Procedures

ProcedureLocationProcedure TypeDescription
advect1dRank1mod_domainFunction

Computes the advective tendency for the domain instance given the desired advection method as an input function and the number of halo cells. This function works only in cases where ndirs == 1.

advect1dRank2mod_domainFunction

Computes the advective tendency for the domain instance given the desired advection method as an input function and the number of halo cells. This function works both when ndirs == 1 (omnidirectional) and when ndirs > 1 (directional).

advect2dRank2mod_domainFunction

Computes the advective tendency for the domain instance given the desired advection method as an input function and the number of halo cells. This function works both when ndirs == 1 (omnidirectional) and when ndirs > 1 (directional).

advectCentered2ndOrdermod_advectionInterface
advectCentered2ndOrder1dRank0mod_advectionFunction

Computes the advective tendency of an input field f given the advective velocity field u [m/s] and grid spacing dx [m], using a second order centered differencing. Fields f and u are defined on a semi-staggered Arakawa C-grid:

advectCentered2ndOrder1dRank1mod_advectionFunction

Computes the advective tendency of an input field f given the advective velocity field u [m/s] and grid spacing dx [m], using a second order centered differencing. Fields f and u are defined on a semi-staggered Arakawa C-grid:

advectCentered2ndOrder1dRank2mod_advectionFunction

Computes the advective tendency of an input field f given the advective velocity field u [m/s] and grid spacing dx [m], using a second order centered differencing. Fields f and u are defined on a semi-staggered Arakawa C-grid:

advectCentered2ndOrder2dRank0mod_advectionFunction

Computes the 2-d advective tendency of an input field f given the advective velocity field u and v [m/s] and grid spacing dx and dy [m], using a second order centered differencing. Fields f, u, and v are defined on a semi-staggered Arakawa C-grid:

advectCentered2ndOrder2dRank1mod_advectionFunction

Computes the 2-d advective tendency of an input field f given the advective velocity field u and v [m/s] and grid spacing dx and dy [m], using a second order centered differencing. Fields f, u, and v are defined on a semi-staggered Arakawa C-grid:

advectCentered2ndOrder2dRank2mod_advectionFunction

Computes the 2-d advective tendency of an input field f given the advective velocity field u and v [m/s] and grid spacing dx and dy [m], using a second order centered differencing. Fields f, u, and v are defined on a semi-staggered Arakawa C-grid:

advectUpwind1stOrdermod_advectionInterface
advectUpwind1stOrder1dRank0mod_advectionFunction

Computes the advective tendency of an input field f given the advective velocity field u [m/s] and grid spacing dx [m], using a first order, positive-definite upwind differencing. Fields f and u are defined on a semi-staggered Arakawa C-grid:

advectUpwind1stOrder1dRank1mod_advectionFunction

Computes the advective tendency of an input field f given the advective velocity field u [m/s] and grid spacing dx [m], using a first order, positive-definite upwind differencing. Fields f and u are defined on a semi-staggered Arakawa C-grid:

advectUpwind1stOrder1dRank2mod_advectionFunction

Computes the advective tendency of an input field f given the advective velocity field u [m/s] and grid spacing dx [m], using a first order, positive-definite upwind differencing. Fields f and u are defined on a semi-staggered Arakawa C-grid:

advectUpwind1stOrder2dRank0mod_advectionFunction

Computes the 2-d advective tendency of an input field f given the advective velocity field u and v [m/s] and grid spacing dx and dy [m], using a first order, positive-definite upwind differencing. Fields f, u, and v are defined on a semi-staggered Arakawa C-grid:

advectUpwind1stOrder2dRank1mod_advectionFunction

Computes the 2-d advective tendency of an input field f given the advective velocity field u and v [m/s] and grid spacing dx and dy [m], using a first order, positive-definite upwind differencing. Fields f, u, and v are defined on a semi-staggered Arakawa C-grid:

advectUpwind1stOrder2dRank2mod_advectionFunction

Computes the 2-d advective tendency of an input field f given the advective velocity field u and v [m/s] and grid spacing dx and dy [m], using a first order, positive-definite upwind differencing. Fields f, u, and v are defined on a semi-staggered Arakawa C-grid:

assign_array_1dmod_spectrumSubroutine

Assigns a 1-d array of reals to a spectrum instance. This procedure overloads the assignment ('=') operator.

assign_array_2dmod_spectrumSubroutine

Assigns a 2-d array of reals to a spectrum instance. This procedure overloads the assignment ('=') operator.

assign_spectrum_array_1dmod_domainSubroutine

Assigns a 1-d array of spectrum instances to a domain instance. This procedure overloads the assignment ('=') operator.

assign_spectrum_array_2dmod_domainSubroutine

Assigns a 2-d array of spectrum instances to a domain instance. This procedure overloads the assignment ('=') operator.

backward_eulermod_time_integrationInterface
backward_euler_domainmod_time_integrationFunction

Integrates a domain instance forward in time using a 1st order implicit backward Euler integration scheme.

backward_euler_spectrummod_time_integrationFunction

Integrates a spectrum forward in time using a 1st order implicit backward Euler integration scheme.

constructormod_domainFunction

Constructor function for the domain object.

constructormod_spectrumFunction

Constructor function for the spectrum object.

constructor_1dmod_gridFunction
constructor_2dmod_gridFunction
diffmod_utilityInterface
diff_1dmod_utilityFunction

Returns a centered-difference of a 1-d array, with first order differencing applied for the boundary points. This procedure is overloaded by the generic procedure diff.

diff_2dmod_utilityFunction

Returns a centered-difference of a 2-d array along dimension dim, with first order differencing applied for the boundary points. This procedure is overloaded by the generic procedure diff.

diff_periodicmod_utilityInterface
diff_periodic_1dmod_utilityFunction

Returns a centered-difference of a 1-d array with periodic boundary conditions. This procedure is overloaded by the generic procedure diff.

diff_periodic_2dmod_utilityFunction

Returns a centered-difference of a 2-d array along dimension dim, with periodic boundary conditions. This procedure is overloaded by the generic procedure diff.

domain_add_domainmod_domainFunction

Returns a sum of two domain instances.

domain_add_realmod_domainFunction

Returns a sum of a domain instance and a real number.

domain_div_domainmod_domainFunction

Returns a division of two domain instances.

domain_div_realmod_domainFunction

Returns a division of a domain instance and a real number.

domain_mult_domainmod_domainFunction

Returns a product of two domain instances.

domain_mult_realmod_domainFunction

Returns a product of a domain instance and a real number.

domain_sub_domainmod_domainFunction

Returns a difference between two domain instances.

domain_sub_realmod_domainFunction

Returns a difference between a domain instance and a real number.

domain_typemod_domainInterface
domain_unary_minusmod_domainFunction

Returns a negative domain instances.

donelanHamiltonHuimod_spectral_shapesFunction

The omnidirectional spectrum function based on the laboratory and field measurements by Donelan, Hamilton, and Hui (1985).

