Binning Tools

Velocity Analysis

Analysis in DOLfYN is primarily handled through the VelBinner class. Below is a list of functions that can be called from VelBinner.

VelBinner

This is the base binning (averaging) tool.

do_avg

Average data into bins/ensembles

do_var

Find the variances of binned data.

reshape

Reshape the array arr to shape (...,n,n_bin+n_pad).

calc_coh

Calculate coherence between veldat1 and veldat2.

calc_phase_angle

Calculate the phase difference between two signals as a function of frequency (complimentary to coherence).

calc_acov

Calculate the auto-covariance of the raw-signal veldat

calc_xcov

Calculate the cross-covariance between arrays veldat1 and veldat2

do_tke

Calculate the tke (variances of u,v,w) and stresses (cross-covariances of u,v,w)

calc_tke

Calculate the tke (variances of u,v,w).

calc_stress

Calculate the stresses (cross-covariances of u,v,w)

calc_psd

Calculate the power spectral density of velocity.

calc_csd

Calculate the cross-spectral density of velocity components.

calc_freq

Calculate the ordinary or radial frequency vector for the PSDs

Turbulence Analysis

Functions for analyzing ADV data via the ADVBinner class, beyond those described in VelBinner. Functions for analyzing turbulence statistics from ADCP data are in development.

ADVBinner

A class that builds upon VelBinner for calculating turbulence statistics and velocity spectra from ADV data

calc_turbulence

Functional version of ADVBinner that computes a suite of turbulence statistics for the input dataset, and returns a binned data object.

calc_epsilon_LT83

Calculate the dissipation rate from the PSD

calc_epsilon_SF

Calculate dissipation rate using the "structure function" (SF) method

calc_epsilon_TE01

Calculate the dissipation rate according to TE01.

calc_L_int

Calculate integral length scales.

class dolfyn.binned.TimeBinner(n_bin, fs, n_fft=None, n_fft_coh=None, noise=[0, 0, 0])[source]

Bases: object

Initialize an averaging object

Parameters
  • n_bin (int) – Number of data points to include in a ‘bin’ (ensemble), not the number of bins

  • fs (int) – Instrument sampling frequency

  • n_fft (int) – Number of data points to use for fft (n_fft`<=`n_bin). Default: n_fft`=`n_bin

  • n_fft_coh (int) – Number of data points to use for coherence and cross-spectra ffts Default: n_fft_coh`=`n_fft

  • noise (list or ndarray) – Instrument’s doppler noise in same units as velocity

reshape(arr, n_pad=0, n_bin=None)[source]

Reshape the array arr to shape (…,n,n_bin+n_pad).

Parameters
  • arr (numpy.ndarray) –

  • n_pad (int) – Is used to add n_pad/2 points from the end of the previous ensemble to the top of the current, and n_pad/2 points from the top of the next ensemble to the bottom of the current. Zeros are padded in the upper-left and lower-right corners of the matrix (beginning/end of timeseries). In this case, the array shape will be (…,`n`,`n_pad`+`n_bin`)

  • n_bin (float, int (optional)) – Override this binner’s n_bin.

Returns

out (|np.ndarray|)

Notes

n_bin can be non-integer, in which case the output array size will be n_pad`+`n_bin, and the decimal will cause skipping of some data points in arr. In particular, every mod(n_bin,1) bins will have a skipped point. For example: - for n_bin=2048.2 every 1/5 bins will have a skipped point. - for n_bin=4096.9 every 9/10 bins will have a skipped point.

do_avg(raw_ds, out_ds=None, names=None, noise=[0, 0, 0])[source]

Average data into bins/ensembles

Parameters
  • raw_ds (xarray.Dataset) – The raw data structure to be binned

  • out_ds (xarray.Dataset) – The bin’d (output) data object to which averaged data is added.

  • names (list of strings) – The names of variables to be averaged. If names is None, all data in raw_ds will be binned.

  • noise (list or numpy.ndarray) – instrument’s doppler noise in same units as velocity

Returns

ds (xarray.Dataset) – A new, averaged dataset if ‘out_ds’ is not specified, or averaged variables returned as dataArrays within ‘out_ds’ if specified.

do_var(raw_ds, out_ds=None, names=None, suffix='_var')[source]

Find the variances of binned data. Complementary to do_avg().

Parameters
  • raw_ds (xarray.Dataset) – The raw data structure to be binned.

  • out_ds (xarray.Dataset) – The binned (output) dataset to which variance data is added, nominally dataset output from do_avg()

  • names (list of strings) – The names of variables of which to calculate variance. If names is None, all data in raw_ds will be binned.

