Wave Module

The wave module contains a set of functions to calculate quantities of interest for wave energy converters (WEC).

Note

The names of the functions below are of the convention path.path.function. Only the function name is used when calling the function in MATLAB. For example, to call on mhkit.wave.io.read_NDBC_file simply use read_NDBC_file.

IO

The io submodule contains the following functions to download and load National Data Buoy Center (NDBC), including real time and historical data, and SWAN model data into structures.

Functions

Description

read_NDBC_file

Reads a NDBC wave buoy data file (from https://www.ndbc.noaa.gov) into a structure.

NDBC_available_data

Returns the NDBC stations IDs, years, and file names for a requested parameter.

NDBC_request_data

Returns requested NDBC data from passed filenames and parameter.

swan_read_block

Reads in SWAN ASCII block format output and returns a data structure.

swan_read_table

Reads in SWAN ASCII table format output and returns a data structure.

cdip_request_parse_workflow

Parses CDIP data from a web request.

region_selection

Returns the name of the predefined region in which the given coordinates reside.

request_wpto

Returns data from the WPTO wave hindcast hosted on AWS at the specified latitude and longitude point(s).

mhkit.wave.IO.CDIP.cdip_request_parse_workflow(options)

CDIP_REQUEST_PARSE_WORKFLOW Parses CDIP data from a web request

Requests data for a station number (from http://cdip.ucsd.edu/) and parses. Years may be non-consecutive e.g. [2001, 2010]. Time may be sliced by dates (start_date or end date in YYYY-MM-DD). By default 2D variables are not parsed if all 2D variables are needed.

Parameters
  • station_number (string) – Station number of CDIP wave buoy

  • parameters (string or array of strings) – Parameters to return. If nan, will return all variables except 2D-variables.

  • years (int or array of int) – Year date, e.g. 2001 or [2001, 2010]

  • start_date (string) – Start date in YYYY-MM-DD, e.g. ‘2012-04-01’

  • end_date (string) – End date in YYYY-MM-DD, e.g. ‘2012-04-30’

  • data_type (string) – Either ‘historic’ or ‘realtime’

  • all_2D_variables (boolean) – Will return all 2D data. Enabling this will add significant processing time. If all 2D variables are not needed it is recommended to pass 2D parameters of interest using the ‘parameters’ keyword and leave this set to the default false.

Returns

data (structure) –

‘data’: structure

grouped 1D and 2D structures of array data with datetimes

’metadata’: structure

Anything not of length time, including buoy name

mhkit.wave.IO.hindcast.region_selection(lat_lon, data_type)

Returns the name of the predefined region in which the given coordinates reside. Can be used to check if the passed lat/lon pair is within the WPTO hindcast dataset.

Parameters
  • lat_lon (matrix) – Latitude (first column) and longitude (second column) coordinates as numerics

  • data_type (string) – Data set type of interest Options: “3-hour” “1-hour”

Returns

region (string) – Name of predefined region for given coordinates

mhkit.wave.IO.hindcast.request_wpto(data_type, parameter, lat_lon, year, api_key)

Returns data from the WPTO wave hindcast hosted on AWS at the specified latitude and longitude point(s), or the closest available pont(s). Visit https://registry.opendata.aws/wpto-pds-us-wave/ for more information about the dataset and available locations and years. NOTE: To access the WPTO hindcast data, you will need to configure h5pyd for data access on HSDS. Please see the WPTO_hindcast_example notebook for more information.

Parameters
  • data_type (string) – Data set type of interest Options: “3-hour” “1-hour”

  • parameter (string or list of strings) –

    Dataset parameter to be downloaded 3-hour dataset options: ‘directionality_coefficient’, ‘energy_period’, ‘maximum_energy_direction’

    ’mean_absolute_period’, ‘mean_zero-crossing_period’, ‘omni-directional_wave_power’, ‘peak_period’ ‘significant_wave_height’, ‘spectral_width’, ‘water_depth’

    1-hour dataset options: ‘directionality_coefficient’, ‘energy_period’, ‘maximum_energy_direction’

    ’mean_absolute_period’, ‘mean_zero-crossing_period’, ‘omni-directional_wave_power’, ‘peak_period’ ‘significant_wave_height’, ‘spectral_width’, ‘water_depth’, ‘maximim_energy_direction’, ‘mean_wave_direction’, ‘frequency_bin_edges’, ‘directional_wave_spectrum’

  • lat_lon (tuple or list of tuples) – Latitude longitude pairs at which to extract data.

  • year (float) – Year to be accessed. The years 1979-2010 available.

  • api_key – API key obtained from https://developer.nrel.gov/signup/

mhkit.wave.IO.NDBC.NDBC_request_data(parameter, filenames)

Requests data by filenames and returns a structure of structures for each filename passed. If filenames for a single buoy are passed then the yearly structures in the returned structure (ndbc_data) are indexed by year (e.g. ndbc_data.year_2004). If multiple buoy ids are passed then the returned dictionary is indexed by buoy id and year (e.g. ndbc_data[‘46022’][‘2014’]).

Parameters
  • parameter (string) – ‘swden’ : ‘Raw Spectral Wave Current Year Historical Data’ ‘stdmet’ : ‘Standard Meteorological Current Year Historical Data’

  • filenames (array of strings) – Data filenames on https://www.ndbc.noaa.gov/data/historical/{parameter}/

  • proxy (None) –

    Parameter is now deprecated. To request data from behind a firewall, configure in MATLAB Preferences by navigating to:

    Home -> Environment -> Preferences

    then:

    MATLAB -> Web -> Use a proxy server to connect to the Internet

    See the following for details:

    https://www.mathworks.com/help/matlab/import_export/proxy.html

Returns

ndbc_data (Structure) – Structure of structures broken down by buoy and years of data.

mhkit.wave.IO.NDBC.read_NDBC_file(file_name, varargin)

Reads a NDBC wave buoy data file (from https://www.ndbc.noaa.gov) into a structure.

Realtime and historical data files can be loaded with this function.

Note: With realtime data, missing data is denoted by “MM”. With historical data, missing data is denoted using a variable number of # 9’s, depending on the data type (for example: 9999.0 999.0 99.0). ‘N/A’ is automatically converted to missing data.

Data values are converted to float/int when possible. Column names are also converted to float/int when possible (this is useful when column names are frequency).

Parameters
  • file_name (string) – Name of NDBC wave buoy data file

  • missing_value (vector of values (optional)) – vector of values that denote missing data

Returns

data (Structure)

data.Data: named according to header row

data.time: given in datetime

data.units: the units for each data entry

OR if a spectra data NDBC file

data.spectra: spectra data

data.time: given in datetime

data.frequency: spectral frequency

mhkit.wave.IO.NDBC.NDBC_available_data(parameter, options)

For a given parameter this will return a structure of years, station IDs and file names that contain that parameter data.

Parameters
  • parameter (string) – ‘swden’ : ‘Raw Spectral Wave Current Year Historical Data’ ‘stdmet’: ‘Standard Meteorological Current Year Historical Data’

  • buoy_number (string (optional)) – Buoy Number. 5-character alpha-numeric station identifier to call: NDBC_available_data(parameter,”buoy_number”,buoy_number)

  • proxy (None) –

    Parameter is now deprecated. To request data from behind a firewall, configure in MATLAB Preferences by navigating to:

    Home -> Environment -> Preferences

    then:

    MATLAB -> Web -> Use a proxy server to connect to the Internet

    See the following for details:

    https://www.mathworks.com/help/matlab/import_export/proxy.html

Returns

available_data (structure) – Structure with station_id, years, and NDBC file names.

mhkit.wave.IO.SWAN.swan_read_block(swan_file)

Reads in SWAN ASCII block format output and returns a data structure containing modeled values and assocuated metadata

Parameters

swan_file (string) – SWAN file name to import

Returns

data (Structure)

mhkit.wave.IO.SWAN.swan_read_table(swan_file)

Reads in SWAN ASCII table format output and returns a Matlab structure with modeled data and assocaited metadata.

Parameters

swan_file (string) – SWAN file name to import

Returns

data (Structure)

Resource

The resource submodule contains methods to compute wave energy spectra and various metrics from the spectra.

The following options exist to compute wave energy spectra:

Functions

Description

jonswap_spectrum

Calculates Jonswap spectrum from wave data.

pierson_moskowitz_spectrum

Calculates Pierson Moskowitz spectrum from wave data.

elevation_spectrum

Calculates wave spectra from wave probe timeseries.

The following metrics can be computed from the spectra:

Functions

Description

average_crest_period

Calculate the average creat period from spectra.

average_wave_period

Calculates the average wave period from spectra

average_zero_crossing_period

Calculates wave average zero crossing period from spectra

depth_regime

Calculates depth regime based on wavelength and height

energy_flux

Calculates the omnidirectional wave energy flux of the spectra

energy_period

Calculates the energy period

environmental_contour

Calculates environmental contours of extreme sea states

frequency_moment

Calculates the Nth frequency moment of the spectrum

peak_period

Calculates wave energy period from spectra

significant_wave_height

Calculates wave height from spectra

spectral_bandwidth

Calculates bandwidth from spectra

spectral_width

Calculates wave spectral width from spectra

surface_elevation

Calculates wave elevation time series from spectrum using a random phase

wave_celerity

Calculates wave celerity (group velocity)

wave_length

Calculates wave length from wave number

wave_number

Calculates wave number

mhkit.wave.resource.energy_flux(S, h, options)
Parameters
  • S (Spectral Density (m^2/Hz)) –

    structure of form:

    S.spectrum: Spectral Density (m^2/Hz)

    S.type: String of the spectra type, i.e. Bretschneider, time series, date stamp etc.

    S.frequency: frequency (Hz)

  • h (double) – Water depth (m)

  • deep (logical (optional)) – If True use the deep water approximation. Default False. When False a depth check is run to check for shallow water. The ratio of the shallow water regime can be changed using the ratio keyword. to call: energy_flux(S,h,”deep”,py.True)

  • rho (double (optional)) – water density (kg/m^3) to call: energy_flux(S,h,”rho”,rho)

  • g (double (optional)) – gravitational acceleration (m/s^2) to call: energy_flux(S,h,”g”,g)

  • ratio (double or int (optional)) – Only applied if depth=False. If h/l > ratio, water depth will be set to deep. Default ratio = 2. to call: energy_flux(S,h,”ratio”,1.5)

Returns

J (double) – Omni-directional wave energy flux (W/m)

mhkit.wave.resource.depth_regime(l, h, options)

Calculates the depth regime based on wavelength and height Deep water: h/l > ratio This function exists so sinh in wave celerity doesn’t blow up to infinity.

P.K. Kundu, I.M. Cohen (2000) suggest h/l >> 1 for deep water (pg 209) Same citation as above, they also suggest for 3% accuracy, h/l > 0.28 (pg 210) However, since this function allows multiple wavelengths, higher ratio numbers are more accurate across varying wavelengths.

Parameters
  • l (vector) – wave length (m)

  • h (double) – Water depth (m)

  • ratio (double or int (optional)) – If h/l > ratio, water depth will be set to deep. Default ratio = 2 to call: energy_flux(k,h,”ratio”,ratio)

Returns

depth_reg (boolean or boolean array) – Boolean True if deep water, False otherwise

mhkit.wave.resource.wave_number(f, h, options)

Calculates wave number

Parameters
  • f (frequency (Hz)) – vector or numpy array

  • h (float) – Water depth (m)

  • rho (float (optional)) – water density (kg/m^3) to call: wave_number(f,h,”rho”,rho)

  • g (float (optional)) – gravitational acceleration (m/s^2) to call: wave_number(f,h,”g”,g)

Returns

k (structure)

k.values: wave number

k.frequency: frequency [Hz]

mhkit.wave.resource.peak_period(S)

Calculates wave energy period from spectra

Parameters

S (Spectral Density (m^2/Hz)) –

Pandas data frame

To make a pandas data frame from user supplied frequency and spectra use py.mhkit_python_utils.pandas_dataframe.spectra_to_pandas(frequency,spectra)

OR

structure of form:

S.spectrum: Spectral Density (m^2/Hz)

S.type: String of the spectra type, i.e. Bretschneider, time series, date stamp etc.

S.frequency: frequency (Hz)

Returns

Tp float – Wave Peak Period (s)

mhkit.wave.resource.elevation_spectrum(ts, sample_rate, nnft, time, options)

Calculates wave spectra from wave probe timeseries

Parameters
  • ts (matrix or table) – Wave probe time-series data, with each column a different time series

  • sample_rate (float) – Data frequency (Hz)

  • nnft (integer) – Number of bins in the Fast Fourier Transform

  • time (vector or table) – time (s)

  • window (string (Optional)) – Signal window type. “hamming” is used by default given the broadband nature of waves. See scipy.signal.get_window for more options. to call: elevation_spectrum(ts,sample_rate,nnft,time,”window”,window)

  • detrend (logical (Optional)) – Specifies if a linear trend is removed from the data before calculating the wave energy spectrum. Data is detrended by default. to call: elevation_spectrum(ts,sample_rate,nnft,time,”detrend”,detrend)

  • noverlap (integer (Optional)) – Number of points to overlap between segments. If None, noverlap = nperseg / 2. Defaults to None. to call: elevation_spectrum(ts,sample_rate,nnft,time,”noverlap”,noverlap)

Returns

S (structure)

S.spectrum: vector or matrix Spectral Density (m^2/Hz) per probe

S.type: ‘Spectra from Time Series’

S.frequency: frequency [Hz]

S.sample_rate: sample_rate

S.nnft: nnft

mhkit.wave.resource.spectral_bandwidth(S, varargin)

Calculates bandwidth from spectra

Parameters

S (Spectral Density (m^2/Hz)) –

Pandas data frame

To make a pandas data frame from user supplied frequency and spectra use py.mhkit_python_utils.pandas_dataframe.spectra_to_pandas(frequency,spectra)

OR

structure of form:

S.spectrum: Spectral Density (m^2/Hz)

S.type: String of the spectra type, i.e. Bretschneider, time series, date stamp etc.

S.frequency: frequency (Hz)

frequency_bins: vector (optional)

Bin widths for frequency of S. Required for unevenly sized bins

Returns

e (double) – Spectral BandWidth

mhkit.wave.resource.frequency_moment(S, N, varargin)

Calculates the Nth frequency moment of the spectrum

Parameters
  • S (Spectral Density (m^2/Hz)) –

    Pandas data frame

    To make a pandas data frame from user supplied frequency and spectra use py.mhkit_python_utils.pandas_dataframe.spectra_to_pandas(frequency,spectra)

    OR

    structure of form:

    S.spectrum: Spectral Density (m^2/Hz)

    S.type: String of the spectra type, i.e. Bretschneider, time series, date stamp etc.

    S.frequency: frequency (Hz)

  • N (int) – Moment (0 for 0th, 1 for 1st ….)

  • frequency_bins (vector (optional)) – Bin widths for frequency of S. Required for unevenly sized bins

Returns

m (double)

mhkit.wave.resource.wave_length(k)

Calculates wave length from wave number To compute: 2*pi/wavenumber

Parameters

k (wave number (1/m)) – intiger, double, or vector

Returns

l (double or array) – Wave length [m] indexed by frequency

mhkit.wave.resource.average_wave_period(S, varargin)

Calculates the average wave period

Parameters

S (Spectral Density (m^2/Hz)) –

Pandas data frame

To make a pandas data frame from user supplied frequency and spectra use py.mhkit_python_utils.pandas_dataframe.spectra_to_pandas(frequency,spectra)

OR

structure of form:

S.spectrum: Spectral Density (m^2/Hz)

S.type: String of the spectra type, i.e. Bretschneider, time series, date stamp etc.

S.frequency: frequency (Hz)

frequency_bins: vector (optional)

Bin widths for frequency of S. Required for unevenly sized bins

Returns

Tavg (float) – Mean wave period (s)

mhkit.wave.resource.significant_wave_height(S, varargin)

Calculates wave height from spectra

Parameters
  • S (Spectral Density (m^2/Hz)) –

    Pandas data frame

    To make a pandas data frame from user supplied frequency and spectra use py.mhkit_python_utils.pandas_dataframe.spectra_to_pandas(frequency,spectra)

    OR

    structure of form:

    S.spectrum: Spectral Density (m^2/Hz)

    S.type: String of the spectra type, i.e. Bretschneider, time series, date stamp etc.

    S.frequency: frequency (Hz)

  • frequency_bins (vector (optional)) – Bin widths for frequency of S. Required for unevenly sized bins

Returns

Hm0 (double) – Significant Wave Height (m)

mhkit.wave.resource.pierson_moskowitz_spectrum(frequency, Tp, Hs)

Calculates Pierson-Moskowitz Spectrum from Tucker and Pitt (2001)

Parameters
  • Frequency (float) – Wave frequency (Hz)

  • Tp (float) – Peak Period (s)

  • Hs (float) – Significant wave height (m)

Returns

S (structure)

S.spectrum=Spectral Density (m^2/Hz)

S.type=String of the spectra type, i.e. Bretschneider, time series, date stamp etc.

S.frequency= frequency (Hz)

S.Te

S.Hm0

mhkit.wave.resource.average_crest_period(S, varargin)

Calculates the average crest period

Parameters

S (Spectral Density (m^2/Hz)) –

Pandas data frame

To make a pandas data frame from user supplied frequency and spectra use py.mhkit_python_utils.pandas_dataframe.spectra_to_pandas(frequency,spectra)

OR

structure of form:

S.spectrum: Spectral Density (m^2/Hz)

S.type: String of the spectra type, i.e. Bretschneider, time series, date stamp etc.

S.frequency: frequency (Hz)

frequency_bins: vector (optional)

Bin widths for frequency of S. Required for unevenly sized bins

Returns

Tavg (double) – Average crest Period (s)

mhkit.wave.resource.average_zero_crossing_period(S, varargin)

Calculates wave average zero crossing period from spectra

Parameters

S (Spectral Density (m^2/Hz)) –

Pandas data frame

To make a pandas data frame from user supplied frequency and spectra use py.mhkit_python_utils.pandas_dataframe.spectra_to_pandas(frequency,spectra,x)

OR

structure of form:

S.spectrum: Spectral Density (m^2/Hz)

S.type: String of the spectra type, i.e. Bretschneider, time series, date stamp etc.

S.frequency: frequency (Hz)

frequency_bins: vector (optional)

Bin widths for frequency of S. Required for unevenly sized bins

Returns

Tz (double) – Average Zero Crossing Period (s)

mhkit.wave.resource.energy_period(S, varargin)
Parameters

S (Spectral Density (m^2/Hz)) –

Pandas data frame

To make a pandas data frame from user supplied frequency and spectra use py.mhkit_python_utils.pandas_dataframe.spectra_to_pandas(frequency,spectra)

OR

structure of form:

S.spectrum: Spectral Density (m^2/Hz)

S.type: String of the spectra type, i.e. Bretschneider, time series, date stamp etc.

S.frequency: frequency (Hz)

frequency_bins: vector (optional)

Bin widths for frequency of S. Required for unevenly sized bins

Returns

Te (float) – Wave energy Period (s)

mhkit.wave.resource.wave_celerity(k, h, options)

Calculates wave celerity (group velocity)

Parameters
  • k (wave number (1/m)) –

    structure of form:

    k.values= wave number

    k.frequency= frequency (Hz)

  • h (double) – Water depth (m)

  • g (double (optional)) – gravitational acceleration (m/s^2) to call: energy_flux(k,h,”g”,g)

  • depth_check (bool (optional)) – If True check depth regime. Default False. to call: energy_flux(k,h,”depth_check”,py.True)

  • ratio (double or int (optional)) – Only applied if depth_check=True. If h/l > ratio, water depth will be set to deep. Default ratio = 2 to call: energy_flux(k,h,”ratio”,ratio)

Returns

Cg (structure)

Cg.values: water celerity

Cg.frequency [Hz]

Cg.h: height [m]

mhkit.wave.resource.spectral_width(S, varargin)

Calculates wave spectral width from spectra

Parameters

S (Spectral Density (m^2/Hz)) –

Pandas data frame

To make a pandas data frame from user supplied frequency and spectra use py.mhkit_python_utils.pandas_dataframe.spectra_to_pandas(frequency,spectra)

OR

structure of form:

S.spectrum: Spectral Density (m^2/Hz)

S.type: String of the spectra type, i.e. Bretschneider, time series, date stamp etc.

S.frequency: frequency (Hz)

frequency_bins: vector (optional)

Bin widths for frequency of S. Required for unevenly sized bins

Returns

e0 (float) – Spectral Width

mhkit.wave.resource.jonswap_spectrum(frequency, Tp, Hs, varargin)

Calculates JONSWAP spectrum from Hasselmann et al (1973)

Parameters
  • Frequency (float) – Wave frequency (Hz)

  • Tp (float) – Peak Period (s)

  • Hs (float) – Significant Wave Height (s)

  • gamma (float (optional)) – Gamma

Returns

S (structure)

S.spectrum=Spectral Density (m^2/Hz)

S.type=String of the spectra type, i.e. Bretschneider, time series, date stamp etc.

S.frequency= frequency (Hz)

S.Te

S.Hm0

mhkit.wave.resource.surface_elevation(S, time_index, options)

Calculates wave elevation time series from spectrum using a random phase

Parameters
  • S (Spectral Density (m^2/Hz)) –

    Pandas data frame

    To make a pandas data frame from user supplied frequency and spectra use py.mhkit_python_utils.pandas_dataframe.spectra_to_pandas(frequency,spectra)

    OR

    structure of form:

    S.spectrum: Spectral Density (m^2/Hz)

    S.type: String of the spectra type, i.e. Bretschneider, time series, date stamp etc.

    S.frequency: frequency (Hz)

  • time_index (array) – Time used to create the wave elevation time series [s]

  • seed (Int (optional)) – random seed to call: wave_elevation(S,time_index,”seed”,seed)

  • frequency_bins (vector (optional)) – Bin widths for frequency of S. Required for unevenly sized bins to call: wave_elevation(S,time_index,”frequency_bins”,frequency_bins)

  • phases (vector or matrix (optional)) – Explicit phases for frequency components (overrides seed) to call: wave_elevation(S,time_index,”phases”,phases)

Returns

wave_elevation (structure)

wave_elevation.elevation: Wave surface elevation (m)

wave_elevation.type: ‘Time Series from Spectra’

wave_elevation.time

mhkit.wave.resource.environmental_contour(x1, x2, dt, period, options)

Calculates environmental contours of extreme sea states using the improved joint probability distributions with the inverse first-order reliability method (IFORM) probability for the desired return period (period). Given the period of interest a circle of iso-probability is created in the in the PCA joint probability (x1, x2) reference frame. Using the joint probability value the CDF of the marginal distribution is used to find the quantile of each component. Finally, using the improved PCA methodology the component 2 contour lines are calculated from component 1 using the relationships defined in Exkert-Gallup et. al. 2016.

Eckert-Gallup, A. C., Sallaberry, C. J., Dallman, A. R., & Neary, V. S. (2016). Application of principal component analysis (PCA) and improved joint probability distributions to the inverse first-order reliability method (I-FORM) for predicting extreme sea states. Ocean Engineering, 112, 307-319.

Parameters
  • x1 (vector) – component 1 data

  • x2 (vector) – component 2 data

  • dt (double) – x1 and x2 sample rate (seconds)

  • period (scalar or vector) – Desired return period (years) for calculation of environmental contour, can be a scalar or a vector.

  • PCA (Structure (optional)) – principal component analysis dictionary from previous function call. When supplied the function will skip the PCA calculation for the passe x1, and x2. to call: environmental_contour(x1,x2,dt,period,”PCA”,PCA)

  • bin_size (double (optional)) – Data points in each bin to call: environmental_contour(x1,x2,dt,period,”bin_size”,bin_size)

  • nb_steps (int (optional)) – Discretization of the circle in the normal space used for IFORM calculation. to call: environmental_contour(x1,x2,dt,period,”nb_steps”,nb_steps)

  • return_PCA (boolean) – Default False, if True will retun the PCA dictionary to call: environmental_contour(x1,x2,dt,period,”return_PCA”,return_PCA)

Returns

environmental_contour (Structure) – Structure with fields contour1, contour2, and optionally PCA

Performance

The performance submodule contains functions to compute capture length, statistics, performance matrices, and mean annual energy production.

Functions

Description

capture_length

Calculates the capture length (often called capture width).

capture_length_matrix

Generates a capture length matrix for a given statistic

mean_annual_energy_production_matrix

Calculates mean annual energy production (MAEP) from matrix data along with data frequency in each bin

mean_annual_energy_production_timeseeries

Calculates mean annual energy production (MAEP) from timeseries

power_matrix

Generates a power matrix from a capture length matrix and wave energy flux matrix

wave_energy_flux_matrix

Generates a wave eneergy flux matrix for a given statistic

power_performance_workflow

High-level function to compute power performance quantities of interest following IEC TS 62600-100 for given wave spectra.

mhkit.wave.performance.power_performance_workflow(S, h, P, statistic, options)

High-level function to compute power performance quantities of interest following IEC TS 62600-100 for given wave spectra.

Parameters
  • S (structure with fields:) – S.spectrum: Spectral Density [m^2/Hz] S.frequency: frequency [Hz] S.time : time [datetime]

  • h (integer) – Water depth [m]

  • P (array or vector) – Power [W]

  • statistic (string or array of strings) – Capture length statistics for plotting options include: “mean”, “std”, “median”, “count”, “sum”, “min”, “max”, and “frequency”. Note that “std” uses a degree of freedom of 1 in accordance with IEC/TS 62600-100. To output capture length matrices for multiple binning parameters, define as a string array: statistic = [“”, “”, “”];

  • savepath (string (optional)) – Path to save figure. to call: power_performance_wave(S,h,P,statistic,”savepath”,savepath)

  • rho (float (optional)) – Water density [kg/m^3] to call: power_performance_wave(S,h,P,statistic,”rho”,rho)

  • g (float (optional)) – Gravitational acceleration [m/s^2] to call: power_performance_wave(S,h,P,statistic,”g”,g)

  • frequency_bins (vector (optional)) – Bin widths for frequency of S. Required for unevenly sized bins

Returns

  • cl_matrix (figure) – Capture length matrix

  • maep_matrix (float) – Mean annual energy production

mhkit.wave.performance.mean_annual_energy_production_timeseries(L, J)

Calculates mean annual energy production (MAEP) from timeseries

Parameters
  • L (numpy array or vector) – Capture length

  • J (numpy array or vector) – Wave energy flux

Returns

maep (float) – Mean annual energy production

mhkit.wave.performance.capture_length_matrix(Hm0, Te, L, statistic, Hm0_bins, Te_bins)

Generates a capture length matrix for a given statistic

Note that IEC/TS 62600-100 requires capture length matrices for the mean, std, count, min, and max.

Parameters
  • Hm0 (numpy array or vector) – Significant wave height from spectra [m]

  • Te (numpy array or vector) – Energy period from spectra [s]

  • L (numpy array or vector) – Capture length [m]

  • statistic (string) – Statistic for each bin, options include: ‘mean’, ‘std’, ‘median’, ‘count’, ‘sum’, ‘min’, ‘max’, and ‘frequency’. Note that ‘std’ uses a degree of freedom of 1 in accordance with IEC/TS 62600-100. or a callable function of python type

  • Hm0_bins (numpy array or vector) – Bin centers for Hm0 [m]

  • Te_bins (numpy array or vector) – Bin centers for Te [s]

Returns

clm (structure)

clm.values

clm.stat

clm.Hm0_bins

clm.Te_bins

mhkit.wave.performance.wave_energy_flux_matrix(Hm0, Te, J, statistic, Hm0_bins, Te_bins)

Generates a wave eneergy flux matrix for a given statistic

Note that IEC/TS 62600-100 requires capture length matrices for the mean, std, count, min, and max.

Parameters
  • Hm0 (numpy array or vector) – Significant wave height from spectra [m]

  • Te (numpy array or vector) – Energy period from spectra [s]

  • J (numpy array or vector) – wave energy flux from spectra [W/m]

  • statistic (string) – Statistic for each bin, options include: ‘mean’, ‘std’, ‘median’, ‘count’, ‘sum’, ‘min’, ‘max’, and ‘frequency’. Note that ‘std’ uses a degree of freedom of 1 in accordance with IEC/TS 62600-100.

  • Hm0_bins (numpy array or vector) – Bin centers for Hm0 [m]

  • Te_bins (numpy array or vector) – Bin centers for Te [s]

Returns

WEFM (Structure)

WEFM.values

WEFM.stat

WEFM.Hm0_bins

WEFM.Te_bins

mhkit.wave.performance.mean_annual_energy_production_matrix(LM, JM, frequency)

Calculates mean annual energy production (MAEP) from matrix data along with data frequency in each bin

Parameters

LM

Pandas data frame

To make a pandas data frame from user supplied frequency and spectra use py.mhkit_python_utils.pandas_dataframe.spectra_to_pandas(Hm0_bins,L)

OR

structure of form:

LM.values

LM.stat

LM.Hm0_bins

LM.Te_bins

Returns

maep (float) – Mean annual energy production

mhkit.wave.performance.power_matrix(LM, JM)

Generates a power matrix from a capture length matrix and wave energy flux matrix

Parameters

LM

Pandas data frame

To make a pandas data frame from user supplied frequency and spectra use py.mhkit_python_utils.pandas_dataframe.spectra_to_pandas(Hm0_bins,L)

OR

structure of form:

LM.values

LM.stat

LM.Hm0_bins

LM.Te_bins

Returns

PM (Structure)

PM.values: Power matrix

PM.stat: statistic of the matrix (i.e. “mean”, “max”, etc.) (string)

PM.Hm0_bins

PM.Te_bins

mhkit.wave.performance.capture_length(Power, J)

Calculates the capture length (often called capture width).

Parameters
  • P (array or vector) – Power [W]

  • J (array or vector) – Omnidirectional wave energy flux [W/m]

Returns

L (vector) – Capture length [m]

Graphics

The :graphics submodule contains functions to plot wave data and related metrics.

Functions

Description

plot_elevation_timeseries

Plots wave elevation timeseries

plot_envoronmental_contours

Plots an overlay of the x1 and x2 variables to the calculated environmental contours.

plot_matrix

Plots the matrix with Hm0 and Te on the y and x axis

plot_spectrum

Plots wave amplitude spectrum

plot_chakrabarti

Plots, in the style of Chakrabarti (2005), relative importance of viscous,inertia, and diffraction phemonena

plot_boxplot

Creates monthl average boxplots of significant wave height

plot_compendium

Creates subplots of environmental resource from cdip data

mhkit.wave.graphics.plot_environmental_contours(x1, x2, x1_contour, x2_contour, options)

Plots an overlay of the x1 and x2 variables to the calculated environmental contours.

Parameters
  • x1 (vector) – x-axis data

  • x2 (vector) – y-axis data

  • x1_countour (Table) – Calculated x1 contour values

  • x2_countour (Table) – Calculated x2 contour values

  • x_label (string (optional)) – x-axis label. Default None. to call: plot_environmental_contours(x1,x2,x1_contour,x2_contour,”x_label”,x_label)

  • y_label (string (optional)) – y-axis label. Default None. to call: plot_environmental_contours(x1,x2,x1_contour,x2_contour,”y_label”,y_label)

  • data_label (string (optional)) – Legend label for x1, x2 data (e.g. ‘Buoy 46022’). Default None. to call: plot_environmental_contours(x1,x2,x1_contour,x2_contour,”data_label”,data_label)

  • contour_label (string or array of strings (optional)) – Legend label for x1_contour, x2_contour countor data (e.g. ‘100-year contour’). Default None. to call: plot_environmental_contours(x1,x2,x1_contour,x2_contour,”contour_label”,contour_label)

  • title (string (optional)) – title for the plot to call: plot_environmental_contours(x1,x2,x1_contour,x2_contour,”title”,title)

  • savepath (string (optional)) – path and filename to save figure. to call: plot_environmental_contours(x1,x2,x1_contour,x2_contour,”savepath”,savepath)

Returns

figure (figure) – Envoronmental contour plot

mhkit.wave.graphics.plot_boxplot(Hs, time, options)

PLOT_BOXPLOT Creates monthly-averaged boxplots of significant wave height

Creates monthly-averaged boxplots of significant wave height (Hs) Developed based on: http://cdip.ucsd.edu/themes/media/docs/documents/html_pages/annualHs_plot.html

Parameters
  • Hs (double array) – significant wave height

  • time (datetime array) – timestamps

  • buoy_title (string (optional)) – figure suptitle (super title)

Returns

f (figure object)

mhkit.wave.graphics.plot_compendium(Hs, Tp, Dp, time, options)

PLOT_COMPENDIUM Creates subplots of wave height, peak period and direction

Creates subplots showing: Significant Wave Height (Hs), Peak Period (Tp), and Direction (Dp). Developed based on: http://cdip.ucsd.edu/themes/media/docs/documents/html_pages/compendium.html

Parameters
  • Hs (double array) – significant wave height

  • Tp (double array) – peak period

  • Dp (double array) – direction

  • time (datetime array) – timestamps

  • buoy_title (string (optional)) – figure suptitle (super title)

Returns

f (figure object)

mhkit.wave.graphics.plot_elevation_timeseries(wave_elevation, options)

Plots wave elevation timeseries

Parameters
  • wave_elevation (Structure of the following form:) –

    wave_elevation.elevation: elevation [m]

    wave_elevation.time: time (s);

  • title (string (optional)) – title for the plot to call: plot_elevation_timeseries(wave_elevation,”title”,title)

  • savepath (string (optional)) – path and filename to save figure. to call: plot_elevation_timeseries(wave_elevation,”savepath”,savepath)

Returns

figure (figure) – Plot of wave elevation vs. time

mhkit.wave.graphics.plot_matrix(M, Mtype, options)

Plots the matrix with Hm0 and Te on the y and x axis

Parameters
  • M (structure) –

    M.values: matrix

    M.Hm0_bins

    M.Te_bins

    M.stat

  • Mtype (string) –

    type of matrix (i.e. power, capture length, etc.) to be used

    in plot title

    savepath: string (optional)

    path and filename to save figure. to call: plot_matrix(M, Mtype,”savepath”,savepath)

Returns

figure (plot of the matrix)

mhkit.wave.graphics.plot_chakrabarti(H, lambda_w, D, options)

Plots, in the style of Chakrabarti (2005), relative importance of viscous, inertia, and diffraction phemonena

Chakrabarti, Subrata. Handbook of Offshore Engineering (2-volume set). Elsevier, 2005.

Parameters
  • H (integer, double or vector) – Wave height [m]

  • lambda_w (integer, double or vector) – Wave length [m]

  • D (integer, double or vector of) – Characteristic length [m]

  • savepath (string (optional)) – path and filename to save figure. to call: plot_chakrabarti(H,lambda_w,D,”savepath”,savepath)

Returns

  • figure (figure)

  • Plots wave force regime as Keulegan-Carpenter parameter versus

  • diffraction parameter

Examples

Using Integers >> D = 5 >> H = 8 >> lambda_w = 200 >> plot_chakrabarti(H,lambda_w,D)

Using vector >> D = linspace(5,15,5) >> H = 8*ones(size(D)) >> lambda_w = 200*ones(size(D)) >> plot_chakrabarti(H,lambda_w,D)

mhkit.wave.graphics.plot_spectrum(wave_spectra, options)

Plots wave amplitude spectrum

Parameters

wave_spectra

Returns

figure (figure)

Plot of wave amplitude spectra versus omega