donelanHamiltonHuiDirectionalSpectrummod_spectral_shapesFunction

Returns directional frequency spectrum based on the laboratory and field measurements by Donelan, Hamilton, and Hui (1985). Includes the high frequency form for beta_s found by Banner (1990). This function invokes the DHH omnidirectional spectrum and the directional spreading functions to compute directional frequency spectrum:

donelanHamiltonHuiDirectionalSpreadingmod_spectral_shapesFunction

Directional spreading function based on the laboratory and field measurements by Donelan, Hamilton, and Hui (1985). Includes the high-frequency form for beta_s found by Banner (1990).

elevationmod_linear_wave_theoryFunction

Returns the elevation [m] of a sinusoid wave given its amplitude [m], wavenumber [rad/m], and frequency [Hz].

eqmod_domainFunction

Logical equality comparison function. Overloads the /= operator.

eqmod_spectrumFunction

Logical equality comparison function. Overloads the == operator.

exact_exponentialmod_time_integrationInterface
exact_exponential_domainmod_time_integrationFunction

Integrates a domain instance forward in time using the exact exponential.

exact_exponential_spectrummod_time_integrationFunction

Integrates a spectrum instance forward in time using the exact exponential.

forward_eulermod_time_integrationInterface
forward_euler_domainmod_time_integrationFunction

Integrates a domain instance forward in time using a 1st order Euler integration scheme.

forward_euler_spectrummod_time_integrationFunction

Integrates a spectrum forward in time using a 1st order Euler integration scheme.

frequencyMomentmod_domainFunction

Returns the spectral frequency moment of order n.

frequencyMomentmod_spectrumFunction

Returns the spectral frequency moment of order n.

gemod_spectrumFunction

Logical greater than or equal comparison function. Overloads the >= operator.

getAirDensitymod_domainFunction

Returns the air density [kg/m^3].

getAirDensitymod_spectrumFunction

Returns the air_density [kg/m^3] of the spectrum instance.

getAmplitudemod_spectrumFunction

Returns the amplitude array.

getAxisXmod_gridFunction

Returns the x-coordinate of the grid instance.

getAxisYmod_gridFunction

Returns the y-coordinate [m] of the grid instance.

getCurrent_umod_domainFunction

Returns the 3-d array with values of Eulerian velocity (mean current) in x-direction [m/s].

getCurrent_umod_spectrumFunction

Returns the current velocity in x-direction.

getCurrent_vmod_domainFunction

Returns the 3-d array with values of Eulerian velocity (mean current) in y-direction [m/s].

getCurrent_vmod_spectrumFunction

Returns the current velocity in y-direction.

getDepthmod_domainFunction

Returns the mean water depth [m] array.

getDepthmod_spectrumFunction

Returns the mean water depth [m].

getDepthLevelsmod_spectrumFunction

Returns the depth levels at which the current arrays are defined.

getDirectionsmod_domainFunction

Returns the spectral direction bins [rad].

getDirectionsmod_spectrumFunction

Returns the directions [rad] array of the spectrum instance.

getDirections2dmod_spectrumFunction

Returns the directions [rad] array of the spectrum instance, reshaped to match the spectrum array shape. This method is most useful for conforming shape array in 2-d spectrum computations.

getElevationmod_domainFunction

Returns the mean water elevation [m] array.

getElevationmod_spectrumFunction

Returns the mean surface elevation anomaly [m].

getFrequencymod_domainFunction

Returns the frequency [Hz] array.

getFrequencymod_spectrumFunction

Returns the frequency [Hz] array of the spectrum instance.

getFrequency2dmod_spectrumFunction

Returns the frequency [Hz] array of the spectrum instance, reshaped to match the spectrum array shape. This method is most useful for conforming shape array in 2-d spectrum computations.

getGravitymod_domainFunction

Returns the gravitational acceleration [m/s^2] array.

getGravitymod_spectrumFunction

Returns the gravitational acceleration [m/s^2].

getGridmod_domainFunction

Returns the grid instance that is the component of the domain.

getGridRotationmod_gridFunction

Returns the grid rotation angle [rad] of the grid instance.

getGridSpacingXmod_gridFunction

Returns the grid spacing in x [m] of the grid instance.

getGridSpacingXWithHalomod_domainFunction

Returns grid spacing array in x-direction including halo cells.

getGridSpacingYmod_gridFunction

Returns the grid spacing in y [m] of the grid instance.

getGridSpacingYWithHalomod_domainFunction

Returns grid spacing array in y-direction including halo cells.

getGroupSpeedmod_domainFunction

Returns a 3-d array with group speed values [m/s].

getGroupSpeedmod_spectrumFunction

Returns the phase speed [m/s] array of the spectrum instance.

getGroupSpeed2dmod_spectrumFunction

Returns the group speed [m/s] array of the spectrum instance.

getLatitudemod_gridFunction

Returns the latitude array [rad] of the grid instance.

getLongitudemod_gridFunction

Returns the longitude array [rad] of the grid instance.

getLowerBoundsmod_gridFunction

Returns the lower bounds of the grid instance.

getLowerBoundsmod_domainFunction

Returns the lower bounds of the domain instance.

getPhaseSpeedmod_domainFunction

Returns a 3-d array with phase speed values [m/s].

getPhaseSpeedmod_spectrumFunction

Returns the phase speed [m/s] array of the spectrum instance.

getPhaseSpeed2dmod_spectrumFunction

Returns the phase speed [m/s] array of the spectrum instance.

getSpectrummod_domainFunction

Returns the array of spectrum instances.

getSpectrummod_spectrumFunction

Returns the spectrum array.

getSpectrumArraymod_domainFunction

Returns a 4-dimensional spectrum array, where the first two dimensions are frequency and directional dimensions and the second two are spatial x and y dimensions.

getSurfaceTensionmod_domainFunction

Returns the surface tension [N/m].

getSurfaceTensionmod_spectrumFunction

Returns the surface tension [N/m].

getUpperBoundsmod_gridFunction

Returns the upper bounds of the grid instance.

getUpperBoundsmod_domainFunction

Returns the upper bounds of the domain instance.

getWaterDensitymod_domainFunction

Returns the water density [kg/m^3].

getWaterDensitymod_spectrumFunction

Returns the water density [kg/m^3].

getWaveActionmod_spectrumFunction

Returns the wave action spectrum, which corresponds to the the wave variance spectrum normalized by the intrinsic frequency.

getWavelengthmod_spectrumFunction

Returns the wavelength [m] array of the spectrum instance.

getWavenumbermod_spectrumFunction

Returns the wavenumber [rad/m] array of the spectrum instance.

getWavenumber2dmod_spectrumFunction

Returns the wavenumber [rad/m] array of the spectrum instance, reshaped to match the spectrum array shape. This method is most useful for conforming shape array in 2-d spectrum computations.

getWavenumberSpacingmod_spectrumFunction