Returns

ds (xarray.Dataset) – A new, variance dataset if ‘out_ds’ is not specified, or variables variances returned as dataArrays within ‘out_ds’ if specified.

calc_coh(veldat1, veldat2, window='hann', debias=True, noise=(0, 0), n_fft_coh=None, n_bin=None)[source]

Calculate coherence between veldat1 and veldat2.

Parameters
  • veldat1 (xarray.DataArray) – The first (the longer, if applicable) raw dataArray of which to calculate coherence

  • veldat2 (xarray.DataArray) – The second (the shorter, if applicable) raw dataArray of which to calculate coherence

  • window (str) – String indicating the window function to use (default: ‘hanning’)

  • noise (float) – The white-noise level of the measurement (in the same units as veldat).

  • n_fft_coh (int) – n_fft of veldat2, number of elements per bin if ‘None’ is taken from VelBinner

  • n_bin (int) – n_bin of veldat2, number of elements per bin if ‘None’ is taken from VelBinner

Returns

da (xarray.DataArray) – The coherence between signal veldat1 and veldat2.

Notes

The two velocity inputs do not have to be perfectly synchronized, but they should have the same start and end timestamps.

calc_phase_angle(veldat1, veldat2, window='hann', n_fft_coh=None, n_bin=None)[source]

Calculate the phase difference between two signals as a function of frequency (complimentary to coherence).

Parameters
  • veldat1 (xarray.DataArray) – The first (the longer, if applicable) raw dataArray of which to calculate phase angle

  • veldat2 (xarray.DataArray) – The second (the shorter, if applicable) raw dataArray of which to calculate phase angle

  • window (str) – String indicating the window function to use (default: ‘hanning’).

  • n_fft (int) – Number of elements per bin if ‘None’ is taken from VelBinner

  • n_bin (int) – Number of elements per bin from veldat2 if ‘None’ is taken from VelBinner

Returns

da (xarray.DataArray) – The phase difference between signal veldat1 and veldat2.

Notes

The two velocity inputs do not have to be perfectly synchronized, but they should have the same start and end timestamps.

calc_acov(veldat, n_bin=None)[source]

Calculate the auto-covariance of the raw-signal veldat

Parameters
  • veldat (xarray.DataArray) – The raw dataArray of which to calculate auto-covariance

  • n_bin (float) – Number of data elements to use

Returns

da (xarray.DataArray) – The auto-covariance of veldat

Notes

As opposed to calc_xcov, which returns the full cross-covariance between two arrays, this function only returns a quarter of the full auto-covariance. It computes the auto-covariance over half of the range, then averages the two sides (to return a ‘quartered’ covariance).

This has the advantage that the 0 index is actually zero-lag.

calc_xcov(veldat1, veldat2, npt=1, n_bin=None, normed=False)[source]

Calculate the cross-covariance between arrays veldat1 and veldat2

Parameters
  • veldat1 (xarray.DataArray) – The first raw dataArray of which to calculate cross-covariance

  • veldat2 (xarray.DataArray) – The second raw dataArray of which to calculate cross-covariance

  • npt (int) – Number of timesteps (lag) to calculate covariance

  • n_fft (int) – n_fft of veldat2, number of elements per bin if ‘None’ is taken from VelBinner

  • n_bin (int) – n_bin of veldat2, number of elements per bin if ‘None’ is taken from VelBinner

Returns

da (xarray.DataArray) – The cross-covariance between signal veldat1 and veldat2.

Notes

The two velocity inputs must be the same length

calc_freq(fs=None, units='Hz', n_fft=None, coh=False)[source]

Calculate the ordinary or radial frequency vector for the PSDs

Parameters
  • fs (float (optional)) – The sample rate (Hz).

  • units (string) – Frequency units in either Hz or rad/s (f or omega)

  • coh (bool) – Calculate the frequency vector for coherence/cross-spectra (default: False) i.e. use self.n_fft_coh instead of self.n_fft.

  • n_fft (int) – n_fft of veldat2, number of elements per bin if ‘None’ is taken from VelBinner

Returns

out (|np.ndarray|) – Spectrum frequency array in units of ‘Hz’ or ‘rad/s’

class dolfyn.velocity.Velocity(ds, *args, **kwargs)[source]

Bases: object

All ADCP and ADV xarray datasets wrap this base class.

