Mathcad Mathematical Functions List

advertisement
Mathcad Mathematical Functions
Mathcad and the Mathcad Extension Packs give you access to hundreds of powerful mathematical functions that enable you to
solve your critical scientific and engineering calculations with ease.
Mathcad Functions
Function Name (Parameters)
acos (z)
Function Definition
Returns the angle (in radians) whose cosine is z. Principal value
acosh (z)
for complex z.
Returns the angle (in radians) whose hyperbolic cosine is z. The
acot (z)
result is the principal value for complex z.
Returns the angle (in radians) whose cotangent is z. The result is
between 0 and pi if z is real, and the principal value if z is
acoth (z)
complex.
Returns the angle (in radians) whose hyperbolic cotangent is z.
acsc (z)
The result is the principal value for complex z.
Returns the angle (in radians) whose cosecant is z. The result is
acsch (z)
the principal value for complex z.
Returns the angle (in radians) whose hyperbolic arccosecant is
Adams (y, x1, x2, npoints, D, [tol])
z. The result is the principal value for complex z.
Returns a matrix of solution values for the differential equation
specified by the derivatives in D, and having initial conditions y
on the interval [x1,x2], using Adams methods. Parameter npoints
controls the number of rows in the matrix output.
AdamsBDF (y, x1, x2, npoints, D, [J], [tol])
Returns a matrix of solution values for the differential equation
specified by the derivatives in D, and having initial conditions y
on the interval [x1,x2], using BDF methods for stiff systems and
Adams methods for non-stiff systems. Parameter npoints
controls the number of rows in the matrix output.
Ai (z)
Ai.sc (x)
Returns the value of the Airy function of the first kind.
Returns the value of the Airy function of the first kind, scaled by
angle (x, y)
the factor Re(exp(2/3*z^(3/2))).
Returns the angle (in radians) between the x-axis and the point
antisymmetric tensor (i, j, k)
(x, y). x and y must be real.
Returns the completely antisymmetric tensor of rank 3. Result is
0 if any two arguments are the same, 1 for even permutations, -1
APPENDPRN (file, [M])
for odd permutations..
Writes the contents of an array to the end of a delimited ASCII
arg (z)
file.
Returns the principal argument of the complex number z,
between -pi and pi, including pi.
asec (z)
Returns the angle (in radians) whose secant is z. The result is
asech (z)
the principal value for complex z.
Returns the angle (in radians) whose hyperbolic secant is z.
asin (z)
Result is the principal value for complex z.
Returns the angle (in radians) whose sine is z. Principal value for
asinh (z)
complex z.
Returns the angle (in radians) whose hyperbolic sine is z.
atan (z)
Principal value for complex z.
Returns the angle (in radians) whose tangent is z. Principal value
atan2 (x, y)
for complex z.
Returns the angle (in radians) from the x-axis to a line containing
the origin (0,0) and the point (x,y). Both x and y must be real.
atanh (z)
Returns the angle (in radians) whose hyperbolic tangent is z.
augment (A, B, C, ...)
BDF (y, x1, x2, npoints, D, [J], [tol])
Principal value for complex z.
Returns an array formed by placing A, B, C, ... left to right
Returns a matrix of solution values for the stiff differential
equation specified by the derivatives in D, and initial conditions y
on the interval [x1,x2], using backwards differentiation formula
methods. Parameter npoints controls the number of rows in the
bei (m, x)
matrix output.
Returns the value of the imaginary Bessel Kelvin function of
ber (m, x)
order m.
Returns the value of the real Bessel Kelvin function of order m.
Bi (x)
Bi.sc (x)
Returns the value of the Airy function of the second kind.
Returns the value of the Airy function of the second kind, scaled
bspline (vx, vy, u, n)
by the factor exp(-|Re(2/3*z^3/2)|).
Returns a vector of the coefficients of a B-spline of degree n for
the data in vx and vy, given the knot values in u. The vector
returned becomes the first argument of the interp function.
Bulstoer (y, x1, x2, npoints, D)
Returns a matrix of solution values for the smooth differential
equation specified by the derivatives in D using a Bulirsch-Stoer
bvalfit (v1, v2, x1, x2, xf, D, load1, load2, score)
method.
Returns a vector of initial conditions for the boundary value
problem specified by the derivatives in D where the solution is
ceil (z)
Ceil (z, y)
known at the intermediate point xf.
Returns the smallest integer greater than or equal to z.
Returns the smallest multiple of y greater than or equal to z,
cfft (A)
typically used for correct unit scaling.
Returns the Discrete Fourier transform of any size vector or
matrix of real or complex numbers. Returns an array of the same
CFFT (A)
size as its argument.
Returns the Discrete Fourier transform of any size vector or
matrix of real or complex numbers. Returns an array of the same
size as its argument. Similar to cfft(A), with a different
Chi (x)
normalizing factor and sign convention.
Returns the value of the hyperbolic cosine integral function. Can
only be evaluated symbolically.
cholesky (M)
Returns the lower triangular matrix L such that L times L
transpose is M. L is the cholesky square root of the input matrix.
Ci (x)
Returns the value of the cosine integral function. Can only be
cnorm (x)
evaluated symbolically.
Returns the cumulative probability distribution with mean 0 and
cnper (rate, pv, fv)
variance 1.
Returns the number of compounding periods for an investment to
cols (A)
combin (n, k)
yield a specified future value.
Returns the number of columns in A.
Returns the number of subsets (combinations) of k elements that
concat (S1, S2, S3, ...)
can be formed from n elements.
Returns the string formed by concatenating strings S1, S2, and
cond1 (M)
so on.
Returns the condition number of the matrix M based on the L1
cond2 (M)
norm.
Returns the condition number of the matrix M based on the L2
conde (M)
norm.
Returns the condition number of the matrix M based on the
condi (M)
Euclidean norm.
Returns the condition number of the matrix M based on the
corr (A, B)
infinity norm.
Returns the Pearson's r correlation coefficient of the elements in
correl (vx, vy)
A and B.
Returns the correlation of vectors vx and vy. Result is a vector
for which each element contains the summed vector product of
correl2d (M, K)
vx and a shifted version of vy.
Returns the 2D correlation of matrix M with kernel K. The
resulting matrix contains the summed element-wise product of K
cos (z)
cosh (z)
cot (z)
coth (z)
crate (nper, pv, fv)
overlapped with a subset of M.
Returns the cosine of z.
Returns the hyperbolic cosine of z.
Returns the cotangent of z.
Returns the hyperbolic cotangent of z.
Returns the fixed interest rate per period required for an
investment at present value to yield a specified future value over
CreateMesh (function(s), [s0, s1, t0, t1], [sgrid, tgrid], [fmap])
a number of compounding periods.
Returns a nested array of three matrices representing the x-, y-,
and z-coordinates of a parametric surface defined by the
CreateSpace (function(s), [t0, t1], [tgrid], [fmap])
function(s) of two variables in the first argument(s).
Returns a nested array of three vectors representing the x-, y-,
and z-coordinates of a space curve defined by the function(s) of
csc (z)
csch (z)
csgn (z)
one variable in the first argument.
Returns the cosecant of z.
Returns the hyperbolic cosecant of z.
Returns the complex sign of z, given by 0 if z = 0, 1 if the real or
csort (A, n)
imaginary part of z is > 0, and -1 otherwise.
Returns an array formed by rearranging rows of A until column n
is in ascending order.
cspline (vx, vy)
Returns a vector of cubic spline coefficients with cubic endpoints
which fits the independent data in vector or matrix vx and
dependent data in vy. This vector becomes the first argument of
cumint (rate, nper, pv, start, end, [type])
the interp function.
Returns the cumulative interest paid on a loan between a starting
period and an ending period given a fixed interest rate, the total
number of compounding periods, and the present value of the
cumprn (rate, nper, pv, start, end, [type])
loan.
Returns the cumulative principal paid on a loan between a
starting period and an ending period given a fixed interest rate,
the total number of compounding periods, and the present value
cvar (A, B)
cyl2xyz (r, q, f)
of the loan.
Returns the covariance of the elements in A and B.
Converts the cylindrical coordinates of a point in 3D space to
DAi (z)
rectangular coordinates.
Returns the value of the first derivative of the Airy function of the
DAi.sc (x)
first kind.
Returns the value of the first derivative of the Airy function of the
dbeta (x, s1, s2)
first kind, scaled by the factor Re(exp(2/3*z^(3/2))).
Returns the probability density for the beta distribution with
DBi (z)
shape parameters s1 and s2.
Returns the value of the first derivative of the Airy function of the
DBi.sc (x)
second kind.
Returns the value of the first derivative of the Airy function of the
second kind, scaled by the factor exp(-|Re(2/3*z^3/2)|).
dbinom (k, n, q)
dcauchy (x, l, s)
Returns the probability density for the Binomial distribution.
Returns the probability density for the Cauchy distribution with
dchisq (x, d)
location l and scale s.
Returns the probability density for the chi-squared distribution
denom (x)
with degrees of freedom d.
Returns the denominator of the fraction or rational expression x.
dexp (x, r)
Can only be evaluated symbolically.
Returns the probability density for the exponential distribution
dF (x, d1, d2)
with rate of decay r.
Returns the probability density for the F distribution with degrees
dgamma (x, s)
of freedom d1 and d2.
Returns the probability density for the gamma distribution with
dgeom (k, p)
shape parameter s.
Returns the probability density for the Geometric distribtuion,
dhypergeom (m, a, b, n)
with probability of success p.
Returns the probability density for the hypergeometric
diag (v)
distribution.
Returns a matrix containing on its diagonal the elements of v.
dilog (x)
Returns the value of the dilogarithm function. Can only be
dlnorm (x, mu, sigma)
evaluated symbolically.
Returns the probability density for the lognormal distribution with
dlogis (x, l, s)
logmean mu and logdeviation sigma.
Returns the probability density for the logistic distribution with
location l and scale s.
DMS (x)
Returns the angle in radians given a vector containing degrees,
minutes, and seconds; or returns the vector given the angle
dnbinom (k, n, p)
when used in the units placeholder.
Returns the probability density for the negative binomial
dnorm (x, mu, sigma)
distribution with size n and probability of failure p.
Returns the probability density for the normal distribution with
dpois (k, l)
mean mu and standard deviation sigma.
Returns the probability density for the Poisson distribution in
dt (x, d)
which mean l.
Returns the probability density for Student's t distribution with
dunif (x, a, b)
degrees of freedom d.
Returns the probability density for the uniform distribution on an
dweibull (x, s)
interval [a,b].
Returns the probability density for the Weibull distribution with
eff (rate, npery)
shape parameter s.
Returns the effective annual interest rate (APR), given the
nominal interest rate and the number of compounding periods
Ei (x)
eigenvals (M)
eigenvec (M, z)
per year.
Returns the value of the exponential integral function.
Returns a vector of eigenvalues for the square matrix M.
Returns the normalized eigenvector associated with eigenvalue z
of the square matrix M. The eigenvector is normalized to unit
eigenvecs (M)
length.
Returns a matrix containing the normalized eigenvectors
corresponding to the eigenvalues of the square matrix M. The
nth column of the matrix returned is an eigenvector
corresponding to the nth eigenvalue returned by eigenvals.
erf (z)
erfc (x)
error (S)
exp (z)
expfit (vx, vy, [vg])
Optional last argument "L" specifies the left eigenvalue.
Returns the error function.
Returns the complementary error function.
Returns the string S as a Mathcad error tip.
Returns the number e raised to the power z.
Returns a vector containing three coefficients for an exponential
curve of the form a*e^(b*x)+c that best approximates the data in
vectors vx and vy. The optional vector vg contains guess values
fft (v)
for the three coefficients.
Returns the fast Fourier transform of real data vector v with 2^n
elements. Returns a vector of size 2^n-1 + 1. Similar to FFT(v),
except uses a different normalizing factor and sign convention.
FFT (v)
Returns the fast Fourier transform of real data vector v with 2^n
elements. Returns a vector of size 2^n-1 + 1. Similar to fft(v),
except uses a different normalizing factor and sign convention.
fhyper (a, b, c, x)
Returns the value of the Gauss hypergeometric function at the
FIF (x)
point x given parameters a, b, c.
Returns a length given a string representing feet-inchesfractions; or returns the FIF string given a length when used in
the units placeholder.
Find (var1, var2, ...)
Returns the values of var1, var2, ..., that solve a system of
equations in a Solve Block. Returns a scalar if there is only one
floor (z)
Floor (z, y)
argument, otherwise returns a vector of answers.
Returns the greatest integer less than or equal to z.
Returns the greatest multiple of y less than or equal to z, typically
format (S, x, y, z, ...)
used for correct unit scaling.
Returns a string containing the value of the arguments x, y, z, ...
with print order and surrounding text specified by S. S is optional
FresnelC (x)
FresnelS (x)
fv (rate, nper, pmt, [[pv], [type]])
if only one value is printed.
Returns the value of the Fresnel cosine integral function.
Returns the value of the Fresnel sine integral function.
Returns the future value of an investment or loan given a
fvadj (prin, v)
periodic, constant payment and a fixed interest rate.
Returns the future value of an initial principal after applying the
fvc (rate, v)
series of compound interest rates in vector v.
Returns the future value of a vector of cash flows, v, earning a
Gamma ([a], z)
specified interest rate.
Returns either Euler's gamma function of z, or the incomplete
gamma function of z with degree a. To type G, press G+[Ctrl]+G.
gcd (A, B, C, ...)
Returns the greatest common divisor: the largest integer that
genfit (vx, vy, vg, F)
evenly divides all the elements of A, B, C, ...
Returns a vector of parameters that make the first function in the
vector F best fit the data in the vectors vx and vy. The remaining
elements in F are partial derivatives of the fitting function with
respect to its n parameters, and vg is a vector of guess values.
Right-click on this function to choose a solver.
geninv (A)
Returns the generalized (pseudo) inverse of the input matrix A,
giving the least-squares solution to a system of equations..
genvals (M, N)
Returns a vector of eigenvalues which satisfy the generalized
genvecs (M, N)
eigenvalue problem.
Returns a matrix of normalized eigenvectors corresponding to
the eigenvalues returned by genvals. Optional last argument "L"
GETWAVINFO (file)
specifies the left eigenvalue.
Returns a vector containing, in order, the number of channels,
the sample rate, the bit resolution, and the average bytes per
gmean (A, B, C, ...)
H1 (m, z)
second for a WAV file.
Returns the geometric mean of the elements of A, B, C, ...
Returns the Hankel function of the first kind (Bessel function of
H1.sc (m, z)
the third kind).
Returns the Hankel function of the first kind (Bessel function of
H2 (m, z)
the third kind), scaled by the factor exp(-z*i).
Returns the Hankel function of the second kind (Bessel function
H2.sc (m, z)
of the third kind).
Returns the Hankel function of the second kind (Bessel function
heaviside step (x)
of the third kind), scaled by the factor exp(z*i).
Returns the heaviside step function with value 1 if x is greater
than or equal to 0, 0 otherwise. To type Phi, press F+[Ctrl]+G.
Her (n, x)
Returns the value of the Hermite polynomial of degree n at x.
hhmmss (x)
Returns a time given a string containing hours:minutes:seconds;
or returns the string given a time when used in the units
hist (intvls, data)
placeholder.
Returns a vector representing the frequencies with which values
in data fall into the intervals represented by intvls. intvls can be a
vector of interval endpoints, or an integer number of subintervals
histogram (intvls, data)
of equal length.
Returns a two-column matrix containing the midpoints of the
intvls subintervals. The second column is identical to the vector
hlookup (z, A, r)
returned by hist. The resulting matrix has intvls rows.
Looks in the first row of a matrix, A, for a given value, z, and
returns the value(s) in the same column(s) in the row specified, r.
When multiple values are returned, they appear in a vector.
hmean (A, B, C, ...)
I0 (z)
Returns the harmonic mean of the elements of A, B, C, ...
Returns the zeroth order modified Bessel function of the first
I0.sc (z)
kind.
Returns the zeroth order modified Bessel function of the first
I1 (z)
kind, scaled by the factor exp(-|Re(z)|).
Returns the first order modified Bessel function of the first kind.
I1.sc (z)
Returns the first order modified Bessel function of the first kind,
ibeta (a, x, y)
scaled by the factor exp(-|Re(z)|).
Returns the value of the incomplete beta function of x and y with
icfft (A)
parameter a.
Returns the inverse Fourier transform corresponding to cfft.
ICFFT (A)
Returns an array of the same size as its argument.
Returns the inverse Fourier transform corresponding to CFFT.
identity (n)
Returns an array of the same size as its argument.
Returns an n x n identity matrix (a matrix of 0's with 1's along the
if (cond, x, y)
diagonal).
Returns x if logical condition cond is true (non-zero), y otherwise.
ifft (u)
Returns the inverse Fourier transform corresponding to fft. Takes
a vector of size 1 + 2^n-1, where n is an integer. Returns a real
IFFT (u)
vector of size 2^n.
Returns the inverse Fourier transform corresponding to FFT.
Takes a vector of size 1 + 2^n-1, where n is an integer. Returns
Im (z)
a real vector of size 2^n.
Returns the imaginary part of complex number, vector, or matrix,
In (m, z)
z.
Returns the mth order modified Bessel function of the first kind.
In.sc (m, z)
Returns the mth order modified Bessel function of the first kind,
intercept (vx, vy)
scaled by the factor exp(-|Re(z)|).
Returns the intercept of line that best fits data in vx and vy.
interp (vs, vx, vy, x)
Returns an interpolated value at x from the coefficients in vector
vs, and the original data in vx and vy. Coefficient vector vs is the
output of one of the following: cspline, lspline, pspline, bspline,
ipmt (rate, per, nper, pv, [[fv], [type]])
loess, or regress.
Returns the interest payment of an investment or loan for a given
period based on periodic, constant payments over a given
number of compounding periods using a fixed interest rate and a
irr (v, [guess])
specified present value.
Returns the internal rate of return for a series of cash flows
IsArray (x)
IsNaN (x)
IsPrime (n)
occurring at regular intervals.
Returns 1 if x is a matrix or vector. Returns 0 otherwise.
Returns 1 if x is NaN. Returns 0 otherwise.
Returns 1 if n is prime and 0 otherwise. Can only be evaluated
IsScalar (x)
symbolically.
Returns 1 if x is a real or complex scalar. Returns 0 otherwise.
IsString (x)
iwave (v)
Returns 1 if x is a string. Returns 0 otherwise.
Returns the inverse one-dimensional discrete wavelet transform
of v computed using the Daubechies 4-coefficient wavelet filter in
J0 (z)
J0.sc (z)
the wave function.
Returns the zeroth order Bessel function of the first kind.
Returns the zeroth order Bessel function of the first kind, scaled
J1 (z)
J1.sc (z)
by exp(-|Im(z)|).
Returns the first order Bessel function of the first kind.
Returns the first order Bessel function of the first kind, scaled by
Jac (n, a, b, x)
exp(-|Im(z)|).
Returns the value of the Jacobi polynomial of degree n at x with
Jacob (F(x),x,[k])
Jn (m, z)
Jn.sc (m, z)
parameters a and b.
Returns the Jacobian matrix of the vector function F(x).
Returns the mth order Bessel function of the first kind.
Returns the mth order Bessel function of the first kind, scaled by
js (m, z)
exp(-|Im(z)|).
Returns the value of the spherical Bessel function of the first
K0 (z)
kind, of order m.
Returns the zeroth order modified Bessel function of the second
K0.sc (z)
kind.
Returns the zeroth order modified Bessel function of the second
K1 (z)
kind, scaled by the factor exp(z).
Returns the first order modified Bessel function of the second
K1.sc (z)
kind.
Returns the first order modified Bessel function of the second
Kn (m, z)
kind, scaled by the factor exp(z).
Returns the mth order modified Bessel function of the second
Kn.sc (m, z)
kind.
Returns the mth order modified Bessel function of the second
Kronecker delta (x, y)
kind, scaled by the factor exp(z).
Returns the Kronecker delta function with value 1 if x = y, 0
ksmooth (vx, vy, b)
otherwise. To type Delta, press d+[Ctrl]+G.
Returns a vector of local weighted averages of vy using a
kurt (A, B, C, ...)
Gaussian kernel with bandwidth b.
Returns the kurtosis of the elements of A, B, C, ...
Lag (n, x)
Returns the value of the Laguerre polynomial of degree n at x.
LambertW ([n],x)
Lambert(x) returns the value of the Lambert W function.
Lambert(n,x) returns the value of the nth branch of the Lambert
last (v)
lcm (A, B, C, ...)
W function.
Returns the scalar index of the last element in vector v.
Returns the least common multiple: the smallest positive integer
Leg (n, x)
that is a multiple of all the elements of A, B, C, ...
Returns the value of the Legendre polynomial of degree n at x.
length (v)
lgsfit (vx, vy, vg)
Returns the integer number of elements in vector v.
Returns a vector containing the 3 coefficients for a logistic curve
of the form a/(1+b*e^(-c*x)) that best approximates the data in
line (vx, vy)
vectors vx and vy, using guess values in vg.
Returns a vector containing the coefficients for a line of the form
a + bx that best approximates the data in vectors vx and vy.
linfit (vx, vy, F)
Returns a vector containing the coefficients used to create a
linear combination of the functions in vector F which best
linterp (vx, vy, x)
approximates the data in vx and vy.
Returns a linearly interpolated value at x for data vectors vx and
ln (z)
vy of the same size.
Returns the natural logarithm (base e) of z. Returns principal
ln0 (z)
value (imaginary part between pi and -pi) for complex z.
Returns the natural logarithm (base e) of z but allows z = 0.
Returns principal value (imaginary part between pi and -pi) for
lnfit (vx, vy)
complex z.
Returns a vector containing the 2 coefficients for a logarithmic
curve of the form a*ln(x) + b that best approximates the data in
lnGamma (z)
vx and vy.
Returns the natural logarithm of Euler's gamma function,
LoadColormap (file)
evaluated at z. To type G, press G[Ctrl]G.
Returns an array containing the values in the colormap named
loess (vx, vy, span)
file.
Returns a vector used by the interp function to find a set of
second order polynomials that best fit a neighborhood of data
values in vectors or matrices vx and vy. The size of the
log (z, [b])
neighborhood is controlled by span.
Returns the base b logarithm of z. If b is omitted, returns the
logfit (vx, vy, vg)
base 10 logarithm.
Returns a vector containing the three coefficients for a
logarithmic curve of the form a*ln(x+b)+c that best approximates
the data in vectors vx and vy. Vector vg contains guess values
logpts (minexp, dec, dnpts)
for the three coefficients.
Returns a vector with dec decades of evenly-spaced points
starting at 10 raised to the exponent minexp, with dnpts points
logspace (min, max, npts)
per decade.
Returns a vector of npts logarithmically-spaced points starting at
min, ending at max.
lookup (z, A, B)
Looks in a vector or matrix, A, for a given value, z, and returns
the value(s) in the same position(s) (i.e., with the same row and
column numbers) in another matrix, B. When multiple values are
lsolve (M, v)
returned, they appear in a vector.
Returns the vector x solving the linear system of equations M*x =
lspline (vx, vy)
v.
Returns a vector of cubic spline coefficients with linear endpoints
which fits the independent data in vector or matrix vx and
dependent data in vy. This vector becomes the first argument of
lu (M)
the interp function.
Returns a matrix containing three augmented square matrices P,
L, and U, all having the same size as M; these satisfy the
match (z, A)
equation P M = L U.
Looks in a vector or matrix, A, for a given value, z, and returns
matrix (m, n, f)
the index (indices) of its positions in A.
Returns a m x n matrix in which the ijth element is given by f(i,j).
max (A, B, C, ...)
Returns the largest value from A, B, C, ... If any value is
complex, returns max(Re(A, B, C, ...)) + i*max(Im(A, B, C, ...)).
Maximize (f, var1, var2, ...)
Returns the values of var1, var2, ..., that satisfy the constraints in
a Solve Block, and make the function f take on its greatest value.
Returns a scalar if there is only one argument, otherwise returns
mean (A, B, C, ...)
a vector of answers.
Returns the arithmetic mean, or average, of the elements of A, B,
medfit (vx, vy)
C, ...
Returns a vector containing the coefficients for a line of the form
a + bx that best approximates the data in vectors vx and vy using
median (A, B, C, ...)
medsmooth (vy, n)
median-median regression.
Returns the median of the elements of A, B, C ...
Returns a smoothed vector by replacing each value in vy with the
mhyper (a, b, x)
median of the n points centered on that value.
Returns the value of the confluent hypergeometric function,
min (A, B, C, ...)
M(a,b,x), at the point x with parameters a and b.
Returns the smallest value in A, B, C, ... If any value is complex,
returns min(Re(A, B, C, ...)) + i*min(Im(A, B, C, ...)).
Minerr (var1, var2, ...)
Returns the values of var1, var2, ..., coming closest to satisfying
a system of equations and constraints in a Solve Block. Returns
a scalar if only one argument, otherwise returns a vector of
answers. If Minerr cannot converge, it returns the results of the
Minimize (f, var1, var2, ...)
last iteration.
Returns the values of var1, var2, ..., that satisfy the constraints in
a Solve Block, and make the function f take on its smallest value.
Returns a scalar if there is only one variable, otherwise returns a
mirr (v, fin_rate, rein_rate)
vector of answers.
Returns the modified internal rate of return for a vector v of cash
mod (x, y)
flows given a finance rate and a reinvestment rate.
Returns the remainder on dividing x by y (x modulo y). Result
mode (A, B, C, ...)
has the same sign as x.
Returns the value in A, B, C, ... that occurs most often.
multigrid (M, ncycle)
Returns a square matrix of solution values for Poisson's partial
differential equation, controlled by ncycle, in the case of zero
nom (APR, npery)
boundaries. Otherwise, use the relax function.
Returns the nominal interest rate, given the effective annual
interest rate (APR) and the number of compounding periods per
norm1 (M)
norm2 (M)
norme (M)
normi (M)
nper (rate, pmt, pv, [[fv], [type]])
year.
Returns the L1 norm of the matrix M.
Returns the L2 norm of the matrix M.
Returns the Euclidean norm of the matrix M.
Returns the infinity norm of the matrix M.
Returns the number of compounding periods for an investment
or loan based on periodic, constant payments using a fixed
npv (rate, v)
interest rate and a specified present value.
Returns the net present value of an investment given a discount
rate and a series of cash flows occuring at regular intervals.
num2str (z)
numer (x)
Returns the number z to a string.
Returns the numerator of the fraction or rational expression x.
numol (x_endpts, xpts, t_endpts, tpts, num_pde, num_pae,
Can only be evaluated symbolically.
Returns an xpts by tpts matrix containing the solutions to the one-
pde_func, pinit, bc_func)
dimensional PDEs in pde_func. Each column represents a
solution over 1-D space at a single solution time. For a system of
equations, the solution for each function is appended
horizontally, so the matrix always has xpts rows, and tpts *
Odesolve ([vf], x, b, [step])
(num pde + num pae) columns.
Returns a function or vector of functions of x representing the
solution to a system of ordinary differential equations in a Solve
pause (S, x, y, z, ...)
Block. vf is omitted when solving a single ODE.
Returns a string containing the value of the arguments x, y, z, ...
with print order and surrounding text specified by S. Prints values
in the Trace Window and pauses execution when debug mode is
on. S is optional if only one value is printed.
pbeta (x, s1, s2)
Returns the cumulative probability beta distribution with shape
pbinom (k, n, q)
parameters s1 and s2.
Returns the cumulative probability binomial distribution for k
successes in n trials, given a probability of success, q, per trial.
pcauchy (x, l, s)
Returns the cumulative probability Cauchy distribution with
pchisq (x, d)
location l and scale s.
Returns the cumulative probability chi-squared distribution with
Pdesolve (u, x, xrange, t, trange, [xpts], [tpts])
degrees of freedom d.
Returns a vector u of functions of x and t representing the
solution to a system of partial differential equations in a Solve
permut (n, k)
Block over the ranges specified in xrange and trange.
Returns the number of ways of ordering n distinct objects taken k
pexp (x, r)
at a time (permutations).
Returns the cumulative exponential probability distribution with
pF (x, d1, d2)
rate r.
Returns the cumulative F probability distribution with degrees of
freedom d1 and d2.
pgamma (x, s)
Returns the cumulative gamma probability distribution with shape
pgeom (k, p)
parameter s.
Returns the cumulative geometric probability distribution with
phypergeom (m, a, b, n)
probability of success p.
Returns the cumulative hypergeometric probability distribution.
plnorm (x, mu, sigma)
Returns the cumulative lognormal probability distribution with
plogis (x, l, s)
logmean mu and logdeviation sigma.
Returns the cumulative logistic probability distribution with
pmt (rate, nper, pv, [[fv], [type]])
location l and scale s.
Returns the payment for an investment or loan based on
periodic, constant payments over a given number of
compounding periods using a fixed interest rate and a specified
pnbinom (k, n, p)
present value.
Returns the cumulative negative binomial probability distribution
pnorm (x, mu, sigma)
with size n and probability of failure p.
Returns the cumulative normal probability distribution with mean
pol2xy (r, theta)
mu and standard deviation sigma.
Converts the polar coordinates of a point in 2D space to
Polyhedron (S)
rectangular coordinates.
Generates the uniform polyhedron whose name, number code,
PolyLookup (n)
or Wythoff symbol is string S.
Returns a vector containing the name, the dual name, and the
Wythoff symbol for the polyhedron whose number code is n.
polyroots (v)
Returns a vector containing all the roots of the polynomial whose
coefficients are in v. Right-click on this function to choose a
ppmt (rate, per, nper, pv, [[fv], [type]])
solver.
Returns the payment on the principal of an investment or loan for
a given period based on periodic, constant payments over a
given number of compounding periods using a fixed interest rate
ppois (k, l)
and a specified present value.
Returns the cumulative Poisson probability distribution in which l
predict (v, m, n)
> 0.
Returns a vector of n predicted values past the last element in v,
based on autocorrelation coefficients of m consecutive values in
Psi ([n],x)
a sliding window.
Psi(x) returns the digamma function of x. Psi(n,x) returns the
polygamma function of x. Can only be evaluated symbolically.
pspline (vx, vy)
Returns a vector of cubic spline coefficients with parabolic
endpoints that fits the independent data in vector or matrix vx
and dependent data in vy. This vector becomes the first
pt (x, d)
argument of the interp function.
Returns the cumulative probability Student's t distribution with
punif (x, a, b)
degrees of freedom d.
Returns the cumulative uniform probability distribution on the
interval [a,b].
pv (rate, nper, pmt, [[fv], [type]])
Returns the present value of an investment or loan based on
periodic, constant payments over a given number of
compounding periods using a fixed interest rate and a specified
pweibull (x, s)
payment.
Returns the cumulative Weibull probability distribution with shape
pwrfit (vx, vy, vg)
parameter s.
Returns a vector containing the coefficients for a power curve of
the form a*x^b + c that best approximates the data in vectors vx
and vy. Vector vg contains guess values for the three
qbeta (p, s1, s2)
coefficients.
Returns the inverse cumulative beta distribution with shape
qbinom (p, n, q)
parameters s1 and s2.
Returns the inverse cumulative binomial distribution with size n
qcauchy (p, l, s)
and probability of success q.
Returns the inverse cumulative Cauchy distribution with location l
qchisq (p, d)
and scale s.
Returns the inverse cumulative chi-squared distribution with
qexp (p, r)
degrees of freedom d.
Returns the inverse cumulative exponential distribution with rate
qF (p, d1, d2)
r.
Returns the inverse cumulative F distribution with degrees of
qgamma (p, s)
freedom d1 and d2.
Returns the inverse cumulative gamma distribution with shape
qgeom (p, q)
parameter s.
Returns the inverse cumulative geometric distribution with
qhypergeom (p, a, b, n)
probability of success q.
Returns the inverse cumulative probability distribution for the
hypergeometric distribution. p is a real number between 0 and 1.
qlnorm (p, mu, sigma)
a, b, and n are integers.
Returns the inverse cumulative lognormal distribution with
qlogis (p, l, s)
logmean mu and logdeviation sigma.
Returns the inverse cumulative logistic distribution with location l
qnbinom (p, n, q)
and scale s.
Returns the inverse cumulative negative binomial distribution
qnorm (p, mu, sigma)
with size n and probability of failure q.
Returns the inverse cumulative normal distribution with mean mu
qpois (p, l)
and standard deviation sigma.
Returns the inverse cumulative Poisson distribution with l > 0.
qr (A)
Returns a matrix whose first n columns contain the square,
orthonormal matrix, Q, and whose remaining columns contain
the upper triangular matrix, R, forming the QR decomposition of
qt (p, d)
the input matrix Q*R = A.
Returns the inverse cumulative Student's t distribution with
qunif (p, a, b)
degrees of freedom d.
Returns the inverse cumulative uniform distribution on the
qweibull (p, s)
interval [a,b].
Returns the inverse cumulative Weibull distribution with shape
parameter s.
Radau (y, x1, x2, npoints, D, [J], [M], [tol])
Returns a matrix of solution values for the stiff differential
equation specified by the derivatives in D, and initial conditions y
on the interval [x1,x2], using a RADAU5 method. Parameter
npoints controls the number of rows in the matrix output.
rank (A)
Returns the rank of matrix A, the number of linearly independent
rate (nper, pmt, pv, [[fv], [type], [guess]])
columns.
Returns the interest rate per period of an investment or loan over
a specified number of compounding periods given a periodic,
rbeta (m, s1, s2)
constant payment and a specified present value.
Returns a vector of m random numbers having the beta
rbinom (m, n, q)
distribution with shape parameters s1 and s2.
Returns a vector of m random numbers having the binomial
rcauchy (m, l, s)
distribution with size n and probability of success q.
Returns a vector of m random numbers having the Cauchy
rchisq (m, d)
distribution with location l and scale s.
Returns a vector of m random numbers having the chi-squared
Re (z)
READ_BLUE (file)
distribution with degrees of freedom d.
Returns the real part of complex number z.
Returns a matrix representing the RGB blue component of the
READ_GREEN (file)
BMP, GIF, JPG, or TGA color image in file.
Returns a matrix representing the RGB green component of the
READ_HLS (file)
BMP, GIF, JPG, or TGA color image in file.
Returns a packed matrix of hue, lightness, and saturation
components based on the Ostwald color model for the BMP,
GIF, JPG, or TGA color image in file. The returned matrix
READ_HLS_HUE (file)
contains the H, L, and S matrices packed side by side.
Returns a matrix representing the HLS hues based on the
Ostwald color model for the BMP, GIF, JPG, or TGA color image
READ_HLS_LIGHT (file)
in file.
Returns a matrix representing the HLS lightness components
based on the Ostwald color model for the BMP, GIF, JPG, or
READ_HLS_SAT (file)
TGA color image in file.
Returns a matrix representing the HLS saturation components
based on the Ostwald color model for the BMP, GIF, JPG, or
READ_HSV (file)
TGA color image in file.
Returns a packed matrix of hue, saturation, and value
components based on Smith's HSV color model for the BMP,
GIF, JPG, or TGA color image in file. The returned matrix
contains the H, S, and V matrices packed side by side.
READ_HSV_HUE (file)
Returns a matrix representing the HSV hues based on Smith's
HSV color model for the BMP, GIF, JPG, or TGA color image in
READ_HSV_SAT (file)
file.
Returns a matrix representing the HSV saturation components
based on Smith's HSV color model for the BMP, GIF, JPG, or
READ_HSV_VALUE (file)
TGA color image in file.
Returns a matrix representing the HSV value components based
on Smith's HSV color model for the BMP, GIF, JPG, or TGA
color image in file.
READ_IMAGE (file)
Returns a matrix containing a grayscale representation of the
READ_RED (file)
BMP, GIF, JPG, or TGA image in file.
Returns a matrix representing the RGB red component of the
READBIN (file, type, [[endian], [cols], [skip], [maxrows]])
BMP, GIF, JPG, or TGA image in file.
Returns a matrix from a single-format binary data file of specified
READBMP (file)
type.
Returns an array of integers between 0 (black) and 255 (white)
READFILE (file, type, [[colwidths], [rows], [cols], [emptyfill]])
representing the grayscale BMP image in file.
Returns a matrix from the contents of a file of specified type
READPRN (file)
(delimited, fixed-width, or Excel).
Returns a matrix formed from a structured data file on your file
READRGB (file)
system.
Returns a packed matrix of red, green, and blue components for
the BMP color image in file. The returned matrix contains the R,
READWAV (file)
G, and B matrices packed side by side.
Creates a matrix containing signal amplitudes in file. Each
column represents a separate channel of data. Each row
regress (vx, vy, n)
corresponds to a moment in time.
Returns a vector of coefficients for the multivariate nth degree
least-squares polynomial fit of the data in vx and vy. This vector
becomes the first argument of the interp function.
relax (A, B, C, D, E, F, U, rjac)
Returns a square matrix of solution values for Poisson's equation
for source function F. Matrices A, B, C, D, and E specify
coefficients for linearly approximating the Laplacian operator.
Matrix U gives boundary values along the edges. If these are
reverse (A)
zero, use multigrid.
Reverses the order of elements in a vector, or of rows in a matrix
rexp (m, r)
A.
Returns a vector of m random numbers having the exponential
rF (m, d1, d2)
distribution with rate r.
Returns a vector of m random numbers having the F distribution
rgamma (m, s)
with degrees of freedom d1 and d2.
Returns a vector of m random numbers having the gamma
rgeom (m, q)
distribution with shape parameter s.
Returns a vector of m random numbers having the geometric
rhypergeom (m, a, b, n)
distribution with probability of success q.
Returns a vector of m random numbers having the
Rkadapt (y, x1, x2, npoints, D)
hypergeometric distribution.
Returns a matrix of solution values for the differential equation
specified by the derivatives in D, and having initial conditions y
on the interval [x1,x2], using an adaptive step Runge-Kutta
method. Parameter npoints controls the number of rows in the
rkfixed (y, x1, x2, npoints, D)
matrix output.
Returns a matrix of solution values for the differential equation
specified by the derivatives in D and having initial conditions y on
the interval [x1,x2] using a fixed step Runge-Kutta method.
Parameter npoints controls the number of rows in the matrix
rlnorm (m, mu, sigma)
output.
Returns a vector of m random numbers having the lognormal
distribution with logmean mu and logdeviation sigma.
rlogis (m, l, s)
Returns a vector of m random numbers having the logistic
rnbinom (m, n, p)
distribution with location l and scale s.
Returns a vector of m random numbers having the negative
rnd (x)
binomial distribution with size n and probability of failure p.
Returns a uniformly distributed random number between 0 and x.
rnorm (m, mu, sigma)
Returns a vector of m random numbers having the normal
root (f(var), var, [a, b])
distribution with mean mu and standard deviation sigma.
Returns the value of var to make the function f equal to zero. If a
and b are specified, root finds var on this interval. Otherwise, var
must be defined with a guess value before root is called.
round (z, n)
Rounds z to n places. If n is omitted, z is rounded to the nearest
integer. If n < 0, z is rounded to the left of the decimal point.
Round (z, y)
Rounds z to the closest multiple of y, typically used for correct
rows (A)
rpois (m, l)
unit scaling.
Returns the number of rows in A.
Returns a vector of m random numbers having the Poisson
rref (A)
distribution with l > 0.
Returns a matrix representing the row-reduced echelon form of
rsort (A, n)
A.
Returns an array formed by rearranging columns of A until row n
rt (m, d)
is in ascending order.
Returns a vector of m random numbers having Student's t
runif (m, a, b)
distribution with d degrees of freedom.
Returns a vector of m random numbers having the uniform
rweibull (m, s)
distribution on interval [a,b].
Returns a vector of m random numbers having the Weibull
SaveColormap (file, M)
distribution with shape parameter s.
Creates a colormap named file containing the values in the
sbval (v, x1, x2, D, load, score)
matrix M. Returns the number of rows written to the file.
Returns a set of initial conditions for the boundary value problem
specified by the derivatives in D and guess values in v on the
interval [x1,x2]. Parameter load contains both known initial
conditions and guess values from v, and score measures
search (S1, SubS, m)
solution discrepancy at x2.
Returns the starting position of the substring SubS in S1
sec (z)
sech (z)
Seed (x)
beginning from position m.
Returns the secant of z.
Returns the hyperbolic secant of z.
Resets the random number seed to x and returns the previous
Shi (x)
Si (x)
sign (x)
value.
Returns the value of the hyperbolic sine integral function.
Returns the value of the sine integral function.
Returns 0 if x = 0, 1 if x > 0, and -1 otherwise. For complex
signum (z, [x])
sin (z)
sinc (z)
values, use csgn.
Returns x if z = 0 and z/|z| otherwise.
Returns the sine of z.
Returns the value of sin(z)/z, with correct behavior in the limit as
z approaches 0.
sinfit (vx, vy, vg)
Returns a vector containing the coefficients for a sine curve of
the form a*sin(x +b) + c that best approximates the data in
vectors vx and vy. Vector vg contains guess values for the three
sinh (z)
SIUnitsOf (x)
skew (A, B, C, ...)
slope (vx, vy)
sort (v)
coefficients.
Returns the hyperbolic sine of z.
Returns the units of x. If x has no units, returns 1.
Returns the skewness of the elements of A, B, C, ...
Returns the slope of line that best fits data in vx and vy.
Returns a vector with the values from v sorted in ascending
sph2xyz (r, theta, phi)
order.
Converts the spherical coordinates of a point in 3D space to
stack (A, B, C, ...)
rectangular coordinates.
Returns an array formed by placing A, B, C, ... top to bottom. A,
B, C, ... are arrays having the same number of columns, or they
statespace (init, t1, t2, npoints, A, [B], [u])
are scalars and column vectors.
Returns the solution to a system of linear, first-order ordinary
stderr (vx, vy)
differential equations.
Returns the standard error associated with a linear regression for
the points described by the vectors vx and vy. Measures the
spread of data points about the regression line.
stdev (A, B, C, ...)
Returns the population standard deviation of the elements of A,
Stdev (A, B, C, ...)
B, C, ...
Returns the sample standard deviation of the elements of A, B, C
Stiffb (y, x1, x2, npoints, D, AJ)
...
Returns a matrix of solution values for the stiff differential
equation specified by the derivatives in D, the augmented
Jacobian function AJ, and initial conditions y on the interval
[x1,x2] using a Bulirsch-Stoer method. Parameter npoints
Stiffr (y, x1, x2, npoints, D, AJ)
controls the number of rows in the matrix output.
Returns a matrix of solution values for the stiff differential
equation specified by the derivatives in D, the augmented
Jacobian function AJ, and initial conditions y on the interval
[x1,x2] using a Rosenbrock method. Parameter npoints controls
str2num (S)
the number of rows in the matrix output.
Returns a constant formed by converting string S into a number.
str2vec (S)
Returns a vector of ASCII codes corresponding to the characters
strlen (S)
submatrix (A, ir, jr, ic, jc)
in S.
Returns the number of characters in string S.
Returns the submatrix of array A consisting of elements in rows ir
substr (S, m, n)
through jr and columns ic through jc of A.
Returns a substring of S beginning at character m and having
supsmooth (vx, vy)
maximum length n.
Returns a vector created by the piecewise use of a symmetric
nearest neighbor linear least-squares fitting on each element in
vy, in which the number of nearest neighbors is adaptively
svd2 (A)
chosen.
Returns a vector of 3 nested arrays. The first array contains the
vector of singular values. The following two arrays are the
matrices U and V.
tan (z)
tanh (z)
Tcheb (n, x)
Returns the tangent of z.
Returns the hyperbolic tangent of z.
Returns the value of the Chebyshev polynomial of degree n, of
time (z)
the first kind, at x.
Returns the current system time. The value z is an arbitrary
tr (M)
Mathcad expression with no impact on the return.
Returns the trace of square matrix M: sum of diagonal elements.
trace (S, x, y, z, ...)
Returns a string containing the value of the arguments x, y, z, ...
with print order and surrounding text specified by S. Prints values
in the Trace Window when debug mode is on. S is optional if only
trunc (z)
Trunc (z, y)
one value is printed.
Returns the integer part of z by removing the fractional part.
Returns the value of trunc(z/y)*y, typically used for correct unit
Ucheb (n, x)
scaling.
Returns the value of the Chebyshev polynomial of degree n, of
until (icond, x)
var (A, B, C, ...)
the second kind, at x.
Returns x until icond is negative.
Returns the population variance of the elements of A, B, C, ...
Var (A, B, C, ...)
vec2str (v)
Returns the sample variance of the elements of A, B, C, ...
Returns a string formed by converting the ASCII codes in v to
vlookup (z, A, c)
characters.
Looks in the first column of a matrix, A, for a given value, z, and
returns the value(s) in the same row(s) in the column specified,
c. When multiple values are returned, they appear in a vector.
wave (v)
Returns the one-dimensional discrete wavelet transform of the
data in v using the Daubechies 4-coefficient wavelet filter.
WRITE_HLS (file)
Writes a packed matrix consisting of the hue, lightness, and
saturation components of an image to a 16 million color Windows
WRITE_HSV (file)
BMP file on your file system.
Writes a packed matrix consisting of the hue, saturation, and
value components of an image to a 16 million color Windows
WRITEBIN (file, type, endian)
WRITEBMP (file)
BMP file on your file system.
Writes an array of scalars to the binary data file named file.
Writes an array into a grayscale BMP file on your file system.
WRITEPRN (file)
WRITERGB (file)
Writes an array into a file on your file system.
Writes a packed matrix consisting of the red, green, and blue
components image to a 16 million color Windows BMP file on
WRITEWAV (file, s, b)
xy2pol (x, y)
your file system.
Writes a WAV signal file out of a matrix.
Converts the rectangular coordinates of a point in 2D space to
xyz2cyl (x, y, z)
polar coordinates.
Converts the rectangular coordinates of a point in 3D space to
xyz2sph (x, y, z)
cylindrical coordinates.
Converts the rectangular coordinates of a point in 3D space to
Y0 (z)
spherical coordinates.
Returns the zeroth order Bessel function of the second kind.
Y0.sc (z)
Returns the zeroth order Bessel function of the second kind,
Y1 (z)
Y1.sc (z)
scaled by the factor exp(-|Im(z)|).
Returns the first order Bessel function of the second kind.
Returns the first order Bessel function of the second kind, scaled
Yn (m, z)
Yn.sc (m, z)
by the factor exp(-|Im(z)|).
Returns the mth order Bessel function of the second kind.
Returns the mth order Bessel function of the second kind, scaled
ys (m, z)
by the factor exp(-|Im(z)|).
Returns the value of the spherical Bessel function of the second
Zeta (s)
kind, of order m.
Returns the value of the Riemann Zeta function. Can only be
evaluated symbolically.
Mathcad Data Analysis Extension Pack Functions
Function Name (Parameters)
Bicubic2D (vx, vy, Z, p, q)
Function Definition
Interpolates between 2-D values in Z, with locations in vx and vy,
Binterp (x, b)
at intermediate point (p, q).
Interpolates results b from Spline2 (b) at point x, along with the
confidence (vx, vy, F, b, conf)
first, second, and third derivatives.
Returns the confidence limits on the parameters b of a fitting
contingtbl (M)
function F(x,b) fit to the data vx and vy.
Returns chi-squared, degrees of freedom, probability that chisquared or larger would occur if variables had no association,
Cramer's V, and the contingency coefficient, C for a contingency
DWS (b)
table M.
Returns the Durbin-Watson statistic for the result vector, b, of the
filterNaN (v)
Ftest (v1, v2)
Spline2 function.
Removes the rows of the data set, v, that have NaNs.
Tests the hypothesis that v1 and v2 are drawn from distributions
having the same variance. Returns the F statistic, and the
probability that a value this large or larger would occur when the
Grubbs (v, a)
distributions have the same variance.
Returns indices of suspected outliers, and their Grubbs test
GrubbsClassic (v, a)
statistics for a confidence level a.
Returns index of the data point most likely to be an outlier, and
Hlookup (z, A, r,"modifier")
its Grubbs test statistic for a confidence level a.
Looks in the first row of A for values matched by z according to
the boolean modifier. Returns the value(s) in the matched
kendltau (v1, v2)
column(s) in row r.
Returns Kendall's tau, number of standard deviations from 0, and
the probability that a value this large or larger would occur if the
kendltau2 (M)
samples were uncorrelated.
Returns Kendall's tau, number of standard deviations from 0, and
the probability that a value this large or larger would occur if
LeastSquaresFit (vx, vy, F, guess, conf, [Stdy], [LBUB],[Acc])
contingency table M were uncorrelated.
Returns parameters and their confidence limits for the nonlinear
fitting function F for the data vx and vy, for a confidence level
conf, with optional standard deviations Stdy and optional lower
and upper bounds on acceptable parameter values to accuracy
Acc.
loadings (nipals)
Returns the loadings of the principal components (eigenvalues)
from multivariate data returned by the nipals function.
localmax (data, [w])
Returns the local maxima in data by nearest neighbor
comparison, with an optional window width w of comparison
localmin (data, [w])
points.
Returns the local minima in data by nearest neighbor
comparison, with an optional window width w of comparison
Lookup (z, A, B, modifier)
points.
Looks in the matrix A for values matched by z according to the
boolean modifier. Returns the value(s) in the same position(s) in
markNaN (data, vindex)
matrix B.
Changes each element in data specified by vindex to contain a
Match (z, A, "modifier")
NaN.
Returns the indices of entries in A which match z according to
matchNaN (data)
the boolean modifier.
Returns the index or pair of indexes of the NaN entries in data.
Nipals (Data, numPC, maxiter, ["scale"])
Returns numPC principal components (eigenvalues), loadings,
scores, and accumulated variance explained by each PC from
multivariate data using a maximum of maxiter iterations. TOL
specifies the termination accuracy used for eigenvalue
generation. Data may be optionally scaled to the standard
Nipals2 (nipals, numPC)
deviation.
Returns numPC additional principal components (eigenvalues),
loadings, scores, and accumulated variance explained by each
PC given the results calculated by Nipals.
order (v)
Returns the index in which the entries of v occur if sorted, based
PCAeigenvals (nipals)
on the current value of ORIGIN.
Returns the principal components (eigenvalues) from multivariate
PCAvariance (nipals)
data returned by the nipals function.
Returns the accumulated percentage of variance explained by
the calculated principal components (eigenvalues) returned by
percentile (v, p)
the nipals function.
Returns the number of values in v below p percent of the total
polycoeff (vx, vy)
number of points.
Returns the coefficients of the interpolating polynomial function.
polyint (vx, vy, x)
Returns interpolated value at x using a polynomial function, and
polyiter (vx, vy, x, N, e)
the expected error.
Returns interpolated value at x using a polynomial function with
maximum order N and maximum error, e. Also returns the
qqplot (v1, [v2 or "distrib"])
calculated error, and whether the function converged.
Returns points on a probability plot. If only v1 is specified,
quantiles for v1 and the normal distribution are returned. If v2 is
specifed, quantiles for v1 and v2 are returned. If 'weibull' is
specified, returns natural log quantiles for v1 and the weibull
Rank (v)
quantiles.
Returns the averaged position at which each value in v appears
in a sorted list of the data.
rationalfit (vx, vy, conf, [m, n], [resid], [Stdy], [LBUB])
Returns parameters and their confidence limits for a rational
polynomial fit of order m and n on the top and bottom, or an
allowable residual chi-squared, if the function should determine
the optimal order. Confidence level conf is achieved, with
optional standard deviations Stdy and optional lower and upper
bounds on acceptable parameter values.
rationalfitnp (vx, vy, conf, [m, n], [resid], [Stdy], [LBUB])
Returns parameters and their confidence limits for a rational
polynomial fit of order m and n on the top and bottom, or an
allowable residual chi-squared, if the function should determine
the optimal order. Confidence level conf is achieved, with
optional standard deviations Stdy and optional lower and upper
bounds on acceptable parameter values.
rationalint (vx, vy, x)
Returns interpolated value at x using rational functions, and the
Scale (M, min, max)
scores (nipals)
expected error.
Scales all values in M between min and max.
Returns the scores of the principal components (eigenvalues)
from multivariate data returned by the nipals function.
Spear (v1, v2)
Returns Spearman's rank correlation coefficient, and associated
Spline2 (vx, vy, n, [vw], [u], [level])
statistics.
Returns the optimal set of order-n B-spline knots to interpolate
on data vx and vy, with optional weights vw, optional desired
knots u, and an optional reject level. Output is used with Binterp.
Thiele (vx, coeff, x)
Returns the interpolated y value for the real scalar x, using the
data points in vx and the coefficients returned by Thielecoeff.
Thielecoeff (vx,vy)
Returns the continued fraction coefficients of the vectors vx and
ThreeSigma (v)
vy.
Returns indices of points in v whose mean divided by standard
deviation is greater than three (outlier test), and the value of this
trim (vdata, vindex)
vhlookup (z1, z2, A)
quantity for each point.
Trims out the entries (rows) specified by vindex.
Looks in the first column and row of A for values matched by z1
and z2, respectively. Returns the value(s) in the intersection of
VHlookup (z1, z2, A, "modifier")
matched rows and columns.
Looks in the first column and row of A for values matched by z1
and z2 according to the boolean modifier. Returns the value(s) in
Vlookup (z, A, c, "modifier")
the intersection of matched rows and columns.
Looks in the first column of a matrix, A, for values matched by z
according to the boolean modifier. Returns the value(s) in the
matched row(s) in column c. When multiple values are returned,
VSmooth (v, w)
they appear in a vector.
Repeatedly median smoothes v until no additional change has
occurred for each window width in w.
Mathcad Image Processing Extension Pack Functions
Function Name (Parameters)
addnoise (M, p, n)
Function Definition
Returns matrix M with added noise, where the noise has
probabilty p/2 to add n to a pixel, and p/2 to subtract n.
and (M, N)
Returns the boolean AND of two image matrices M and N, which
augment3 (X, Y, Z)
must be the same size.
Returns a matrix formed by putting matrices (or vectors) X, Y,
and Z side by side. They must all have the same number of
binarize (M, thresh)
rows.
Returns a binarized version of matrix M with pixels above
binarize_auto (M)
threshold thresh set to 1 and below to 0.
Returns a binarized version of matrix M, choosing the threshold
binarize2 (M, lowThresh, highThresh, inValue, outValue)
automatically.
Returns a binarized version of matrix M with pixels between
lowThresh and highThresh set to inValue, and pixels outside to
blend (M, N)
outValue.
Returns a blend of same-size matrices M and N (pixelwise sum -
canny (M, sigma, low, high)
[product/255]).
Returns a binary edge image resulting from Canny edge
detection on matrix M, using standard deviation sigma and
center (M)
hysteresis thresholds low and high.
Returns fourier transform image matrix M tansformed so that DC
centsmooth (M)
is in the center.
Returns matrix M smoothed with a 3x3 center weighted kernel.
clip (M, Min, Max)
Returns matrix M with elements clipped to lie between Min and
close (M, Melem, b)
Max.
Performs binary closing on matrix M at threshold b with
cnvxhull (M, fg)
structuring element Melem.
Returns a matrix containing the convex hull of pixels of value fg
colgrad (M)
in matrix M.
Returns the column gradient (difference by columns) of matrix M.
compgrad (M)
Performs edge detection by comparing the gradients of the 8
concomp (M, con, fg)
neighbors on matrix M.
Performs connected component labeling of the pixels with
grayscale value fg in matrix M, considering 4-connected
convol2d (M, K)
convolve3 (M, K)
convolve5 (M, K)
dct2d (M)
neighbors if con is 4 or 8-connected if con is 8.
Returns the convolution of matrix M with kernel K.
Returns the quick convolution of matrix M with 3x3 kernel K.
Returns the quick convolution of matrix M with 5x5 kernel K.
Returns the 2D discrete cosine transform (type II) of matrix M.
diacrisp (M)
Returns matrix M crisped with a 3x3 diagonally weighted kernel.
difedge (M)
Performs edge-detection by differential convolution on matrix M.
dilate (M, Melem, r_origin, c_origin, b)
Performs binary dilation on matrix M at threshold b using
structuring element Melem with origin at row r_origin and column
dilate4 (M, b)
c_origin.
Performs dilation on matrix M at threshold b using 4 neighbors.
dilate8 (M, b)
Performs dilation on matrix M at threshold b using 8 neighbors.
distform (M, fg)
Returns the distance transform of image M using foreground
equalize (M)
gray value fg.
Returns matrix M with grayscale adjusted to form a linear
erode (M, Melem, r_origin, c_origin, b)
cumulative histogram.
Performs binary erosion on matrix M at threshold b using
structuring element Melem with origin at row r_origin and column
erode4 (M, b)
c_origin.
Performs erosion on matrix M at threshold b using 4 neighbors.
erode8 (M, b)
Performs erosion on matrix M at threshold b using 8 neighbors.
extract (M, n)
Returns the nth (1, 2, or 3) color component of packed 3-color
freichen (M)
matrix M.
Performs edge detection by Frei-Chen convolution on matrix M.
funcdeconv (M, f, e)
Deconvolution of matrix M with frequency domain function f and
funconv (M, f)
funmap (M, f)
gaussconv (M, s)
error e.
Convolution of matrix M with frequency domain function f.
Returns matrix M with function f applied to each element.
Convolution of matrix M with frequency domain gaussian of half-
gaussdeconv (M, s, e)
width s.
Deconvolution of matrix M with frequency domain gaussian of
getnoise (M)
half-width s with error e.
Returns the difference between matrix M and median filtered M.
gray_close (M, Melem)
Performs grayscale closing on matrix M with structuring element
gray_dilate (M, Melem, r_origin, c_origin)
Melem.
Performs grayscale dilation on matrix M using structuring
element Melem with origin at row r_origin and column c_origin.
gray_erode (M, Melem, r_origin, c_origin)
Performs grayscale erosion on matrix M using structuring
element Melem with origin at row r_origin and column c_origin.
gray_open (M, Melem)
Performs grayscale opening on matrix M with structuring element
gray_to_rgb (gray, colormap)
Melem.
Returns grayscale matrix gray converted to color using color
hist2d (M, N, n)
palette matrix colormap.
Returns a two-dimensional histogram with n bins on equal-sized
hls_to_rgb (HLS)
matrices M and N.
Returns array HLS in HLS color representation converted to
horzflip (M)
hsv_to_rgb (HSV)
RGB color representation.
Returns the matrix M flipped horizontally.
Returns array HSV in HSV color representation converted to
idct2d (M)
RGB color representation.
Returns the inverse 2D discrete cosine transform (type II) of
imhist (M, n)
matrix M.
Returns an n-bin histogram of M for values between 0 and 255
imhist2 (M, n)
immse (M, Q)
(ignores values outside that range).
Returns an n-bin histogram of M over its range of values.
Returns the mean-squared-error (MSE) between image matrices
M and Q.
imquant (M, n)
Returns a quantized version of matrix M containing only n
imquant2 (M, v)
equally-spaced grayscale levels between 0 and 255.
Returns a quantized version of matrix M containing only the
imsnr (M, Q)
grayscale levels in vector v.
Returns the signal-to-noise ratio (SNR) between image matrices
invert (M)
M and Q.
Returns the matrix M with each element set to 255 - element.
invert2 (M)
Returns the matrix M with each element set to max(M) - element
iwave2d (M, n)
kirsch (M)
+ min(M).
The n-level inverse wavelet transform of M.
Performs edge detection by kirsch convolution and comparison
laplace24 (M)
on matrix M.
Returns the convolution of matrix M with a 5x5 Laplacian kernel.
laplace4 (M)
The kernel's center is 24.
Returns the convolution of matrix M with a 3x3 Laplacian kernel.
laplace8 (M)
The kernel's center is 4.
Returns the convolution of matrix M with a 3x3 Laplacian kernel.
levelmap (M, vec)
The kernel's center is 8.
Returns matrix with values in vec assigned by matching vec's
indices to elements in matrix M. vec must be such that the
mask (M, N)
elements of M are between 0 and length(vec) - 1.
Returns matrix M masked by same-size matrix N (i.e. with zeros
matconv (M, N)
matdeconv (M, N, e)
where N is zero).
Convolution of matrix M with frequency domain mask N.
Deconvolution of matrix M with frequency domain mask N and
medfilt (M)
moment_invariant (M)
error e.
Returns median filtered M.
Returns a vector containing the seven typical moment invariants
open (M, Melem, b)
of M.
Performs binary opening on matrix M at threshold b using
or (M, N)
structuring element Melem.
Returns boolean OR of two image matrices M and N, which must
orthocrisp (M)
be the same size.
Returns matrix M crisped with a 3x3 orthogonally weighted
orthocrisp5 (M)
kernel.
Returns matrix M crisped with a 5x5 orthogonally weighted
orthosmooth (M)
kernel.
Returns matrix M smoothed with a 3x3 orthogonally weighted
orthosmooth5 (M)
kernel.
Returns matrix M smoothed with a 5x5 orthogonally weighted
prewitt (M)
putregion (M, N, row, col)
kernel.
Performs edge detection by Prewitt convolution on matrix M.
Returns the matrix N inserted into M at row row and column col.
quantfilt (M, elem, quantile)
Performs quantile filtering on M using neighborhood matrix elem
and quantile probability quantile.
READRAW (filename, rows, cols, bits, endian, skip)
Returns the contents of a raw binary image file as a matrix. The
binary file is interpreted to contain a rows x cols matrix of bits (8
or 16) bits per pixel packed integers, in "Little" or "Big" endian
format, and skip bytes are skipped for header at the beginning of
reg_grow (M, x_gridsize, y_gridsize, num_regions)
the file.
Performs the piecewise-constant energy-based region growing
segmentation of M into num_regions regions, using initial grid
spaced by x_gridsize along x and y_gridsize along y.
relerror (M, Q)
replace (M, N, n)
Returns the relative error between matrices M and Q.
Returns packed image matrix M with the nth (1, 2, or 3) color
component replaced by matrix N, which must have the same
rgb_to_gray (RGB)
rgb_to_hls (RGB)
number of rows as M and 1/3 as many columns.
Returns RGB color array RGB converted to grayscale.
Returns array RGB in RGB color representation converted to
rgb_to_hsv (M)
HLS color representation.
Returns array RGB in RGB color representation converted to
rgb_to_ycbcr (RGB)
HSV color representation.
Returns array RGB in RGB color representation converted to
rgb_to_yiq (RGB)
YCbCr color representation.
Returns array RGB in RGB color representation converted to
roberts (M)
YIQ color representation.
Performs edge detection by Roberts convolution on matrix M.
robinson3 (M)
Performs edge detection by 3x3 Robinson convolution and
robinson5 (M)
comparison on matrix M.
Performs edge detection by 5x5 Robinson convolution and
rotate (M, angle)
comparison on matrix M.
Returns the matrix M rotated angle degrees counterclockwise.
rotate180 (M)
rotate270 (M)
rotate90 (M)
rowgrad (M)
scale (M, Min, Max)
Returns the matrix M rotated 180 degrees counterclockwise.
Returns the matrix M rotated 270 degrees counterclockwise.
Returns the matrix M rotated 90 degrees counterclockwise.
Returns the row gradient (difference by rows) of matrix M.
Returns matrix M with elements scaled between Min and Max.
shape_features (M)
Returns a matrix of moments and shape features for each
skeleton (B)
skeleton2 (M, b)
sobel (M)
subcolor (M, ir, jr, ic, jc)
distinct pixel value in labeled image M.
Returns binary matrix B eroded to its innermost level.
Returns the skeleton of matrix M binarized with threshold b.
Performs edge detection by Sobel convolution on matrix M.
Returns the submatrix from row ir to jr, column ic to jc, of packed
thin (M, b)
color matrix M.
Returns the thinned version of matrix M binarized with threshold
threshold (M, thresh)
b.
Returns the matrix M with every element below thresh set to
thresh. If thresh is negative, every element above -thresh is set
translate (M, rows, cols, pad)
to -thresh.
Returns matrix M translated by rows rows and cols colums,
padding unfilled matrix elements with pad.
unicrisp (M)
Returns matrix M crisped with a 3x3 uniformly weighted kernel.
unismooth (M)
Returns matrix M smoothed with a 3x3 uniformly weighted
unismooth5 (M)
kernel.
Returns matrix M smoothed with a 5x5 uniformly weighted
vertflip (M)
warp (M, T)
kernel.
Returns the matrix M flipped vertically.
Performs bilinear warping on matrix M, using tie-points stored in
wave2d (M, n)
wavescale (M, n, Min, Max)
matrix T.
The n-level wavelet tranform of M.
The n-level wavelet transform of M, scaled between Min and
wiener2d (M, win_h, win_w)
Max.
Perform 2D adaptive Wiener filtering on M using a local window
WRITERAW (filename, bits, endian)
win_w pixels wide by win_h pixels high.
Writes a matrix M to raw binary integer image file filename, using
either 8 or 16 bits per pixel, in "Little" or "Big" endian storage
ycbcr_to_rgb (YCbCr)
order. Set this function equal to the matrix M.
Returns array YCbCr in YCbCr color representation converted to
yiq_to_rgb (YIQ)
RGB color representation.
Returns array YIQ in YIQ color representation converted to RGB
zoom (M, hscale, vscale)
color representation.
Return image matrix M resized by factor hscale horizontally and
vscale vertically.
Mathcad Signal Processing Extension Pack Functions
Function Name (Parameters)
bandpass (f1, f2, n, [w])
Function Definition
Returns coefficients for a bandpass FIR filter with n coefficients
and cutoff frequencies f1 and f2, windowed with a taper w.
bandstop (f1, f2, n, [w])
Returns coefficients for a bandstop FIR filter with n coefficients
and cutoff frequencies f1 and f2, windowed with taper w.
bessel (n, scale)
Returns coefficients for an analog Bessel filter of order n; scale
controls the gain at cutoff. The output is an argument to the
blackman (n)
burg (v, n)
functions iirlow, iirhigh, iirpass or iirstop.
Returns a Blackman window of width n.
Returns coefficients for nth order linear prediction generated
butter (n)
from the vector v using Burg's method.
Returns coefficients for an analog Butterworth filter of order n.
The output is used as an argument to one of the functions iirlow,
ccepstrum (A)
iirhigh, iirpass or iirstop.
Returns a matrix containing the complex cepstrum of a
cepstrum (v)
cheby (n, b)
cheby1 (n, e)
multichannel signal A.
Returns the cepstrum of the vector v.
Returns a Chebyshev window of width n and parameter b.
Returns coefficients for a Type I Chebyshev analog filter of order
n; ripple is controlled by the parameter e. The output is used as
an argument to one of the functions iirlow, iirhigh, iirpass or
iirstop.
cheby2 (n, scale, atten)
Returns coefficients for a Type II Chebyshev analog filter of ord.
n with the lower edge of the stopband at scale and stopband
attenuation atten. The output is an argument to the functions
chirpz (v, lo, hi, d)
iirlow, iirhigh, iirpass or iirstop.
Returns the frequency spectrum of the signal v between lo and hi
coherence (vx, vy, n, r, [w])
at frequency intervals of d.
Returns the coherence of vectors vx and vy. The signal vectors
are divided into n overlapping intervals with fraction of overlap r.
convol (vx, vy)
costaper (n, a)
Each data segment is windowed with taper w.
Returns the convolution of the arrays vx and vy.
Returns a cosine taper window of length n, with the percentage
costr (v)
covar (vx, vy)
cspectrum (vx, vy, n, r, [w])
of raised cosine given by a.
Returns the cosine transform of the array v.
Returns the covariance of the arrays vx and vy.
Returns the cross spectrum of the vectors vx and vy. The signal
vectors are divided into n overlapping intervals with fraction of
overlap r. Each data segment is windowed with taper w.
deconvol (vz, vx)
detrend (v)
dht (v)
dwavelet (v)
expsmooth (v, a)
Returns the deconvolution of the array vz by the array vx.
Returns the vector or matrix v with any linear trend removed.
Returns the Hartley transform of the array v.
Returns a discrete wavelet transform of the array v.
Returns a smoothed version of data in array v generated by
fftfilt (v, C, [nfft])
exponential smoothing with weight a.
Returns a matrix with the result of the convolution of a
multichannel signal v, with an array C, calculated by computing
gain (C, f)
gaussian (n, a)
the FFT of length nfft.
Returns the gain at frequency f of a filter with coefficients C.
Returns a Gaussian window of width n; the parameter a controls
gaussn (n)
the peak width.
Returns an n-element vector of random numbers following a
Gaussian probability distribution of mean 0 and standard
hamming (n)
hanning (n)
highpass (f, n, [w])
deviation 1.
Returns a Hamming window of width n.
Returns a Hanning window of width n.
Returns coefficients for a highpass FIR filter with n coefficients
hilbert (v)
icostr (v)
idht (v)
idwavelet (v)
and cutoff frequency f, windowed with taper w.
Returns the Hilbert transform of the array v.
Returns the inverse cosine transform of the array v.
Returns the inverse Hartley transform of the array v.
Returns the inverse of the discrete wavelet transform carried out
iirhigh (C, f)
by the dwavelet function.
Returns coefficients for a highpass IIR filter with cutoff frequency
f. The input array C is generated by one of the functions cheby1,
iirlow (C, f)
cheby2, bessel, or butter.
Returns coefficients for a lowpass IIR filter with cutoff frequency
f. The input array C is generated by one of the functions cheby1,
iirpass (C, lowf, highf)
cheby2, bessel, or butter.
Returns coefficients for a bandpass IIR filter with cutoff
frequencies lowf and highf. The input array C is generated by
one of the functions cheby1, cheby2, bessel, or butter.
iirstop (C, lowf, highf)
Returns coefficients for a bandstop IIR filter with cutoff
frequencies lowf and highf. The input array C is generated by
interpolate (v, n)
one of the functions cheby1, cheby2, bessel, or butter.
Returns an interpolated version of the vector v with n times as
isintr (v)
kaiser (n, b)
lcorr (vx, vy)
many points as v.
Returns the inverse sine transform of the array v.
Returns a Kaiser window of width n and parameter b.
Returns a vector giving the correlation of the vectors vx and vy at
lowpass (f, n, [w])
each possible lag.
Returns coefficients for a lowpass FIR filter with n coefficients
mag (v)
and cutoff frequency f, windowed with taper w.
Returns a vector containing the magnitudes of the elements in
makeri (magvec, phasevec)
the complex array v.
Returns a vector of complex numbers whose magnitudes and
medfilt1d (M, n)
phases are contained in magvec and phasevec.
Returns the multichannel signal M, filtered with a median filter of
movavg (v, n)
length n.
Returns a smoothed version of data in array v created by taking
multirate (v, n, m, [f])
a moving average with a window of width n.
Returns a version of multichannel signal v resampled by a factor
of n/m, using the optional argument f as the lowpass interpolating
nuttall (n)
onefn (n)
phase (v)
filter.
Returns a Nuttall window of width n.
Returns an n-element vector of 1/f noise.
Returns a vector containing the phases of the elements in the
phasecor (phasevec)
complex array v.
Returns a vector generated from the array of phases phasevec
plcorr (v)
by removing jump discontinuities.
Returns a vector giving the partial autocorrelation of the vector v
pspectrum (v, n, r, [w])
at each lag.
Returns the power spectrum of v, computed by dividing v into n
overlapping segments with overlap fraction r. Each data segment
quantize (v, n)
is windowed with taper w.
Returns a vector that assigns the elements of v to n equally
recenter (A)
spaced levels.
Returns a recentered version of array A, cyclically permuted to
remez (vg, vr, vw, n)
bring the first element of A to the middle.
Returns coefficients for an FIR filter of length n generated by the
resample (v, m, n)
Remez exchange algorithm.
Returns a vector obtained from v by n-fold interpolation and then
response (v, C, n)
sampling every mth point.
Returns a vector giving n terms of the response of an input
sintr (v)
snr (vx, vy, n, r, [w])
vector v to an FIR filter with coefficient array C.
Returns the sine transform of the array v.
Returns the signal-to-noise ratio for vx and vy. The signal vectors
are divided into n overlapping segments with fraction of overlap r.
stft (v, [n], [s], [w])
Each data segment is windowed with taper w.
Returns a matrix containing the short time Fourier transform of a
signal v; computes n frequencies, every s samples, and tapers
taprect (n)
each block with window (or window type) w.
Returns a tapered rectangular window of width n.
timecorr (v, t, l, s, [d])
Returns a matrix containing the samples of a time-depemdent
autocorrelation function for a signal v, type t, l number of lags,
step size s, and an optional scalar or matrix argument d.
timefreq (v, t, f, s, [d])
Returns a matrix containing the samples of a time-depemdent
autocorrelation function for a signal v, type t, f number of
frequencies, step size s, and an optional scalar or matrix
triangular (n)
twodconvol (A, B)
argument d.
Returns a triangular window of width n.
Returns the two-dimensional convolution of the arrays A and B.
walsh (n, k)
Returns the kth Walsh function of order n (n between 0 and 12).
whiten (n)
Returns an n-element vector of uniformly distributed white noise.
yulew (v, n)
Returns coefficients for nth order linear prediction generated
from the vector v using the Yule-Walker algorithm.
Mathcad Wavelets Extension Pack Functions
Function Name (Parameters)
applybs (w, b, f)
Function Definition
Returns the result of applying the function f to each subband of
the wavelet packet basis b comprising the coefficients in w. b is a
applytbl (T, f)
2- or 3-column matrix representing a packet basis.
Returns a new wavelet packet table by applying the function f to
basis_display2d (b)
each subband of the wavelet packet table T.
Creates a matrix for graphically displaying 2-dimensional basis b.
best_basis (T, f)
Returns the best packet basis from a packet table T, based on
bl (n)
the additive cost function f.
Returns the Battle-Lemarie wavelet based upon the degree n
Bspline (m, n)
cardinal B-spline. n is an integer bewtween 0 and 6.
Returns the analysis and synthesis low-pass filters for a splinebased biorthogonal wavelet. m is 1, 2, or 3. When m=1, n is an
odd number between 1 and 5. When m=2, n is an even number
between 2 and 8. When m=3, n is an odd number between 1 and
coiflet (n)
9.
Returns the low-pass filter of the n-coefficient Coiflet wavelet. n
cpt (a, n)
is 6, 12, 18, 24, or 30.
Returns the n-level local cosine packet table for the data array a,
create_level (n, d)
using the default trig data taper function.
Returns a d-dimensional wavelet packet basis of all wavelet
daublet (n)
packets at the level n.
Returns the low-pass filter of the n-coefficient minimum phase
Daubechies wavelet. n is an even integer between 2 and 20.
dlfather (x, [j, k], s)
Returns the value at x of the dual father wavelet packet based on
the filter represented by string s at scale j and position k. If j and
dlfather2d (x, y, [j, kx, ky], s)
k are omitted, they are assumed to be 0.
Returns the value at (x,y) of the 2D dual father wavelet packet
based on the filter represented by string s at scale j and position
(kx,ky). If j, kx, and ky are omitted, they are assumed to be 0.
dlmother (x, [j, k], s)
Returns the value at x of the dual mother wavelet packet based
on the filter represented by string s at scale j and position k. If j
dlmother2d (x, y, [j, kx, ky], s, ds)
and k are omitted, they are assumed to be 0.
Returns the value at (x,y) of the 2D dual mother wavelet packet
based on the filter represented by string s at scale j and position
(kx,ky). String ds is either "H", "V", or "D", and indicates either
the horizontal, vertical, or diagonal mother wavelet. If j, kx, and
ky are omitted, they are assumed to be 0.
dlwavelet (x, j, k, n, f, [o, [i]])
Returns the value at x of the nth dual wavelet packet based on
the filter f at scale j and position k. f is either a vector or a 2-
dlwavelet2d (x, y, j, kx, ky, m, n, f, [o, [i]])
column matrix. f can have an offset o and negation i.
Returns the value at (x,y) of the (m,n)th dual wavelet packet
based on filter f at scale j and position (kx,ky). f is either a vector
or a 2-column matrix. f can have an offset o and negation i.
dwt (a, n, f, [o, [i]])
Returns the n-level wavelet transform of the array a by the
wavelet filter f. f is either a vector or a 2-column matrix. f can
dwti (a, n, f)
have an offset o and negation i.
Returns the n-level interval wavelet transform of the array a by
the wavelet filter f. f is a vector returned by daublet or symmlet.
dwts (a, n, f)
Returns the n-level symmetric wavelet transform of the array a
by the wavelet filter f. f is either a vector or a 2-column matrix
evalbs (w, b, f)
returned by bl, Bspline, or daublet(2).
Returns the result of applying the function f to each subband of
the wavelet packet basis b comprising the coefficients in w. b is a
evaltbl (T, f)
2- or 3-column matrix representing a packet basis.
Returns the result of applying the function f to each subband of
extract_basis (T, b)
the wavelet packet table T.
Returns coefficients in the basis specified by b from a 1D or 2D
father (x, [j, k], s)
packet table T.
Returns the value at x of the father wavelet packet based on the
filter represented by string s at scale j and position k. If j and k
father2d (x, y, [j, kx, ky], s)
are omitted, they are assumed to be 0.
Returns the value at (x,y) of the 2D father wavelet packet based
on the filter represented by string s at scale j and position (kx,ky).
If j, kx, and ky are omitted, they are assumed to be 0.
get_detail (w, l)
Returns the result of extracting the index-1 block of wavelet
packet coefficients at level l from the wavelet packet transform w.
get_detail2d (M, l, ds)
Returns the result of extracting the subband indicated by the
string ds of wavelet packet coefficients at level l from the 2dimensional wavelet packet transform M. ds is either "H", "V", or
"D", and indicates either the index-(1,0), index-(0,1), or index-
get_smooth (w, l)
(1,1) subband.
Returns the result of extracting the 0th block of wavelet packet
coefficients at level l from the wavelet packet transform w.
get_smooth2d (M, l)
Returns the result of extracting the (0,0)th subband of wavelet
packet coefficients at level l from the 2-dimensional wavelet
get_subband (w, l, n)
packet transform M.
Returns the nth block of wavelet packet coefficients at level l
extracted from the wavelet packet transform w. w is a vector.
get_subband2d (M, l, m, n)
Returns the result of extracting the (m,n)th subband of wavelet
packet coefficients at level l from the 2-dimensional wavelet
icpt (w, n, b)
packet transform M. M is an array.
If w is an array of cosine packet coefficients constructed from a
cosine packet table with n levels, returns the inverse cosine
packet transform with respect to the basis specified by b, using
the default trig data taper function. b is a 2- or 3-column matrix
idwt (a, n, f, [o, [i]])
representing a cosine packet basis.
Returns the n-level inverse wavelet transform of the array a by
the wavelet filter f. f is either a vector or a 2-column matrix. f can
idwti (a, n, f)
have an offset o and negation i.
Returns the n-level inverse interval wavelet transform of the
array a by the wavelet filter f. f is a vector returned by daublet or
idwts (a, n, f)
symmlet.
Returns the n-level inverse symmetric wavelet transform of the
array a by the wavelet filter f. f is either a vector or a 2-column
ilct (w, n, b, f)
matrix returned by bl, Bspline, or daublet(2).
If w is an array of cosine packet coefficients constructed from a
cosine packet table with n levels, returns the inverse cosine
packet transform with respect to the basis specified by b, using
data taper function f. b is a 2- or 3-column matrix representing a
iwpt (w, b, f, [o, [i]])
cosine packet basis.
Returns the inverse wavelet packet transform of the array w with
respect to basis b by the wavelet filter f. b is a 2- or-3-column
matrix representing a packet basis. f is either a vector or a 2column matrix. f can have an offset o and negation i.
iwpti (w, b, f)
Returns the inverse interval wavelet packet transform of the
array w with respect to basis b by the wavelet filter f. b is a 2- or
3-column matrix representing a packet basis. f is a vector.
iwpts (w, b, f)
Returns the inverse symmetric wavelet packet transform of the
array w with respect to basis b by the wavelet filter f. b is a 2- or
3-column matrix representing a packet basis. f is either a vector
lct (a, n, f)
or a 2-column matrix.
Returns the n-level local cosine packet table for the data array a
mother (x, [j, k], s)
using data taper function f.
Returns the value at x of the mother wavelet packet based on the
filter represented by string s at scale j and position k. If j and k
mother2d (x, y, [j, kx, ky], s, ds)
are omitted, they are assumed to be 0.
Returns the value at (x,y) of the 2D mother wavelet packet based
on the filter represented by string s at scale j and position (kx,ky).
String ds is either "H", "V", or "D", and indicates either the
horizontal, vertical, or diagonal wavelet. If j, kx, and ky are
omitted, they are assumed to be 0.
put_detail (w, l, y)
Returns the result of inserting the vector y into the index-1 block
put_detail2d (M, l, N, ds)
of wavelet packet coefficients of w at level l.
Returns the result of inserting the matrix N into the subband
indicated by the string ds of wavelet packet coefficients at level l
of the 2-dimensional wavelet packet transform M. ds is either
"H", "V", or "D", and indicates either the index-(1,0), index-(0,1),
put_smooth (w, l, y)
or index-(1,1) subband.
Returns the result of inserting the vector y into the index-0 block
put_smooth2d (M, l, N)
of wavelet packet coefficients of w at level l.
Returns the result of inserting the matrix N into the index-(0,0)
subband of wavelet packet coefficients at level l of the 2-
put_subband (w, l, n, y)
dimensional wavelet packet transform M.
Returns the result of inserting the vector y into the nth block of
wavelet packet coefficients at level l of the wavelet packet
put_subband2d (M, l, m, n, N)
transform w. w is a vector.
Returns the result of inserting the matrix N into the (m,n)th
subband of wavelet packet coefficients at level l of the 2-
swaveterp (x, v, j, n, f)
dimensional wavelet packet transform M. M is an array.
Returns the value at x of the symmetric multiresolution
approximation of v corresponding to the nth subband at level j,
based on the filter f. f is an array returned by bl, Bspline, or
swaveterp2d (x, y, v, j, m, n, f)
daublet(2).
Returns the value at (x,y) of the symmetric multiresolution
approximation of v corresponding to the (m,n) th subband at level
j, based on the filter f. f is an array returned by bl, Bspline, or
symmlet (n)
daublet(2).
Returns the low-pass filter of the n-coefficient least asymmetric
Daubechies wavelet. n is an even integer between 4 and 20.
wavebs (n, d)
Returns the d-dimensional wavelet packet basis corresponding
wavelet (x, j, k, n, f, [o, [i]])
to the wavelet transform of level n.
Returns the value at x of the nth wavelet packet based on filter f
at scale j and position k. f is either a vector or a 2-column matrix.
wavelet2d (x, y, j, kx, ky, m, n, f, [o, [i]])
f can have an offset o and negation i.
Returns the value at (x,y) of the (m,n)th wavelet packet based on
filter f at scale j and position (kx,ky). f is either a vector or a 2column matrix. f can have an offset o and negation i.
waveterp (x, v, j, n, f, [o, [i]])
Returns the value at x of the periodic multiresolution
approximation of v corresponding to the nth subband at level j,
based on the filter f. f is either a vector or a 2-column matrix. f
waveterp2d (x, y, v, j, m, n, f, [o, [i]])
can have an offset o and negation i.
Returns the value at (x,y) of the periodic multiresolution
approximation of v corresponding to the (m,n) th subband at level
j, based on the filter f. f is either a vector or a 2-column matrix. f
wpt (a, b, f, [o, [i]])
can have an offset o and negation i.
Returns the wavelet packet transform of the array a with respect
to basis or level b by the wavelet filter f. b is either an integer or a
2-or-3-column matrix representing a packet basis. f is either a
vector or a 2-column matrix. f can have offset o and negation i.
wpti (a, b, f)
Returns the interval wavelet packet transform of the array a with
respect to basis or level b by the wavelet filter f. b is either an
integer or a 2- or 3-column matrix representing a packet basis. f
wpts (a, b, f)
is a vector.
Returns the symmetric wavelet packet transform of the array a
with respect to basis or level b by the wavelet filter f. b is either
an integer or a 2- or 3-column matrix representing a packet
basis. f is either a vector or a 2-column matrix.
Download