Returns the wavenumber spacing [rad/m] array of the spectrum instance.

gravityClairautmod_gravityFunction

Returns the gravitational acceleration at the Earth's surface as function of latitude, based on Clairaut's formula.

grid_typemod_gridInterface
gtmod_spectrumFunction

Logical greater than comparison function. Overloads the > operator.

horizontalAccelerationmod_linear_wave_theoryFunction

Returns the horizontal acceleration of a water particle under a sinusoid wave, given its amplitude, wavenumber, and frequency.

horizontalVelocitymod_linear_wave_theoryFunction

Returns the horizontal velocity of a water particle under a sinusoid wave, given its amplitude, wavenumber, and frequency.

integratemod_time_integrationInterface
integrate_domainmod_time_integrationFunction

Integrates domain forward in time using a time integration method provided as the argument func.

integrate_spectrummod_time_integrationFunction

Integrates spectrum forward in time using a time integration method provided as the argument func.

isAllocatedmod_domainFunction

Returns the allocation status of the domains sub-components.

isAllocatedmod_spectrumFunction

Returns the allocation status of the spectrum array.

isMonochromaticmod_spectrumFunction

Returns .true. if only one frequency bin is allocated, and .false. otherwise.

isOmnidirectionalmod_spectrumFunction

Returns .true. if only one direction bin is allocated, and .false. otherwise.

jonswapmod_spectral_shapesFunction

Computes the JONSWAP equilibrium spectrum (Hasselmann et al. 1973) based on input wind speed at the height of 10 m and fetch.

jonswapPeakFrequencymod_spectral_shapesFunction

Computes the JONSWAP equilibrium peak frequency [Hz] on the input based on the 10-m wind speed and fetch [km] (Hasselmann et al., 1973).

lemod_spectrumFunction

Logical less than or equal comparison function. Overloads the <= operator.

ltmod_spectrumFunction

Logical less than comparison function. Overloads the < operator.

meanPeriodmod_domainFunction

Returns the mean wave period [s] for the whole domain.

meanPeriodmod_spectrumFunction

Returns the mean wave period [s].

meanPeriodZeroCrossingmod_domainFunction

Returns the zero-crossing mean wave period [s] for the whole domain.

meanPeriodZeroCrossingmod_spectrumFunction

Returns the zero-crossing mean wave period [s]:

meanSquareSlopemod_spectrumFunction

Returns the mean square slope of the spectrum, which is the second moment of the wavenumber spectrum.

meanSquareSlopeDirectionalmod_spectrumFunction

For each directional frequency bin, computes the mean square slope of all all waves longer than that bin, projected to the direction of that bin.

momentum_xmod_spectrumFunction

Returns total wave momentum [kg/m/s] in x-direction.

momentum_ymod_spectrumFunction

Returns total wave momentum [kg/m/s] in y-direction.

momentumFlux_xxmod_spectrumFunction

Returns total advective flux [kg/m^2/s^2] in y-direction of momentum in y-direction.

momentumFlux_xymod_spectrumFunction

Returns total advective flux [kg/m^2/s^2] in x-direction of momentum in y-direction and vice versa (flux in y-direction of momentum in y-direction), because \int{CgxMy} == \int{CgyMx}.

momentumFlux_yymod_spectrumFunction

Returns total advective flux [kg/m^2/s^2] in y-direction of momentum in y-direction.

neqmod_domainFunction

Logical inequality comparison function. Overloads the /= operator.

neqmod_spectrumFunction

Logical inequality comparison function. Overloads the /= operator.

nondimensionalDepthmod_nondimensionalFunction

Returns nondimensional depth based on input wind speed [m/s], mean water depth [m], and gravitational acceleration [m/s^2].

nondimensionalEnergymod_nondimensionalFunction

Returns nondimensional energy based on input wind speed, RMS of wave variance, and gravitational acceleration.

nondimensionalFetchmod_nondimensionalFunction

Returns nondimensional energy based on input wind speed, RMS of wave variance, and gravitational acceleration.

nondimensionalFrequencymod_nondimensionalFunction

Returns nondimensional frequency based on input wind speed, peak frequency, and gravitational acceleration.

nondimensionalRoughness_H1986mod_nondimensionalFunction

Returns the aerodynamic roughness length scaled by significant wave height, after Huang (1986).

nondimensionalRoughness_S1974mod_nondimensionalFunction

Returns the aerodynamic roughness length scaled by friction velocity squared and gravitational acceleration, after Stewart (1974).

nondimensionalTimemod_nondimensionalFunction

Returns nondimensional time (duration) based on input wind speed, duration, and gravitational acceleration.

omnidirectionalSpectrummod_spectrumFunction

Returns the omnidirectional spectrum that corresponds to the input directional spectrum, integrated over all directions.

onesmod_utilityInterface
ones_intmod_utilityFunction

Returns a 1-d array of integer ones. This procedure is overloaded by the generic procedure ones.

ones_realmod_utilityFunction

Returns a 1-d array of floating-point ones. This procedure is overloaded by the generic procedure ones.

peakednessmod_spectrumFunction

Returns the peakedness parameter that quantifies the sharpness of the spectral peak, following Goda (1970).

peakFrequencymod_spectrumFunction

Returns the peak frequency based on Young (1995).

peakFrequencyDiscretemod_spectrumFunction

Returns the peak frequency based on simple discrete maximum location of the spectrum array.

phillipsmod_spectral_shapesFunction

Computes the Phillips (1958) equilibrium spectrum based on the input peak frequency [Hz].

piersonMoskowitzmod_spectral_shapesFunction

Computes the Pierson-Moskowitz (1964) equilibrium spectrum based on input wind speed at the height of 10 m.

piersonMoskowitzPeakFrequencymod_spectral_shapesFunction

Computes the Pierson-Moskowitz (1964) peak frequency based on input wind speed at the height of 10 m.

pressuremod_linear_wave_theoryFunction

Returns the pressure [Pa] at depth z (negative downward) for a sinusoid wave given its amplitude [m], wavenumber [rad/m], and frequency [Hz].

rangemod_utilityInterface
range_intmod_utilityFunction

Returns an array of integers given start, end, and increment values. If the increment argument is not passed, default increment is 1. This procedure is overloaded by the generic procedure range.

range_realmod_utilityFunction

Returns an array of reals given start, end, and increment values. If the increment argument is not passed, default increment is 1. This procedure is overloaded by the generic procedure range.

readJSONmod_spectrumSubroutine

Read a spectrum instance from a JSON file.

real2d_mult_spectrummod_spectrumFunction

Returns a product of a real number and a spectrum instance.

real_add_domainmod_domainFunction

Returns a sum of a real number and a domain instance.

real_add_spectrummod_spectrumFunction

Returns a sum of a real number and a spectrum instance.

real_div_domainmod_domainFunction

Returns a product of a real number and a domain instance.

real_div_spectrummod_spectrumFunction

Returns a division of a real number and a spectrum instance.