The turbulence-related attributes defined within this class assume that the 'tke_vec' and 'stress' data entries are included in the dataset. These are typically calculated using a VelBinner tool, but the method for calculating these variables can depend on the details of the measurement (instrument, it’s configuration, orientation, etc.).

See also

VelBinner

property u

The first velocity component.

This is simply a shortcut to self[‘vel’][0]. Therefore, depending on the coordinate system of the data object (self.attrs[‘coord_sys’]), it is:

  • beam: beam1

  • inst: x

  • earth: east

  • principal: streamwise

property v

The second velocity component.

This is simply a shortcut to self[‘vel’][1]. Therefore, depending on the coordinate system of the data object (self.attrs[‘coord_sys’]), it is:

  • beam: beam2

  • inst: y

  • earth: north

  • principal: cross-stream

property w

The third velocity component.

This is simply a shortcut to self[‘vel’][2]. Therefore, depending on the coordinate system of the data object (self.attrs[‘coord_sys’]), it is:

  • beam: beam3

  • inst: z

  • earth: up

  • principal: up

property U

Horizontal velocity as a complex quantity

property U_mag

Horizontal velocity magnitude

property U_dir

Angle of horizontal velocity vector, degrees counterclockwise from X/East/streamwise. Direction is ‘to’, as opposed to ‘from’.

property tau_ij

Total stress tensor

property E_coh

Coherent turbulent energy

Niel Kelley’s ‘coherent turbulence energy’, which is the RMS of the Reynold’s stresses.

See: NREL Technical Report TP-500-52353

property I_tke

Turbulent kinetic energy intensity.

Ratio of sqrt(tke) to horizontal velocity magnitude.

property I

Turbulence intensity.

Ratio of standard deviation of horizontal velocity std dev to horizontal velocity magnitude.

property tke

Turbulent kinetic energy (sum of the three components)

property upvp_

u’v’bar Reynolds stress

property upwp_

u’w’bar Reynolds stress

property vpwp_

v’w’bar Reynolds stress

property upup_

u’u’bar component of the tke

property vpvp_

v’v’bar component of the tke

property wpwp_

w’w’bar component of the tke

property k

Wavenumber vector, calculated from psd-frequency vector

class dolfyn.velocity.VelBinner(n_bin, fs, n_fft=None, n_fft_coh=None, noise=[0, 0, 0])[source]

Bases: dolfyn.binned.TimeBinner

This is the base binning (averaging) tool. All DOLfYN binning tools derive from this base class.

Examples

The VelBinner class is used to compute averages and turbulence statistics from ‘raw’ (not averaged) ADV or ADP measurements, for example:

# First read or load some data.
rawdat = dlfn.read_example('BenchFile01.ad2cp')

# Now initialize the averaging tool:
binner = dlfn.VelBinner(n_bin=600, fs=rawdat.fs)

# This computes the basic averages
avg = binner.do_avg(rawdat)

Initialize an averaging object

Parameters
  • n_bin (int) – Number of data points to include in a ‘bin’ (ensemble), not the number of bins

  • fs (int) – Instrument sampling frequency

  • n_fft (int) – Number of data points to use for fft (n_fft`<=`n_bin). Default: n_fft`=`n_bin

  • n_fft_coh (int) – Number of data points to use for coherence and cross-spectra ffts Default: n_fft_coh`=`n_fft

  • noise (list or ndarray) – Instrument’s doppler noise in same units as velocity

do_tke(dat, out_ds=None)[source]

Calculate the tke (variances of u,v,w) and stresses (cross-covariances of u,v,w)

Parameters
  • dat (xarray.Dataset) – Xarray dataset containing raw velocity data

  • out_ds (xarray.Dataset) – Averaged dataset to save tke and stress dataArrays to, nominally dataset output from do_avg().

Returns

ds (xarray.Dataset) – Dataset containing tke and stress dataArrays

calc_tke(veldat, noise=[0, 0, 0], detrend=True)[source]

Calculate the tke (variances of u,v,w).

Parameters
  • veldat (xarray.DataArray) – a velocity data array. The last dimension is assumed to be time.

  • noise (float) – a three-element vector of the noise levels of the velocity data for ach component of velocity.

  • detrend (bool (default: False)) – detrend the velocity data (True), or simply de-mean it (False), prior to computing tke. Note: the psd routines use detrend, so if you want to have the same amount of variance here as there use detrend=True.

Returns

ds (xarray.DataArray) – dataArray containing u’u’_, v’v’_ and w’w’_

calc_stress(veldat, detrend=True)[source]

Calculate the stresses (cross-covariances of u,v,w)

