LTPDA Toolbox™ | contents | ![]() ![]() |
|
The LTPDA toolbox restrict access of the properties.
The get access is 'public' and thus it is possible to get the values with the dot-command (similar to structures).
For example:The set access is 'protected' and thus it is only possible to assign a value to a property with a set-method.
val = obj.prop(2).prop;
For example: obj2 = obj1.setName('my name') % This command creates a copy of obj1 (obj1 ~= obj2) obj.setName('my name'); % This command applies to obj
Properties | Description | Defining Class |
---|---|---|
data | Data object associated with this AO | ao |
hist | History of the object (history object) | ltpda_uoh |
procinfo | plist with additional information for an object. | ltpda_uoh |
plotinfo | plotinfo object | ltpda_uoh |
name | name of the object | ltpda_uo |
description | description of the object | ltpda_uo |
UUID | Universally Unique Identifier of 128-bit | ltpda_uo |
|
Methods | Description | Defining Class |
---|---|---|
and | Overloads the and (&) method for analysis objects. | ao |
eq | Overloads == operator for analysis objects. Compare the y-axis values. | ao |
ge | Overloads >= operator for analysis objects. Compare the y-axis values. | ao |
gt | Overloads > operator for analysis objects. Compare the y-axis values. | ao |
le | Overloads <= operator for analysis objects. Compare the y-axis values. | ao |
lt | Overloads < operator for analysis objects. Compare the y-axis values. | ao |
minus | Implements subtraction operator for analysis objects. | ao |
mod | Overloads the modulus function for analysis objects. | ao |
mpower | Implements mpower operator for analysis objects. | ao |
mrdivide | Implements mrdivide operator for analysis objects. | ao |
mtimes | Implements mtimes operator for analysis objects. | ao |
ne | Overloads ~= operator for analysis objects. Compare the y-axis values. | ao |
or | Overloads the or (|) method for Analysis objects. | ao |
plus | Implements addition operator for analysis objects. | ao |
power | Implements power operator for analysis objects. | ao |
rdivide | Implements division operator for analysis objects. | ao |
times | Implements multiplication operator for analysis objects. | ao |
xor | Overloads the xor (exclusive or) method for Analysis objects. | ao |
Methods | Description | Defining Class |
---|---|---|
ao | Analysis object class constructor. | ao |
rebuild | Rebuilds the input objects using the history. | ltpda_uoh |
Methods | Description | Defining Class |
---|---|---|
cast | Converts the numeric values in an AO to the data type specified by type. | ao |
double | Overloads double() function for analysis objects. | ao |
logical | Overloads logical() function for analysis objects. | ao |
Methods | Description | Defining Class |
---|---|---|
convert | Perform various conversions on the ao. | ao |
demux | Splits the input vector of AOs into a number of output AOs. | ao |
dx | Get the data property 'dx'. | ao |
dy | Get the data property 'dy'. | ao |
dz | DX Get the data property 'dz'. | ao |
find | Particular samples that satisfy the input query and return a new AO. | ao |
flscov | M - Tool to perform a least square fit in frequency domain. | ao |
fromProcinfo | Returns for a given key-name the value of the procinfo-plist | ao |
fs | Get the data property 'fs'. | ao |
join | Multiple AOs into a single AO. | ao |
len | Overloads the length operator for Analysis objects. Length of the data samples. | ao |
nsecs | Get the data property 'nsecs'. | ao |
scatter3D | Creates from the y-values of the input AOs a new AO with a xyz-data object | ao |
scatterData | Creates from the y-values of two input AOs an new AO(xydata) | ao |
setDx | Sets the 'dx' property of the ao. | ao |
setDy | Sets the 'dy' property of the ao. | ao |
setDz | Sets the 'dz' property of the ao. | ao |
setEnbw | Sets the 'enbw' property of the ao/fsdata. | ao |
setFs | Sets the 'fs' property of the ao. | ao |
setNavs | Sets the 'navs' property of the ao/fsdata. | ao |
setReferenceTime | Sets the t0 to the new value but doesn't move the data in time | ao |
setT0 | Sets the 't0' property of the ao. | ao |
setToffset | Sets the 'toffset' property of the ao with tsdata | ao |
setX | Sets the 'x' property of the ao. | ao |
setXY | Sets the 'x' and 'y' properties of the ao. | ao |
setXaxisName | Sets the x-axis name of the ao. | ao |
setXunits | Sets the 'xunits' property of the ao. | ao |
setY | Sets the 'y' property of the ao. | ao |
setYaxisName | Sets the y-axis name of the ao. | ao |
setYunits | Sets the 'yunits' property of the ao. | ao |
setZ | Sets the 'z' property of the ao. | ao |
setZaxisName | Sets the z-axis name of the ao. | ao |
setZunits | Sets the 'zunits' property of the ao. | ao |
simplifyXunits | Simplify the 'xunits' of the ao. | ao |
simplifyYunits | Simplify the 'yunits' property of the ao. | ao |
simplifyZunits | Simplify the 'zunits' of the ao. | ao |
t0 | Get the data property 't0'. | ao |
timeshift | For AO/tsdata objects, shifts data in time by the specified value in seconds. | ao |
toffset | Get the data property 'toffset'. | ao |
validate | Checks that the input Analysis Object is reproducible and valid. | ao |
x | Get the data property 'x'. | ao |
xaxisname | Get the x axis name of the underlying data object. | ao |
xunits | Get the data property 'xunits'. | ao |
y | Get the data property 'y'. | ao |
yaxisname | Get the y axis name of the underlying data object. | ao |
yunits | Get the data property 'yunits'. | ao |
z | Get the data property 'z'. | ao |
zaxisname | Get the z axis name of the underlying data object. | ao |
zunits | Get the data property 'zunits'. | ao |
get | Get a property of a object. | ltpda_obj |
search | Select objects that match the given name. | ltpda_uo |
setDescription | Sets the 'description' property of a ltpda_uo object. | ltpda_uo |
setName | Sets the property 'name' of an ltpda_uoh object. | ltpda_uo |
created | Returns a time object of the last modification. | ltpda_uoh |
creator | Extract the creator(s) from the history. | ltpda_uoh |
csvexport | Exports the data of an object to a csv file. | ltpda_uoh |
index | Index into a 'ltpda_uoh' object array or matrix. This properly captures the history. | ltpda_uoh |
requirements | Returns a list of LTPDA extension requirements for a given object. | ltpda_uoh |
setPlotAxes | Sets the 'axes' property of a the object's plotinfo. | ltpda_uoh |
setPlotColor | Sets the color of a the object's plotinfo. | ltpda_uoh |
setPlotFigure | Sets the 'figure' property of a the object's plotinfo. | ltpda_uoh |
setPlotFillmarker | Defines if the plot function fill the marker or not. | ltpda_uoh |
setPlotLineStyle | Sets the linestyle of a the object's plotinfo. | ltpda_uoh |
setPlotLinewidth | Sets the linewidth of a the object's plotinfo. | ltpda_uoh |
setPlotMarker | Sets the marker of a the object's plotinfo. | ltpda_uoh |
setPlotMarkerEdgeColor | Sets the color of a the object's marker edge. | ltpda_uoh |
setPlotMarkerFaceColor | Sets the color of a the object's marker face. | ltpda_uoh |
setPlotMarkersize | Sets the markersize of a the object's plotinfo. | ltpda_uoh |
setPlotinfo | Sets the 'plotinfo' property of a ltpda_uoh object. | ltpda_uoh |
setPlottingStyle | Sets the style property of a the object's plotinfo. | ltpda_uoh |
setProcinfo | Sets the 'procinfo' property of a ltpda_uoh object. | ltpda_uoh |
setShowsErrors | Sets the 'showErrors' property of a the object's plotinfo. | ltpda_uoh |
Methods | Description | Defining Class |
---|---|---|
char | Overloads char() function for analysis objects. | ao |
generateConstructorPlist | Generates a PLIST from the properties which can rebuild the object. | ao |
md5 | Computes an MD5 checksum from an analysis objects. | ao |
plot | The analysis objects on the given axes. | ao |
isprop | Tests if the given field is one of the object properties. | ltpda_obj |
bsubmit | Submits the given collection of objects in binary form to an LTPDA repository | ltpda_uo |
submit | Submits the given collection of objects to an LTPDA repository | ltpda_uo |
update | Updates the given object in an LTPDA repository | ltpda_uo |
string | Writes a command string that can be used to recreate the input object(s). | ltpda_uoh |
type | Converts the input objects to MATLAB functions. | ltpda_uoh |
Methods | Description | Defining Class |
---|---|---|
abs | Overloads the Absolute value method for analysis objects. | ao |
all | Overloads the all operator for analysis objects. True if all elements | ao |
angle | Overloads the angle operator for analysis objects. | ao |
any | Overloads the any operator for analysis objects. True if any element | ao |
ao2numMatrices | Transforms AO objects to numerical matrices. | ao |
bilinfit | Is a linear fitting tool | ao |
cat | Concatenate AOs into a row vector. | ao |
complex | Overloads the complex operator for Analysis objects. | ao |
conj | Overloads the conjugate operator for analysis objects. | ao |
ctranspose | Overloads the ' operator for Analysis Objects. | ao |
cumsum | Overloads the cumsum operator for analysis objects. | ao |
det | Overloads the determinant function for analysis objects. | ao |
diag | Overloads the diagonal operator for analysis objects. | ao |
eig | Overloads the eigenvalues/eigenvectors function for analysis objects. | ao |
exp | Overloads the exp operator for analysis objects. Exponential. | ao |
hypot | Overloads robust computation of the square root of the sum of squares for AOs. | ao |
imag | Overloads the imaginary operator for analysis objects. | ao |
inv | Overloads the inverse function for analysis objects. | ao |
ln | Overloads the log operator for analysis objects. Natural logarithm. | ao |
log | Overloads the log operator for analysis objects. Natural logarithm. | ao |
log10 | Overloads the log10 operator for analysis objects. Common (base 10) logarithm. | ao |
max | Computes the maximum value of the data in the AO | ao |
mean | Computes the mean value of the data in the AO. | ao |
median | Computes the median value of the data in the AO. | ao |
min | Computes the minimum value of the data in the AO | ao |
mode | Computes the modal value of the data in the AO. | ao |
norm | Overloads the norm operator for analysis objects. | ao |
not | Overloads the logical not operator for analysis objects. | ao |
offset | Adds an offset to the data in the AO. | ao |
phase | Is the phase operator for analysis objects. | ao |
quasiSweptSine | Computes a transfer function from swept-sine measurements | ao |
real | Overloads the real operator for analysis objects. | ao |
rotate | Applies rotation factor to AOs | ao |
round | Overloads the Round method for analysis objects. | ao |
scale | Scales the data in the AO by the specified factor. | ao |
sign | Overloads the sign operator for analysis objects. | ao |
sort | The values in the AO. | ao |
spsdSubtraction | Makes a sPSD-weighted least-square iterative fit | ao |
sqrt | Computes the square root of the data in the AO. | ao |
std | Computes the standard deviation of the data in the AO. | ao |
sum | Computes the sum of the data in the AO. | ao |
sumjoin | Sums time-series signals togther | ao |
svd | Overloads the svd (singular value decomposition) function for analysis objects. | ao |
transpose | Overloads the .' operator for Analysis Objects. | ao |
uminus | Overloads the uminus operator for analysis objects. | ao |
unwrap | Overloads the unwrap operator for analysis objects. | ao |
var | Computes the variance of the data in the AO. | ao |
Methods | Description | Defining Class |
---|---|---|
display | Implement terminal display for analysis object. | ao |
export | Export the data of an analysis object to a text file. | ao |
gnuplot | A gnuplot interface for AOs. | ao |
iplot | Provides an intelligent plotting tool for LTPDA. | ao |
iplotyy | Provides an intelligent plotting tool for LTPDA. | ao |
summaryReport | Generates an HTML report about the input objects. | ao |
table | Display the data from the AO in a table. | ao |
save | Overloads save operator for ltpda objects. | ltpda_uo |
report | Generates an HTML report about the input objects. | ltpda_uoh |
viewHistory | Displays the history of an object as a dot-view or a MATLAB figure. | ltpda_uoh |
Methods | Description | Defining Class |
---|---|---|
isequal | Overloads the isequal operator for ltpda objects. | ltpda_obj |
Methods | Description | Defining Class |
---|---|---|
average | Averages aos point-by-point | ao |
bandpass | AOs containing time-series data. | ao |
bandreject | AOs containing time-series data. | ao |
bicohere | Computes the bicoherence of two input time-series | ao |
bin_data | Rebins aos data, on logarithmic scale, linear scale, or arbitrarly chosen. | ao |
buildWhitener1D | Builds a whitening filter based on the input frequency-series. | ao |
cdfplot | Makes cumulative distribution plot | ao |
cgfill | Fills specified gaps in the data given an inital guess for the spectrum. | ao |
cohere | Estimates the coherence between time-series objects | ao |
compute | Performs the given operations on the input AOs. | ao |
confint | Calculates confidence levels and variance for psd, lpsd, cohere, lcohere and curvefit parameters | ao |
consolidate | Resamples all input AOs onto the same time grid. | ao |
conv | Vector convolution. | ao |
corr | Estimate linear correlation coefficients. | ao |
cov | Estimate covariance of data streams. | ao |
cpsd | Estimates the cross-spectral density between time-series objects | ao |
crb | Computes the inverse of the Fisher Matrix | ao |
crbound | Computes the inverse of the Fisher Matrix | ao |
delay | Delays a time-series using various methods. | ao |
delayEstimate | Estimates the delay between two AOs | ao |
detectOutliers | Locates outliers in data. | ao |
detrend | Detrends the input analysis object using a polynomial of degree N. | ao |
dft | Computes the DFT of the input time-series at the requested frequencies. | ao |
diff | Differentiates the data in AO. | ao |
dispersionLoop | DipersionLoop computes the dispersion function in loop | ao |
downsample | Sample AOs containing time-series data down. | ao |
dropduplicates | Drops all duplicate samples in time-series AOs. | ao |
dsmean | Performs a simple downsampling by taking the mean of every N samples. | ao |
dtfe | Estimates transfer function between time-series objects. | ao |
ecdf | Calculate empirical cumulative distribution function | ao |
edgedetect | Detects edges in a binary pulse-train. | ao |
eqmotion | Solves numerically a given linear equation of motion | ao |
evaluateModel | Evaluate a curvefit model. | ao |
fft | Overloads the fft method for Analysis objects. | ao |
fftfilt | Overrides the fft filter function for analysis objects. | ao |
filtSubtract | Subtracts a frequency dependent noise contribution from an input ao. | ao |
filter | Overrides the filter function for analysis objects. | ao |
filtfilt | Overrides the filtfilt function for analysis objects. | ao |
firwhiten | Whitens the input time-series by building an FIR whitening filter. | ao |
fixfs | Resamples the input time-series to have a fixed sample rate. | ao |
fngen | Creates an arbitrarily long time-series based on the input PSD. | ao |
gapfilling | Fills possible gaps in data. | ao |
gapfillingoptim | Fills possible gaps in data. | ao |
getAbsTimeRange | Returns a timespan object which span the absolute time range of an AO | ao |
getKSCValPSD | Provides critical value for KStest on the PSD | ao |
getdof | Calculates degrees of freedom for psd, lpsd, cohere and lcohere | ao |
heterodyne | Heterodynes time-series. | ao |
highpass | Highpass AOs containing time-series data. | ao |
hist | Overloads the histogram function (hist) of MATLAB for Analysis Objects. | ao |
iacf | Computes the inverse auto-correlation function from a spectrum. | ao |
ifft | Overloads the ifft operator for Analysis objects. | ao |
integrate | Integrates the data in AO. | ao |
interp | Interpolate the values in the input AO(s) at new values. | ao |
interpmissing | Interpolate missing samples in a time-series. | ao |
intersect | Overloads the intersect operator for Analysis objects. | ao |
kstest | Perform KS test on input AOs | ao |
lcohere | Implement magnitude-squadred coherence estimation on a log frequency axis. | ao |
lcpsd | Implement cross-power-spectral density estimation on a log frequency axis. | ao |
linSubtract | Subtracts a linear contribution from an input ao. | ao |
lincom | Make a linear combination of analysis objects | ao |
linedetect | Find spectral lines in the ao/fsdata objects. | ao |
linfit | Is a linear fitting tool | ao |
linlsqsvd | Linear least squares with singular value decomposition | ao |
lisovfit | Uses LISO to fit a pole/zero model to the input frequency-series. | ao |
lowpass | Lowpass AOs containing time-series data. | ao |
lpsd | Implements the LPSD algorithm for analysis objects. | ao |
lscov | Is a wrapper for MATLAB's lscov function. | ao |
ltfe | Implements transfer function estimation computed on a log frequency axis. | ao |
map3D | Maps the input 1 or 2D AOs on to a 3D AO | ao |
mhsample | The Metropolis - Hastings algorithm | ao |
modelSelect | Method to compute the Bayes Factor using RJMCMC, LF, LM, BIC methods | ao |
mve | Minimum Volume Ellipsoid estimator | ao |
noisegen1D | Generates colored noise from white noise. | ao |
noisegen2D | Generates cross correleted colored noise from white noise. | ao |
normdist | Computes the equivalent normal distribution for the data. | ao |
nyquistplot | Fits a piecewise powerlaw to the given data. | ao |
overlap | This method cuts out the the overlapping data of the input AOs. | ao |
pad | Pads the input data series to a given value. | ao |
play | Plays a time-series using MATLAB's audioplay function. | ao |
polyfit | Overloads polyfit() function of MATLAB for Analysis Objects. | ao |
polyfitSpectrum | Does a polynomial fit to the log of the input spectrum. | ao |
polynomfit | Is a polynomial fitting tool | ao |
powerFit | Fits a piecewise powerlaw to the given data. | ao |
ppsd | Makes power spectral density estimates of the time-series objects in the input analysis objects by estimating ARMA models coefficients. | ao |
preprocessDataForMCMC | Split, resample and apply FFT to time series for MCMC analysis. | ao |
psd | Makes power spectral density estimates of the time-series objects | ao |
psdconf | Calculates confidence levels and variance for psd | ao |
psdvfit | Performs a fitting loop to identify model for a psd. | ao |
qqplot | Makes quantile-quantile plot | ao |
removeVal | Removes values from the input AO(s). | ao |
resample | Overloads resample function for AOs. | ao |
rjsample | Reverse Jump MCMC sampling using the "Metropolized Carlin And Chib" Method. | ao |
rms | Calculate RMS deviation from spectrum | ao |
sDomainFit | Performs a fitting loop to identify model order and | ao |
select | Select particular samples from the input AOs and return new AOs with only those samples. | ao |
simplex | Multidimensional unconstrained nonlinear minimization (Nelder-Mead) | ao |
sineParams | Estimates parameters of sinusoids | ao |
smoother | Smooths a given series of data points using the specified method. | ao |
spcorr | Calculate Spearman Rank-Order Correlation Coefficient | ao |
spectrogram | Computes a spectrogram of the given ao/tsdata. | ao |
spikecleaning | Detects and corrects possible spikes in analysis objects | ao |
split | Split an analysis object into the specified segments. | ao |
spsd | Implements the smoothed (binned) PSD algorithm for analysis objects. | ao |
subsData | Performs actions on ao objects. | ao |
svd_fit | Estimates parameters for a linear model using SVD | ao |
tdfit | Fit a set of smodels to a set of input and output signals.. | ao |
tfe | Estimates transfer function between time-series objects. | ao |
timeaverage | Averages time series intervals | ao |
toSI | Converts the units of the x, y and z axes into SI units. | ao |
union | Overloads the union operator for Analysis Objects. | ao |
upsample | Overloads upsample function for AOs. | ao |
validateSpectrumMod | Statistically validate a model for a psd. | ao |
whiten1D | Whitens the input time-series. | ao |
whiten2D | Whiten the noise for two cross correlated time series. | ao |
window | Applies the specified window to the input time-series objects | ao |
xcorr | Makes cross-correlation estimates of the time-series | ao |
xfit | Fit a function of x to data. | ao |
zDomainFit | Performs a fitting loop to identify model order and | ao |
zeropad | Zero pads the input data series. | ao |
Methods | Description | Defining Class |
---|---|---|
acos | Overloads the acos method for analysis objects. | ao |
asin | Overloads the asin method for analysis objects. | ao |
atan | Overloads the atan method for analysis objects. | ao |
atan2 | Overloads the atan2 operator for analysis objects. Four quadrant inverse tangent. | ao |
cos | Overloads the cos method for analysis objects. | ao |
sin | Overloads the sin method for analysis objects. | ao |
tan | Overloads the tan method for analysis objects. | ao |
![]() |
MCMC Class | collection Class | ![]() |
©LTP Team