real_mult_domainmod_domainFunction

Returns a product of a real number and a domain instance.

real_mult_spectrummod_spectrumFunction

Returns a product of a real number and a spectrum instance.

real_sub_domainmod_domainFunction

Returns a difference between a real number and a domain instance.

real_sub_spectrummod_spectrumFunction

Returns a difference between a real number and a spectrum instance.

saturationSpectrummod_spectrumFunction

Returns the saturation spectrum B(k) = F(k)k^4.

sbf_DCCM2012mod_source_functionsFunction

Returns a spectrum instance with the wave dissipation tendency due to bottom friction and percolation, formulated by Donelan et al. (2012).

sbf_JONSWAPmod_source_functionsFunction

Returns a spectrum instance with the bottom friction ($S_{bot}$) tendency based on JONSWAP field data (Hasselmann et al., 1973). It is also the default parameterization scheme used in the WAM model (WAMDIG, 1988).

sds_DCCM2012mod_source_functionsFunction

Returns a spectrum instance with the wave dissipation ($S_{ds}$) tendency formulated by Donelan et al. (2012).

sdt_DCCM2012mod_source_functionsFunction

Returns a spectrum instance with the wave dissipation due to turbulence ($S_{dt}$) tendency formulated by Donelan et al. (2012).

setAirDensitymod_domainSubroutine

Sets the air density [kg/m^3].

setAirDensitymod_spectrumSubroutine

Sets the air density [kg/m^3].

setCurrent1dmod_spectrumSubroutine

Sets the 1-d current velocity field. This procedure is overloaded by the generic procedure setCurrent.

setCurrent2dmod_spectrumSubroutine

Sets the 2-d current velocity field. This procedure is overloaded by the generic procedure setCurrent.

setDepthmod_domainSubroutine

Sets the mean water depth [m].

setDepthmod_spectrumSubroutine

Sets the mean surface elevation value.

setElevationmod_domainSubroutine

Sets the mean water elevation [m].

setElevationmod_spectrumSubroutine

Sets the mean surface elevation value.

setGravitymod_domainSubroutine

Sets the gravitational acceleration [m/s^2].

setGravitymod_spectrumSubroutine

Sets the gravitational acceleration [m/s^2].

setSpectrum1dmod_domainSubroutine

Sets the 1-d spectrum array. This procedure is overloaded by the generic procedure setSpectrum.

setSpectrum1dmod_spectrumSubroutine

Sets the 2-d spectrum array. This procedure is overloaded by the generic procedure setSpectrum.

setSpectrum2dmod_domainSubroutine

Sets the 2-d spectrum array. This procedure is overloaded by the generic procedure setSpectrum.

setSpectrum2dmod_spectrumSubroutine

Sets the 2-d spectrum array. This procedure is overloaded by the generic procedure setSpectrum.

setSpectrumArray1d1dmod_domainSubroutine

Sets the spectrum instances based on input spectrum array. This implementation is for omnidirectional spectrum in 1-d space (1d-1d)

setSpectrumArray1d2dmod_domainSubroutine

Sets the spectrum instances based on input spectrum array. This implementation is for setting 1-d spectrum into 2-d physical space of 2-d spectrum into 1-d physical space.

setSpectrumArray2d2dmod_domainSubroutine

Sets the spectrum instances based on input spectrum array. This implementation is for directional spectrum in 2-d space (2d-2d)

setSurfaceTensionmod_domainSubroutine

Sets the surface tension [N/m^2].

setSurfaceTensionmod_spectrumSubroutine

Sets the surface tension [N/m].

setWaterDensitymod_domainSubroutine

Sets the water density [kg/m^3].

setWaterDensitymod_spectrumSubroutine

Sets the water density [kg/m^3].

significantSurfaceOrbitalVelocitymod_spectrumFunction

Returns the significant surface orbital velocity [m/s].

significantWaveHeightmod_domainFunction

Returns the significant wave height [m] for the whole domain.

significantWaveHeightmod_spectrumFunction

Returns the significant wave height [m].

sin_DCCM2012mod_source_functionsFunction

TODO implement currents averaged over the effective depth layer for modulation of phase speed.

snl_DCCM2012mod_source_functionsFunction

Returns a spectrum instance with the non-linear wave-wave energy transfer ($S_{nl}$) tendency formulated by Donelan et al. (2012).

spectrum_add_realmod_spectrumFunction

Returns a sum of a spectrum instance and a real number.

spectrum_add_spectrummod_spectrumFunction

Returns a spectrum instance with the spectrum array values being the sum of the two input spectrum instances.

spectrum_div_realmod_spectrumFunction

Returns a division of a spectrum instance and a real number.

spectrum_div_spectrummod_spectrumFunction

Returns a division of two spectrum instances.

spectrum_mult_realmod_spectrumFunction

Returns a product of a spectrum instance and a real number.

spectrum_mult_real2dmod_spectrumFunction

Returns a product of a spectrum instance and a real number.

spectrum_mult_spectrummod_spectrumFunction

Returns a product of two spectrum instances.

spectrum_sub_realmod_spectrumFunction

Returns a difference of a spectrum instance and a real number.

spectrum_sub_spectrummod_spectrumFunction

Subtracts one spectrum instance from another and returns the resulting spectrum instance.

spectrum_typemod_spectrumInterface
spectrum_unary_minusmod_spectrumFunction

Returns a negative value of the spectrum instance.

stokesDriftmod_spectrumFunction

Exact solution of Stokes drift based on linear wave theory, given input omnidirectional spectrum and distance from surface z [m], negative downward.

stokesDrift2dmod_spectrumFunction

Exact solution of Stokes drift based on linear wave theory, given input directional spectrum and distance from surface z [m], negative downward.

tilemod_utilityInterface
tile_1d_intmod_utilityFunction

Tiles the input array n times. Returns a tiled array that has rank equal to size(shape(array))+1 and that has values equal to values of array, repeated n times. This version is for 1-d input array of integers. This procedure is overloaded by the generic procedure tile.

tile_1d_realmod_utilityFunction

Tiles the input array n times. Returns a tiled array that has rank equal to size(shape(array))+1 and that has values equal to values of array, repeated n times. This version is for 1-d input array of reals. This procedure is overloaded by the generic procedure tile.

tile_2d_intmod_utilityFunction

Tiles the input array n times. Returns a tiled array that has rank equal to size(shape(array))+1 and that has values equal to values of array, repeated n times. This version is for 2-d input array of integers. This procedure is overloaded by the generic procedure tile.

tile_2d_realmod_utilityFunction

Tiles the input array n times. Returns a tiled array that has rank equal to size(shape(array))+1 and that has values equal to values of array, repeated n times. This version is for 2-d input array of reals. This procedure is overloaded by the generic procedure tile.

tile_3d_intmod_utilityFunction

Tiles the input array n times. Returns a tiled array that has rank equal to size(shape(array))+1 and that has values equal to values of array, repeated n times. This version is for 3-d input array of integers. This procedure is overloaded by the generic procedure tile.