Parameters
  • veldat (xr.DataArray) – A velocity data array. The last dimension is assumed to be time.

  • detrend (bool (default: True)) – detrend the velocity data (True), or simply de-mean it (False), prior to computing stress. Note: the psd routines use detrend, so if you want to have the same amount of variance here as there use detrend=True.

Returns

ds (xarray.DataArray)

calc_psd(veldat, freq_units='Hz', fs=None, window='hann', noise=[0, 0, 0], n_bin=None, n_fft=None, n_pad=None, step=None)[source]

Calculate the power spectral density of velocity.

Parameters
  • veldat (xr.DataArray) – The raw velocity data (of dims ‘dir’ and ‘time’).

  • freq_units (string) – Frequency units of the returned spectra in either Hz or rad/s (f or \(\omega\))

  • fs (float (optional)) – The sample rate (default: from the binner).

  • window (string or array) – Specify the window function.

  • noise (list(3 floats) (optional)) – Noise level of each component’s velocity measurement (default 0).

  • n_bin (int (optional)) – The bin-size (default: from the binner).

  • n_fft (int (optional)) – The fft size (default: from the binner).

  • n_pad (int (optional)) – The number of values to pad with zero (default: 0)

  • step (int (optional)) – Controls amount of overlap in fft (default: the step size is chosen to maximize data use, minimize nens, and have a minimum of 50% overlap.).

Returns

psd (xarray.DataArray (3, M, N_FFT)) – The spectra in the ‘u’, ‘v’, and ‘w’ directions.

calc_csd(veldat, freq_units='Hz', fs=None, window='hann', n_bin=None, n_fft_coh=None)[source]

Calculate the cross-spectral density of velocity components.

Parameters
  • veldat (xarray.DataArray) – The raw 3D velocity data.

  • freq_units (string) – Frequency units of the returned spectra in either Hz or rad/s (f or \(\omega\))

  • fs (float (optional)) – The sample rate (default: from the binner).

  • window (string or array) – Specify the window function.

  • n_bin (int (optional)) – The bin-size (default: from the binner).

  • n_fft_coh (int (optional)) – The fft size (default: n_fft_coh from the binner).

Returns

csd (xarray.DataArray (3, M, N_FFT)) – The first-dimension of the cross-spectrum is the three different cross-spectra: ‘uv’, ‘uw’, ‘vw’.

class dolfyn.adv.turbulence.ADVBinner(n_bin, fs, n_fft=None, n_fft_coh=None, noise=[0, 0, 0])[source]

Bases: dolfyn.velocity.VelBinner

A class that builds upon VelBinner for calculating turbulence statistics and velocity spectra from ADV data

Parameters
  • n_bin (int) – The length of bin s, in number of points, for this averaging operator.

  • n_fft (int (optional, default: n_fft = n_bin)) – The length of the FFT for computing spectra (must be < n_bin)

Initialize an averaging object

Parameters
  • n_bin (int) – Number of data points to include in a ‘bin’ (ensemble), not the number of bins

  • fs (int) – Instrument sampling frequency

  • n_fft (int) – Number of data points to use for fft (n_fft`<=`n_bin). Default: n_fft`=`n_bin

  • n_fft_coh (int) – Number of data points to use for coherence and cross-spectra ffts Default: n_fft_coh`=`n_fft

  • noise (list or ndarray) – Instrument’s doppler noise in same units as velocity

__call__(ds, freq_units='rad/s', window='hann')[source]

Compute a suite of turbulence statistics for the input data ds, and return a binned data object.

Parameters
  • ds (xarray.Dataset) – The raw adv dataset to bin, average and compute turbulence statistics of.

  • omega_range_epsilon (iterable(2)) – The frequency range (low, high) over which to estimate the dissipation rate epsilon [rad/s].

  • window (1, None, 'hann') – The window to use for psds.

Returns

advb (xarray.Dataset) – Returns an ‘binned’ (i.e. ‘averaged’) dataset. All fields (variables) of the input dataset are averaged in n_bin chunks. This object also computes the following items over those chunks:

  • tke_vec : The energy in each component (components are also accessible as upup_, vpvp_, wpwp_)

  • stress : The Reynolds stresses (each component is accessible as upvp_, upwp_, vpwp_)

  • U_std : The standard deviation of the horizontal velocity U_mag.

  • psd: A DataArray containing the spectra of the velocity in radial frequency units. This DataArray contains: - spectra : the velocity spectra array (m^2/s/rad)) - omega : the radial frequency (rad/s)