tile_3d_realmod_utilityFunction

Tiles the input array n times. Returns a tiled array that has rank equal to size(shape(array))+1 and that has values equal to values of array, repeated n times. This version is for 3-d input array of reals. This procedure is overloaded by the generic procedure tile.

ursellNumbermod_spectrumFunction

Returns the Ursell number.

verticalAccelerationmod_linear_wave_theoryFunction

Returns the vertical acceleration of a water particle under a sinusoid wave, given its amplitude, wavenumber, and frequency.

verticalVelocitymod_linear_wave_theoryFunction

Returns the vertical velocity of a water particle under a sinusoid wave, given its amplitude, wavenumber, and frequency.

waveAgemod_nondimensionalFunction

Returns wave age, the ratio of phase speed and friction velocity or wind speed, depending on the caller's definition of wave age.

wavenumbermod_spectrumFunction

Solves the linear water wave dispersion relationship using a Newton-Raphson iteration loop.

wavenumberMomentmod_domainFunction

Returns the spectral frequency moment of order n.

wavenumberMomentmod_spectrumFunction

Returns the spectral wavenumber moment of order n.

wavenumberSpectrummod_spectrumFunction

Returns the wavenumber spectrum array of the spectrum instance.

writeJSONmod_domainSubroutine

Writes a spectrum instance to a JSON file.

writeJSONmod_spectrumSubroutine

Writes a spectrum instance to a JSON file.

zerosmod_utilityInterface
zeros_intmod_utilityFunction

Returns a 1-d array of integer zeros. This procedure is overloaded by the generic procedure zeros.

zeros_realmod_utilityFunction

Returns a 1-d array of floating-point zeros. This procedure is overloaded by the generic procedure zeros.

call~~graph~~CallGraph proc~spectrum_sub_spectrum spectrum_sub_spectrum proc~getspectrum~2 getSpectrum proc~spectrum_sub_spectrum->proc~getspectrum~2 proc~real_add_spectrum real_add_spectrum proc~real_add_spectrum->proc~getspectrum~2 proc~real_sub_spectrum real_sub_spectrum proc~real_sub_spectrum->proc~getspectrum~2 proc~getfrequency getFrequency proc~getfrequency->proc~getfrequency spectrum spectrum proc~getfrequency->spectrum proc~spectrum_mult_real spectrum_mult_real proc~spectrum_mult_real->proc~getspectrum~2 proc~real_sub_domain real_sub_domain proc~getspectrum getSpectrum proc~real_sub_domain->proc~getspectrum proc~getgroupspeed2d getGroupSpeed2d proc~setspectrumarray1d1d setSpectrumArray1d1d proc~setspectrumarray1d1d->spectrum lb lb proc~setspectrumarray1d1d->lb setspectrum setspectrum proc~setspectrumarray1d1d->setspectrum ub ub proc~setspectrumarray1d1d->ub proc~le le proc~le->proc~getspectrum~2 proc~horizontalvelocity horizontalVelocity proc~real_mult_domain real_mult_domain proc~real_mult_domain->proc~getspectrum proc~real_div_domain real_div_domain proc~real_div_domain->proc~getspectrum proc~peakedness peakedness proc~frequencymoment~2 frequencyMoment proc~peakedness->proc~frequencymoment~2 proc~omnidirectionalspectrum omnidirectionalSpectrum proc~peakedness->proc~omnidirectionalspectrum proc~real2d_mult_spectrum real2d_mult_spectrum proc~real2d_mult_spectrum->proc~getspectrum~2 proc~donelanhamiltonhui donelanHamiltonHui nondimensionalfrequency nondimensionalfrequency proc~donelanhamiltonhui->nondimensionalfrequency proc~spectrum_sub_real spectrum_sub_real proc~spectrum_sub_real->proc~getspectrum~2 proc~meanperiod~2 meanPeriod proc~meanperiod~2->proc~frequencymoment~2 proc~significantwaveheight~2 significantWaveHeight proc~significantwaveheight~2->proc~frequencymoment~2 interface~ones ones proc~ones_real ones_real interface~ones->proc~ones_real proc~ones_int ones_int interface~ones->proc~ones_int proc~wavenumbermoment wavenumberMoment proc~wavenumbermoment->proc~wavenumbermoment proc~tile_2d_int tile_2d_int proc~wavenumberspectrum wavenumberSpectrum cg cg proc~wavenumberspectrum->cg proc~frequencymoment~2->proc~omnidirectionalspectrum proc~peakfrequency peakFrequency proc~peakfrequency->proc~omnidirectionalspectrum proc~zeros_int zeros_int proc~getdepth~2 getDepth proc~tile_2d_real tile_2d_real proc~real_mult_spectrum real_mult_spectrum proc~real_mult_spectrum->proc~getspectrum~2 proc~getcurrent_u getCurrent_u proc~getcurrent_u->proc~getcurrent_u proc~getcurrent_u->spectrum proc~getcurrent_u->lb proc~getcurrent_u->ub proc~spectrum_mult_spectrum spectrum_mult_spectrum proc~spectrum_mult_spectrum->proc~getspectrum~2 proc~forward_euler_spectrum forward_euler_spectrum proc~horizontalacceleration horizontalAcceleration proc~meansquareslope meanSquareSlope proc~wavenumbermoment~2 wavenumberMoment proc~meansquareslope->proc~wavenumbermoment~2 proc~neq~2 neq proc~assign_array_1d assign_array_1d proc~assign_array_1d->setspectrum proc~getgridrotation getGridRotation proc~tile_3d_int tile_3d_int proc~saturationspectrum saturationSpectrum proc~saturationspectrum->proc~wavenumberspectrum proc~advectupwind1storder2drank0 advectUpwind1stOrder2dRank0 proc~meanperiodzerocrossing~2 meanPeriodZeroCrossing proc~meanperiodzerocrossing~2->proc~frequencymoment~2 interface~tile tile interface~tile->proc~tile_2d_int interface~tile->proc~tile_2d_real interface~tile->proc~tile_3d_int proc~tile_1d_int tile_1d_int interface~tile->proc~tile_1d_int proc~tile_3d_real tile_3d_real interface~tile->proc~tile_3d_real proc~tile_1d_real tile_1d_real interface~tile->proc~tile_1d_real proc~getwavenumberspacing getWavenumberSpacing proc~meansquareslopedirectional meanSquareSlopeDirectional proc~meansquareslopedirectional->proc~wavenumberspectrum k k proc~meansquareslopedirectional->k dk dk proc~meansquareslopedirectional->dk th th proc~meansquareslopedirectional->th proc~assign_spectrum_array_1d assign_spectrum_array_1d proc~assign_spectrum_array_1d->setspectrum proc~getcurrent_v getCurrent_v proc~getcurrent_v->proc~getcurrent_v proc~getcurrent_v->spectrum proc~getcurrent_v->lb proc~getcurrent_v->ub interface~forward_euler forward_euler interface~forward_euler->proc~forward_euler_spectrum proc~forward_euler_domain forward_euler_domain interface~forward_euler->proc~forward_euler_domain proc~readjson readJSON interface~diff_periodic diff_periodic proc~readjson->interface~diff_periodic interface~diff diff proc~readjson->interface~diff initialize initialize proc~readjson->initialize destroy destroy proc~readjson->destroy load_file load_file proc~readjson->load_file get get proc~readjson->get proc~assign_array_2d assign_array_2d proc~assign_array_2d->setspectrum proc~advect2drank2 advect2dRank2 proc~getdirections getDirections proc~advect2drank2->proc~getdirections proc~getspectrumarray getSpectrumArray proc~advect2drank2->proc~getspectrumarray proc~getgridspacingxwithhalo getGridSpacingXWithHalo proc~advect2drank2->proc~getgridspacingxwithhalo proc~getgridspacingywithhalo getGridSpacingYWithHalo proc~advect2drank2->proc~getgridspacingywithhalo proc~getgroupspeed getGroupSpeed proc~advect2drank2->proc~getgroupspeed proc~advect2drank2->lb proc~advect2drank2->ub setspectrumarray setspectrumarray proc~advect2drank2->setspectrumarray hw hw proc~advect2drank2->hw proc~getwaveaction getWaveAction proc~getfrequency2d getFrequency2d proc~getwaveaction->proc~getfrequency2d proc~sds_dccm2012 sds_DCCM2012 getfrequency2d getfrequency2d proc~sds_dccm2012->getfrequency2d saturationspectrum saturationspectrum proc~sds_dccm2012->saturationspectrum meansquareslopedirectional meansquareslopedirectional proc~sds_dccm2012->meansquareslopedirectional proc~verticalacceleration verticalAcceleration proc~lt lt proc~lt->proc~getspectrum~2 proc~snl_dccm2012 snl_DCCM2012 getfrequency getfrequency proc~snl_dccm2012->getfrequency getspectrum getspectrum proc~snl_dccm2012->getspectrum getwavenumber getwavenumber proc~snl_dccm2012->getwavenumber getwavenumberspacing getwavenumberspacing proc~snl_dccm2012->getwavenumberspacing getdirections getdirections proc~snl_dccm2012->getdirections float float proc~snl_dccm2012->float proc~sdt_dccm2012 sdt_DCCM2012 getairdensity getairdensity proc~sdt_dccm2012->getairdensity getwavenumber2d getwavenumber2d proc~sdt_dccm2012->getwavenumber2d getwaterdensity getwaterdensity proc~sdt_dccm2012->getwaterdensity proc~getgravity~2 getGravity proc~setgravity~2 setGravity proc~getdepth getDepth proc~getdepth->proc~getdepth proc~momentum_x momentum_x df df proc~momentum_x->df spec spec proc~momentum_x->spec cp cp proc~momentum_x->cp proc~wavenumber wavenumber proc~range_int range_int proc~exact_exponential_domain exact_exponential_domain interface~exact_exponential exact_exponential proc~exact_exponential_domain->interface~exact_exponential proc~exact_exponential_domain->getspectrum proc~getelevation getElevation proc~getelevation->proc~getelevation proc~constructor_2d constructor_2d proc~constructor_2d->interface~diff interface~grid_type grid_type interface~grid_type->proc~constructor_2d proc~constructor_1d constructor_1d interface~grid_type->proc~constructor_1d proc~domain_mult_domain domain_mult_domain proc~domain_mult_domain->proc~getspectrum proc~verticalvelocity verticalVelocity proc~advectupwind1storder2drank1 advectUpwind1stOrder2dRank1 proc~spectrum_unary_minus spectrum_unary_minus proc~spectrum_unary_minus->proc~getspectrum~2 proc~getwavenumber getWavenumber proc~getdirections2d getDirections2d proc~constructor_1d->interface~diff y y proc~constructor_1d->y lon lon proc~constructor_1d->lon lat lat proc~constructor_1d->lat dy dy proc~constructor_1d->dy proc~diff_2d diff_2d proc~getdirections->proc~getdirections proc~getdirections->spectrum proc~setspectrum2d~2 setSpectrum2d proc~sbf_dccm2012 sbf_DCCM2012 proc~sbf_dccm2012->getwavenumber2d getdepth getdepth proc~sbf_dccm2012->getdepth proc~setspectrumarray1d2d setSpectrumArray1d2d proc~setspectrumarray1d2d->spectrum proc~setspectrumarray1d2d->lb proc~setspectrumarray1d2d->setspectrum proc~setspectrumarray1d2d->ub proc~getgravity getGravity proc~getgravity->proc~getgravity interface~zeros zeros interface~zeros->proc~zeros_int proc~zeros_real zeros_real interface~zeros->proc~zeros_real proc~sin_dccm2012 sin_DCCM2012 proc~sin_dccm2012->getfrequency proc~sin_dccm2012->getwavenumber proc~sin_dccm2012->getdirections proc~sin_dccm2012->getairdensity proc~sin_dccm2012->getwaterdensity windatreferenceheight windatreferenceheight proc~sin_dccm2012->windatreferenceheight getphasespeed getphasespeed proc~sin_dccm2012->getphasespeed getgravity getgravity proc~sin_dccm2012->getgravity getwavelength getwavelength proc~sin_dccm2012->getwavelength proc~gt gt proc~gt->proc~getspectrum~2 proc~piersonmoskowitzpeakfrequency piersonMoskowitzPeakFrequency proc~getgrid getGrid proc~getairdensity~2 getAirDensity proc~setcurrent1d setCurrent1d v v proc~setcurrent1d->v proc~backward_euler_domain backward_euler_domain interface~backward_euler backward_euler proc~backward_euler_domain->interface~backward_euler proc~backward_euler_domain->setspectrum proc~backward_euler_domain->getspectrum proc~advectcentered2ndorder2drank2 advectCentered2ndOrder2dRank2 proc~wavenumbermoment~2->proc~wavenumberspectrum proc~setcurrent2d setCurrent2d proc~isallocated isAllocated proc~spectrum_div_spectrum spectrum_div_spectrum proc~spectrum_div_spectrum->proc~getspectrum~2 proc~momentumflux_xy momentumFlux_xy proc~momentumflux_xy->cg proc~momentumflux_xy->df proc~momentumflux_xy->spec proc~momentumflux_xy->cp proc~sbf_jonswap sbf_JONSWAP proc~sbf_jonswap->getdepth proc~sbf_jonswap->getgravity getphasespeed2d getphasespeed2d proc~sbf_jonswap->getphasespeed2d getgroupspeed2d getgroupspeed2d proc~sbf_jonswap->getgroupspeed2d proc~jonswap jonswap proc~jonswappeakfrequency jonswapPeakFrequency proc~jonswap->proc~jonswappeakfrequency nondimensionalfetch nondimensionalfetch proc~jonswap->nondimensionalfetch proc~assign_spectrum_array_2d assign_spectrum_array_2d proc~assign_spectrum_array_2d->setspectrum proc~getsurfacetension~2 getSurfaceTension proc~spectrum_add_real spectrum_add_real proc~spectrum_add_real->proc~getspectrum~2 proc~getspectrumarray->proc~getspectrum proc~getspectrumarray->spectrum proc~getspectrumarray->lb proc~getspectrumarray->ub proc~getspectrumarray->hw proc~nondimensionaltime nondimensionalTime proc~getphasespeed~2 getPhaseSpeed proc~advectupwind1storder2drank2 advectUpwind1stOrder2dRank2 proc~elevation elevation interface~spectrum_type spectrum_type proc~constructor~2 constructor interface~spectrum_type->proc~constructor~2 proc~getupperbounds~2 getUpperBounds proc~getwavelength getWavelength proc~getwaterdensity~2 getWaterDensity proc~eq eq proc~eq->proc~getspectrum proc~domain_mult_real domain_mult_real proc~domain_mult_real->proc~getspectrum proc~writejson~2 writeJSON proc~writejson~2->proc~getdepth~2 proc~writejson~2->proc~getgravity~2 proc~writejson~2->proc~getwavenumber proc~writejson~2->proc~getairdensity~2 proc~writejson~2->proc~getsurfacetension~2 proc~writejson~2->proc~getwaterdensity~2 proc~getdirections~2 getDirections proc~writejson~2->proc~getdirections~2 proc~getdepthlevels getDepthLevels proc~writejson~2->proc~getdepthlevels proc~getfrequency~2 getFrequency proc~writejson~2->proc~getfrequency~2 proc~getcurrent_u~2 getCurrent_u proc~writejson~2->proc~getcurrent_u~2 proc~getcurrent_v~2 getCurrent_v proc~writejson~2->proc~getcurrent_v~2 proc~writejson~2->proc~getspectrum~2 proc~getelevation~2 getElevation proc~writejson~2->proc~getelevation~2 proc~writejson~2->initialize proc~writejson~2->destroy add add proc~writejson~2->add create_object create_object proc~writejson~2->create_object interface~range range interface~range->proc~range_int proc~range_real range_real interface~range->proc~range_real proc~setsurfacetension~2 setSurfaceTension proc~setwaterdensity~2 setWaterDensity proc~advectupwind1storder1drank2 advectUpwind1stOrder1dRank2 proc~setdepth~2 setDepth proc~neq neq proc~forward_euler_domain->interface~forward_euler proc~forward_euler_domain->getspectrum proc~spectrum_add_spectrum spectrum_add_spectrum proc~spectrum_add_spectrum->proc~getspectrum~2 proc~diff_periodic_2d diff_periodic_2d proc~getupperbounds getUpperBounds proc~setwaterdensity setWaterDensity proc~setwaterdensity->proc~setwaterdensity proc~waveage waveAge proc~getgroupspeed~2 getGroupSpeed proc~setelevation~2 setElevation proc~getphasespeed getPhaseSpeed proc~getphasespeed->proc~getphasespeed proc~getphasespeed->spectrum proc~getphasespeed->lb proc~getphasespeed->ub proc~stokesdrift stokesDrift proc~stokesdrift->proc~omnidirectionalspectrum proc~ge ge proc~ge->proc~getspectrum~2 proc~setspectrum1d setSpectrum1d proc~setspectrum1d->lb proc~setspectrum1d->ub proc~nondimensionalfetch nondimensionalFetch proc~getaxisx getAxisX proc~donelanhamiltonhuidirectionalspreading donelanHamiltonHuiDirectionalSpreading proc~backward_euler_spectrum backward_euler_spectrum proc~significantwaveheight significantWaveHeight proc~significantwaveheight->proc~significantwaveheight proc~nondimensionalenergy nondimensionalEnergy proc~getaxisy getAxisY proc~nondimensionalroughness_h1986 nondimensionalRoughness_H1986 proc~advectcentered2ndorder2drank1 advectCentered2ndOrder2dRank1 proc~setspectrum2d setSpectrum2d proc~setspectrum2d->lb proc~setspectrum2d->ub proc~real_div_spectrum real_div_spectrum proc~real_div_spectrum->proc~getspectrum~2 proc~setairdensity~2 setAirDensity proc~diff_periodic_1d diff_periodic_1d proc~domain_add_domain domain_add_domain proc~domain_add_domain->proc~getspectrum proc~domain_sub_domain domain_sub_domain proc~domain_sub_domain->proc~getspectrum proc~isallocated~2 isAllocated proc~getgridspacingy getGridSpacingY proc~momentumflux_yy momentumFlux_yy proc~momentumflux_yy->cg proc~momentumflux_yy->df proc~momentumflux_yy->spec proc~momentumflux_yy->cp proc~advectcentered2ndorder1drank0 advectCentered2ndOrder1dRank0 proc~advectcentered2ndorder2drank0 advectCentered2ndOrder2dRank0 proc~ismonochromatic isMonochromatic proc~significantsurfaceorbitalvelocity significantSurfaceOrbitalVelocity proc~gravityclairaut gravityClairaut proc~getamplitude getAmplitude proc~getamplitude->proc~getdirections~2 proc~getamplitude->proc~ismonochromatic proc~getamplitude->spec proc~domain_unary_minus domain_unary_minus proc~domain_unary_minus->proc~getspectrum proc~getsurfacetension getSurfaceTension proc~getsurfacetension->proc~getsurfacetension interface~diff_periodic->proc~diff_periodic_2d interface~diff_periodic->proc~diff_periodic_1d proc~isomnidirectional isOmnidirectional proc~diff_1d diff_1d proc~getgridspacingxwithhalo->lb proc~getgridspacingxwithhalo->ub proc~getgridspacingxwithhalo->hw proc~getgridspacingywithhalo->lb proc~getgridspacingywithhalo->ub proc~getgridspacingywithhalo->hw proc~advectupwind1storder1drank1 advectUpwind1stOrder1dRank1 proc~getlongitude getLongitude proc~advectcentered2ndorder1drank1 advectCentered2ndOrder1dRank1 proc~stokesdrift2d stokesDrift2d proc~stokesdrift2d->proc~getdirections~2 proc~stokesdrift2d->th proc~stokesdrift2d->spec dth dth proc~stokesdrift2d->dth proc~getlatitude getLatitude proc~phillips phillips proc~piersonmoskowitz piersonMoskowitz proc~piersonmoskowitz->proc~piersonmoskowitzpeakfrequency proc~nondimensionalfrequency nondimensionalFrequency proc~domain_div_domain domain_div_domain proc~domain_div_domain->proc~getspectrum proc~getairdensity getAirDensity proc~getairdensity->proc~getairdensity proc~setspectrumarray2d2d setSpectrumArray2d2d proc~setspectrumarray2d2d->spectrum proc~setspectrumarray2d2d->lb proc~setspectrumarray2d2d->setspectrum proc~setspectrumarray2d2d->ub interface~integrate integrate proc~integrate_spectrum integrate_spectrum interface~integrate->proc~integrate_spectrum proc~integrate_domain integrate_domain interface~integrate->proc~integrate_domain interface~advectcentered2ndorder advectCentered2ndOrder interface~advectcentered2ndorder->proc~advectcentered2ndorder2drank2 interface~advectcentered2ndorder->proc~advectcentered2ndorder2drank1 interface~advectcentered2ndorder->proc~advectcentered2ndorder1drank0 interface~advectcentered2ndorder->proc~advectcentered2ndorder2drank0 interface~advectcentered2ndorder->proc~advectcentered2ndorder1drank1 proc~advectcentered2ndorder1drank2 advectCentered2ndOrder1dRank2 interface~advectcentered2ndorder->proc~advectcentered2ndorder1drank2 proc~momentum_y momentum_y proc~momentum_y->df proc~momentum_y->spec proc~momentum_y->cp interface~advectupwind1storder advectUpwind1stOrder interface~advectupwind1storder->proc~advectupwind1storder2drank0 interface~advectupwind1storder->proc~advectupwind1storder2drank1 interface~advectupwind1storder->proc~advectupwind1storder2drank2 interface~advectupwind1storder->proc~advectupwind1storder1drank2 interface~advectupwind1storder->proc~advectupwind1storder1drank1 proc~advectupwind1storder1drank0 advectUpwind1stOrder1dRank0 interface~advectupwind1storder->proc~advectupwind1storder1drank0 proc~frequencymoment frequencyMoment proc~frequencymoment->proc~frequencymoment proc~getlowerbounds getLowerBounds interface~exact_exponential->proc~exact_exponential_domain proc~exact_exponential_spectrum exact_exponential_spectrum interface~exact_exponential->proc~exact_exponential_spectrum interface~domain_type domain_type proc~constructor constructor interface~domain_type->proc~constructor proc~peakfrequencydiscrete peakFrequencyDiscrete proc~peakfrequencydiscrete->proc~omnidirectionalspectrum f f proc~peakfrequencydiscrete->f proc~nondimensionalroughness_s1974 nondimensionalRoughness_S1974 proc~spectrum_div_real spectrum_div_real proc~spectrum_div_real->proc~getspectrum~2 proc~getgridspacingx getGridSpacingX proc~constructor->proc~getfrequency proc~constructor->proc~getdirections proc~constructor->proc~getupperbounds~2 proc~getlowerbounds~2 getLowerBounds proc~constructor->proc~getlowerbounds~2 proc~constructor->lb proc~constructor->ub proc~constructor->v depth depth proc~constructor->depth getgridspacingy getgridspacingy proc~constructor->getgridspacingy u u proc~constructor->u getgridspacingx getgridspacingx proc~constructor->getgridspacingx eta eta proc~constructor->eta proc~meanperiod meanPeriod proc~writejson writeJSON proc~writejson->proc~getfrequency proc~writejson->proc~getdirections proc~writejson->proc~getspectrumarray proc~writejson->proc~getupperbounds~2 proc~writejson->proc~getlowerbounds~2 proc~writejson->initialize proc~writejson->destroy proc~writejson->add proc~writejson->create_object getaxisy getaxisy proc~writejson->getaxisy getaxisx getaxisx proc~writejson->getaxisx proc~domain_sub_real domain_sub_real proc~domain_sub_real->proc~getspectrum proc~setsurfacetension setSurfaceTension proc~setsurfacetension->proc~setsurfacetension proc~domain_add_real domain_add_real proc~domain_add_real->proc~getspectrum proc~getwaterdensity getWaterDensity proc~getwaterdensity->proc~getwaterdensity proc~setspectrum1d~2 setSpectrum1d proc~spectrum_mult_real2d spectrum_mult_real2d proc~spectrum_mult_real2d->proc~getspectrum~2 proc~getgroupspeed->proc~getgroupspeed proc~getgroupspeed->spectrum proc~getgroupspeed->lb proc~getgroupspeed->ub proc~getgroupspeed->hw interface~diff->proc~diff_2d interface~diff->proc~diff_1d proc~momentumflux_xx momentumFlux_xx proc~momentumflux_xx->cg proc~momentumflux_xx->df proc~momentumflux_xx->spec proc~momentumflux_xx->cp proc~setdepth setDepth proc~setdepth->proc~setdepth proc~meanperiodzerocrossing meanPeriodZeroCrossing proc~advect1drank1 advect1dRank1 proc~advect1drank1->proc~getspectrumarray proc~advect1drank1->proc~getgridspacingxwithhalo proc~advect1drank1->proc~getgroupspeed proc~advect1drank1->lb proc~advect1drank1->ub proc~advect1drank1->setspectrumarray interface~backward_euler->proc~backward_euler_domain interface~backward_euler->proc~backward_euler_spectrum proc~domain_div_real domain_div_real proc~domain_div_real->proc~getspectrum proc~constructor~2->proc~wavenumber proc~constructor~2->proc~setcurrent2d proc~constructor~2->interface~diff_periodic proc~constructor~2->interface~diff proc~constructor~2->cg proc~constructor~2->k proc~constructor~2->dk proc~constructor~2->th proc~constructor~2->spec proc~constructor~2->cp proc~constructor~2->dth proc~constructor~2->f proc~nondimensionaldepth nondimensionalDepth proc~ursellnumber ursellNumber proc~ursellnumber->proc~meanperiod~2 proc~ursellnumber->proc~significantwaveheight~2 proc~eq~2 eq proc~eq~2->proc~getspectrum~2 proc~setelevation setElevation proc~setelevation->proc~setelevation proc~advect1drank2 advect1dRank2 proc~advect1drank2->proc~getspectrumarray proc~advect1drank2->proc~getgridspacingxwithhalo proc~advect1drank2->proc~getgroupspeed proc~advect1drank2->lb proc~advect1drank2->ub proc~advect1drank2->setspectrumarray proc~setairdensity setAirDensity proc~setairdensity->proc~setairdensity proc~omnidirectionalspectrum->dth proc~donelanhamiltonhuidirectionalspectrum donelanHamiltonHuiDirectionalSpectrum proc~donelanhamiltonhuidirectionalspectrum->proc~donelanhamiltonhui proc~donelanhamiltonhuidirectionalspectrum->proc~donelanhamiltonhuidirectionalspreading proc~getwavenumber2d getWavenumber2d proc~pressure pressure proc~pressure->proc~elevation proc~setgravity setGravity proc~setgravity->proc~setgravity proc~getphasespeed2d getPhaseSpeed2d proc~real_add_domain real_add_domain proc~real_add_domain->proc~getspectrum proc~exact_exponential_spectrum->setspectrum proc~exact_exponential_spectrum->getspectrum
Help