calc_epsilon_LT83(psd, U_mag, omega_range=[6.28, 12.57])[source]

Calculate the dissipation rate from the PSD

Parameters
  • psd (xarray.DataArray (...,n_time,n_f)) – The psd [m^2/s/rad] with frequency vector ‘omega’ [rad/s]

  • U_mag (numpy.ndarray (…,n_time)) – The bin-averaged horizontal velocity [m/s] (from dataset shortcut)

  • omega_range (iterable(2)) – The range over which to integrate/average the spectrum.

Returns

epsilon (xarray.DataArray (…,n_time)) – dataArray of the dissipation rate

Notes

This uses the standard formula for dissipation:

\[S(k) = \alpha \epsilon^{2/3} k^{-5/3}\]

where \(\alpha = 0.5\) (1.5 for all three velocity components), k is wavenumber and S(k) is the turbulent kinetic energy spectrum.

With \(k \rightarrow \omega / U\), then – to preserve variance – \(S(k) = U S(\omega)\), and so this becomes:

\[S(\omega) = \alpha \epsilon^{2/3} \omega^{-5/3} U^{2/3}\]

LT83 : Lumley and Terray, “Kinematics of turbulence convected by a random wave field”. JPO, 1983, vol13, pp2000-2007.

calc_epsilon_SF(vel_raw, U_mag, fs=None, freq_rng=[2.0, 4.0])[source]

Calculate dissipation rate using the “structure function” (SF) method

Parameters
  • vel_raw (xarray.DataArray) – The raw velocity data (with dimension time) upon which to perform the SF technique.

  • U_mag (xarray.DataArray) – The bin-averaged horizontal velocity (from dataset shortcut)

  • fs (float) – The sample rate of vel_raw [Hz]

  • freq_rng (iterable(2)) – The frequency range over which to compute the SF [Hz] (i.e. the frequency range within which the isotropic turbulence cascade falls)

Returns

epsilon (xarray.DataArray) – dataArray of the dissipation rate

calc_epsilon_TE01(dat_raw, dat_avg, omega_range=[6.28, 12.57])[source]

Calculate the dissipation rate according to TE01.

Parameters
  • dat_raw (xarray.Dataset) – The raw (off the instrument) adv dataset

  • dat_avg (xarray.Dataset) – The bin-averaged adv dataset (calc’d from ‘calc_turbulence’ or ‘do_avg’). The spectra (psd) and basic turbulence statistics (‘tke_vec’ and ‘stress’) must already be computed.

Notes

TE01 : Trowbridge, J and Elgar, S, “Turbulence measurements in the Surf Zone”. JPO, 2001, vol31, pp2403-2417.

calc_L_int(a_cov, vel_avg, fs=None)[source]

Calculate integral length scales.

Parameters
  • a_cov (xarray.DataArray) – The auto-covariance array (i.e. computed using calc_acov).

  • vel_avg (xarray.DataArray) – The bin-averaged velocity (from dataset shortcut)

  • fs (float) – The raw sample rate

Returns

L_int (|np.ndarray| (…, n_time)) – The integral length scale (T_int*U_mag).

Notes

The integral time scale (T_int) is the lag-time at which the auto-covariance falls to 1/e.

If T_int is not reached, L_int will default to ‘0’.

dolfyn.adv.turbulence.calc_turbulence(ds_raw, n_bin, fs, n_fft=None, freq_units='rad/s', window='hann')[source]

Functional version of ADVBinner that computes a suite of turbulence statistics for the input dataset, and returns a binned data object.

Parameters
  • ds_raw (xarray.Dataset) – The raw adv datset to bin, average and compute turbulence statistics of.

  • omega_range_epsilon (iterable(2)) – The frequency range (low, high) over which to estimate the dissipation rate epsilon, in units of [rad/s].

  • window (1, None, 'hann') – The window to use for calculating power spectral densities

Returns

ds (xarray.Dataset) – Returns an ‘binned’ (i.e. ‘averaged’) data object. All fields (variables) of the input data object are averaged in n_bin chunks. This object also computes the following items over those chunks:

  • tke_vec : The energy in each component, each components is alternatively accessible as: upup_, vpvp_, wpwp_)

  • stress : The Reynolds stresses, each component is alternatively accessible as: upwp_, vpwp_, upvp_)

  • U_std : The standard deviation of the horizontal velocity U_mag.

  • psd : DataArray containing the spectra of the velocity in radial frequency units. The data-array contains: - vel : the velocity spectra array (m^2/s/rad)) - omega : the radial frequncy (rad/s)