Index of all Fields and Methods
All Packages  Class Hierarchy

A B C D E F G H I J K L M N O P Q R S T U V W X Y Z

Index of all Fields and Methods

A

abs(Complex). Static method in class VisualNumerics.math.Complex
Returns the absolute value (modulus) of a Complex, |z|.
acos(Complex). Static method in class VisualNumerics.math.Complex
Returns the inverse cosine (arc cosine) of a Complex.
acosh(double). Static method in class VisualNumerics.math.Sfun
Returns the inverse (arc) hyperbolic cosine.
add(Complex). Method in class VisualNumerics.math.Complex
Adds a Complex and returns the sum, this += y.
add(Complex, Complex). Static method in class VisualNumerics.math.Complex
Returns the sum of two Complex's, x+y.
add(Complex, Complex[]). Static method in class VisualNumerics.math.ComplexVector
Add a Complex scalar to each element of the vector, zi + b for all values of the index i.
add(Complex, double). Static method in class VisualNumerics.math.Complex
Returns the sum of a Complex and a double, x+y.
add(Complex[], Complex[]). Static method in class VisualNumerics.math.ComplexVector
Add a Complex vector to a Complex vector.
add(Complex[][], Complex[][]). Static method in class VisualNumerics.math.ComplexMatrix
Add two rectangular arrays, a + b.
add(double). Method in class VisualNumerics.math.Complex
Adds a double and returns the sum, this += y.
add(double, Complex). Static method in class VisualNumerics.math.Complex
Returns the sum of a double and a Complex, x+y.
add(double, Complex[]). Static method in class VisualNumerics.math.ComplexVector
Add a scalar of type double to each element of the vector, zi + b for all values of the index i.
add(double, double[]). Static method in class VisualNumerics.math.DoubleVector
Add a scalar to each element of the vector.
add(double[], Complex[]). Static method in class VisualNumerics.math.ComplexVector
Add a double vector to a Complex vector.
add(double[], double[]). Static method in class VisualNumerics.math.DoubleVector
Calculate the sum of two vectors, v1 + v2.
add(double[][], double[][]). Static method in class VisualNumerics.math.DoubleMatrix
Add two rectangular arrays, a + b.
adjoint(Complex[][]). Static method in class VisualNumerics.math.ComplexMatrix
Return the adjoint of the matrix.
argument(Complex). Static method in class VisualNumerics.math.Complex
Returns the argument (phase) of a Complex, in radians.
asin(Complex). Static method in class VisualNumerics.math.Complex
asinh(double). Static method in class VisualNumerics.math.Sfun
Returns the inverse (arc) hyperbolic sine.
atanh(double). Static method in class VisualNumerics.math.Sfun
Returns the inverse (arc) hyperbolic tangent.
average(double[]). Static method in class VisualNumerics.math.Statistics
Returns the average (mean).

C

Complex(). Constructor for class VisualNumerics.math.Complex
Construct a Complex equal to zero.
Complex(Complex). Constructor for class VisualNumerics.math.Complex
Construct a Complex equal to the argument.
Complex(double). Constructor for class VisualNumerics.math.Complex
Construct a Complex with a zero imaginary part.
Complex(double, double). Constructor for class VisualNumerics.math.Complex
Construct a Complex with real and imaginary parts given by the input arguments.
ComplexCholesky(Complex[][]). Constructor for class VisualNumerics.math.ComplexCholesky
Construct the Cholesky decomposition of a Complex Hermitian positive definite matrix.
ComplexLU(Complex[][]). Constructor for class VisualNumerics.math.ComplexLU
Create the LU factorization of a square Complex matrix.
ComplexQR(Complex[][]). Constructor for class VisualNumerics.math.ComplexQR
Construct the QR decomposition of a Complex matrix.
ComplexSVD(Complex[][]). Constructor for class VisualNumerics.math.ComplexSVD
Create the ComplexSVD of a rectangular matrix with default tolerance.
ComplexSVD(Complex[][], double). Constructor for class VisualNumerics.math.ComplexSVD
Create the ComplexSVD of a rectangular matrix with a given tolerance.
condition(). Static method in class VisualNumerics.math.ComplexCholesky
Return an estimate of the reciprocal of the L1 condition number of the Complex matrix used to construct this instance.
condition(). Method in class VisualNumerics.math.ComplexLU
Return an estimate of the reciprocal of the L1 condition number of the Complex matrix used to construct this instance.
condition(). Method in class VisualNumerics.math.DoubleCholesky
Return an estimate of the reciprocal of the L1 condition number of the matrix used to construct this instance.
condition(). Method in class VisualNumerics.math.DoubleLU
Return an estimate of the reciprocal of the L1 condition number of the matrix used to construct this instance.
conjugate(Complex). Static method in class VisualNumerics.math.Complex
Returns the complex conjugate of a Complex.
conjugate(Complex[]). Static method in class VisualNumerics.math.ComplexVector
Return the complex conjugate of each Complex object in the array.
cos(Complex). Static method in class VisualNumerics.math.Complex
Returns the cosine of a Complex.
cosh(double). Static method in class VisualNumerics.math.Sfun
Returns the hyperbolic cosine.
cot(double). Static method in class VisualNumerics.math.Sfun
Returns the cotangent.

D

determinant(). Static method in class VisualNumerics.math.ComplexCholesky
Return the determinant of the matrix used to construct this instance.
determinant(). Method in class VisualNumerics.math.ComplexLU
Return the determinant of the matrix used to construct this instance.
determinant(). Method in class VisualNumerics.math.DoubleCholesky
Return the determinant of the matrix used to construct this object.
determinant(). Method in class VisualNumerics.math.DoubleLU
Return the determinant of the matrix used to construct this instance.
determinant(Complex[][]). Static method in class VisualNumerics.math.ComplexMatrix
Return the determinant of the matrix from its LU factorization.
determinant(double[][]). Static method in class VisualNumerics.math.DoubleMatrix
Return the determinant of the matrix from its LU factorization.
divide(Complex). Method in class VisualNumerics.math.Complex
Divides by a Complex and returns the result, this /= y.
divide(Complex, Complex). Static method in class VisualNumerics.math.Complex
Returns Complex x divided by Complex y, x/y.
divide(Complex, double). Static method in class VisualNumerics.math.Complex
Returns a Complex divided by a double, x/y.
divide(double). Method in class VisualNumerics.math.Complex
Divides by a double and returns the result, this /= y.
DoubleCholesky(double[][]). Constructor for class VisualNumerics.math.DoubleCholesky
Construct the Cholesky decomposition of a positive definite matrix with elements of type double.
DoubleLU(double[][]). Constructor for class VisualNumerics.math.DoubleLU
Create the LU factorization of a square matrix of type double.
DoubleQR(double[][]). Constructor for class VisualNumerics.math.DoubleQR
Construct the QR decomposition of a matrix with elements of type double.
DoubleSVD(double[][]). Constructor for class VisualNumerics.math.DoubleSVD
Construct the singular value decomposition of a rectangular matrix with default tolerance.
DoubleSVD(double[][], double). Constructor for class VisualNumerics.math.DoubleSVD
Construct the singular value decomposition of a rectangular matrix with a given tolerance.

E

EPSILON_LARGE. Static variable in class VisualNumerics.math.Sfun
The largest relative spacing for doubles.
EPSILON_SMALL. Static variable in class VisualNumerics.math.Sfun
The smallest relative spacing for doubles.
equals(Complex). Method in class VisualNumerics.math.Complex
Compares this Complex with another.
equals(Object). Method in class VisualNumerics.math.Complex
Compares this object against the specified object.
erf(double). Static method in class VisualNumerics.math.Sfun
Returns the error function.
erfc(double). Static method in class VisualNumerics.math.Sfun
Returns the complementary error function.
Euler. Static variable in class VisualNumerics.math.Sfun
Euler's Constant.
exp(Complex). Static method in class VisualNumerics.math.Complex
Returns the exponential of a Complex z, exp(z).

F

FCdf(double, double, double). Static method in class VisualNumerics.math.Statistics
Returns the value of the cummulative F distribution function.
frobeniusNorm(Complex[][]). Static method in class VisualNumerics.math.ComplexMatrix
Return the frobenius norm of a matrix.
frobeniusNorm(double[][]). Static method in class VisualNumerics.math.DoubleMatrix
Return the frobenius norm of a matrix.

G

gamma(double). Static method in class VisualNumerics.math.Sfun
Returns the gamma function.

I

im. Variable in class VisualNumerics.math.Complex
Imaginary part of the Complex.
imag(Complex[]). Static method in class VisualNumerics.math.ComplexVector
Return the imaginary part of each Complex element of the array.
INFINITY. Static variable in class VisualNumerics.math.Complex
Complex infinity.
infinityNorm(Complex[]). Static method in class VisualNumerics.math.ComplexVector
Calculate the infinity norm of a vector.
infinityNorm(Complex[][]). Static method in class VisualNumerics.math.ComplexMatrix
Return the infinity norm of a matrix.
infinityNorm(double[]). Static method in class VisualNumerics.math.DoubleVector
Calculate the infinity norm of a vector.
infinityNorm(double[][]). Static method in class VisualNumerics.math.DoubleMatrix
Return the infinity norm of a matrix.
info(). Method in class VisualNumerics.math.ComplexSVD
Return convergence information about S, U, and V.
info(). Method in class VisualNumerics.math.DoubleSVD
Return convergence information about S, U, and V.
innerProduct(Complex[], Complex[]). Static method in class VisualNumerics.math.ComplexVector
Calculate the dot product of two vectors.
innerProduct(double[], double[]). Static method in class VisualNumerics.math.DoubleVector
Calculate the dot product of two vectors.
inverse(). Static method in class VisualNumerics.math.ComplexCholesky
Return the inverse of the matrix used to construct this instance.
inverse(). Method in class VisualNumerics.math.ComplexLU
Return the inverse of the matrix used to construct this instance.
inverse(). Method in class VisualNumerics.math.ComplexSVD
Compute the generalized inverse of a real matrix.
inverse(). Method in class VisualNumerics.math.DoubleCholesky
Construct the inverse of this object using information from its Cholesky factorization.
inverse(). Method in class VisualNumerics.math.DoubleLU
Compute the inverse of a matrix of type double.
inverse(). Method in class VisualNumerics.math.DoubleSVD
Compute the generalized inverse of a real matrix.
inverse(Complex[][]). Static method in class VisualNumerics.math.ComplexMatrix
Return the inverse of the matrix a using its LU factorization.
inverse(double[][]). Static method in class VisualNumerics.math.DoubleMatrix
Return the inverse of the matrix a using its LU factorization.
inverseFCdf(double, double, double). Static method in class VisualNumerics.math.Statistics
Returns the inverse of the cummulative F distribution function.
inverseNormalCdf(double). Static method in class VisualNumerics.math.Statistics
Returns the inverse of the cummulative normal (Gaussian) distribution function.
inverseTCdf(double, double). Static method in class VisualNumerics.math.Statistics
ipvt(). Method in class VisualNumerics.math.ComplexLU
Return a vector containing information for the LU factorization of the matrix.
ipvt(). Method in class VisualNumerics.math.ComplexQR
Return an integer vector containing information about the permutation of the elements of A during pivoting.
ipvt(). Method in class VisualNumerics.math.DoubleLU
Return a vector containing the pivoting information from the LU factorization.
ipvt(). Method in class VisualNumerics.math.DoubleQR
Return an integer vector containing information about the permutation of the elements of the matrix during pivoting.
isInfinite(Complex). Static method in class VisualNumerics.math.Complex
Returns true if either component is an infinite value.
isNaN(Complex). Static method in class VisualNumerics.math.Complex
Returns true if either component is a Not-a-Number (NaN) value.

K

kurtosis(double[]). Static method in class VisualNumerics.math.Statistics
Returns the kurtosis.

L

linearFit(double[], double[]). Static method in class VisualNumerics.math.Statistics
Returns the the best least squares fit of a line through the data.
log(Complex). Static method in class VisualNumerics.math.Complex
Returns the logarithm of a Complex z, log(z).
log10(double). Static method in class VisualNumerics.math.Sfun
Returns the base 10 logarithm.
logGamma(double). Static method in class VisualNumerics.math.Sfun
Returns the logarithm gamma function.

M

MathException(). Constructor for class VisualNumerics.math.MathException
Constructs an MathException with no detail message.
MathException(String). Constructor for class VisualNumerics.math.MathException
Constructs an MathException with the specified detail message.
maximum(double[]). Static method in class VisualNumerics.math.Statistics
Returns the maximum value.
median(double[]). Static method in class VisualNumerics.math.Statistics
Returns the median value.
minimum(double[]). Static method in class VisualNumerics.math.Statistics
Returns the minimum value.
multiply(Complex). Method in class VisualNumerics.math.Complex
Multiplies by a Complex and returns the product, this *= y.
multiply(Complex, Complex). Static method in class VisualNumerics.math.Complex
Returns the product of two Complexs, x*y.
multiply(Complex, Complex[]). Static method in class VisualNumerics.math.ComplexVector
Multiply a Complex vector by a Complex scalar, zi * b for all values of the index i.
multiply(Complex, double). Static method in class VisualNumerics.math.Complex
Returns the product of a Complex and a double, x*y.
multiply(Complex[], Complex[]). Static method in class VisualNumerics.math.ComplexVector
Multiply a Complex vector by a Complex vector.
multiply(Complex[], Complex[][]). Static method in class VisualNumerics.math.ComplexMatrix
Return the product of the row vector x and the rectangular array a.
multiply(Complex[][], Complex[]). Static method in class VisualNumerics.math.ComplexMatrix
Multiply the rectangular array a and the column vector x.
multiply(Complex[][], Complex[][]). Static method in class VisualNumerics.math.ComplexMatrix
Multiply two rectangular arrays, a * b.
multiply(double). Method in class VisualNumerics.math.Complex
Multiplies by a double and returns the product, this *= y.
multiply(double, Complex). Static method in class VisualNumerics.math.Complex
Returns the product of a double and a Complex, x*y.
multiply(double, Complex[]). Static method in class VisualNumerics.math.ComplexVector
Multiply a Complex vector by a scalar of type double, zi * b for all values of the index i.
multiply(double, double[]). Static method in class VisualNumerics.math.DoubleVector
Multiply a vector by a scalar.
multiply(double[], Complex[]). Static method in class VisualNumerics.math.ComplexVector
Multiply a Complex vector by a double vector.
multiply(double[], double[]). Static method in class VisualNumerics.math.DoubleVector
Calculate the product of corresponding elements in the input vectors.
multiply(double[], double[][]). Static method in class VisualNumerics.math.DoubleMatrix
Return the product of the row vector x and the rectangular array a.
multiply(double[][], double[]). Static method in class VisualNumerics.math.DoubleMatrix
Multiply the rectangular array a and the column vector x.
multiply(double[][], double[][]). Static method in class VisualNumerics.math.DoubleMatrix
Multiply two rectangular arrays, a * b.

N

nearestInteger(double). Static method in class VisualNumerics.math.Sfun
Returns the nearest integer.
negate(Complex). Static method in class VisualNumerics.math.Complex
Returns the negative of a Complex, -z.
normalCdf(double). Static method in class VisualNumerics.math.Statistics
Returns the value of the cummulative normal (Gaussian) distribution function.

O

oneNorm(Complex[]). Static method in class VisualNumerics.math.ComplexVector
Calculate the one norm of a vector.
oneNorm(Complex[][]). Static method in class VisualNumerics.math.ComplexMatrix
Return the matrix one norm.
oneNorm(double[]). Static method in class VisualNumerics.math.DoubleVector
Calculate the one norm of a vector.
oneNorm(double[][]). Static method in class VisualNumerics.math.DoubleMatrix
Return the matrix one norm.

P

pow(Complex, Complex). Static method in class VisualNumerics.math.Complex
Returns the Complex x raised to the Complex y power.
pow(Complex, double). Static method in class VisualNumerics.math.Complex
Returns the Complex z raised to the x power.
product(Complex[]). Static method in class VisualNumerics.math.ComplexVector
Calculate the product of the array elements.
product(double[]). Static method in class VisualNumerics.math.DoubleVector
Calculate the product of the array elements.

Q

Q(). Method in class VisualNumerics.math.ComplexQR
Return the orthogonal or unitary matrix Q.
Q(). Method in class VisualNumerics.math.DoubleQR
Return the orthogonal or unitary matrix Q.
QRsolve(Complex[][], Complex[]). Static method in class VisualNumerics.math.ComplexMatrix
Solve ax=b for x, using the QR decomposition of a.
QRsolve(double[][], double[]). Static method in class VisualNumerics.math.DoubleMatrix
Solve ax=b for x, using the QR decomposition of a.

R

R(). Static method in class VisualNumerics.math.ComplexCholesky
Return the Cholesky factorization of the Complex Hermitian positive definite matrix used to construct this instance.
R(). Method in class VisualNumerics.math.ComplexQR
Return the upper trapezoidal matrix R.
R(). Method in class VisualNumerics.math.DoubleCholesky
Return the Cholesky factor of this object.
R(). Method in class VisualNumerics.math.DoubleQR
Return the upper trapezoidal matrix R.
range(double[]). Static method in class VisualNumerics.math.Statistics
Returns the range (xmax-xmin).
rank(). Method in class VisualNumerics.math.ComplexQR
Return the rank of the matrix.
rank(). Method in class VisualNumerics.math.ComplexSVD
Return the rank of the matrix used to construct this instance.
rank(). Method in class VisualNumerics.math.DoubleQR
Return the rank of the matrix used to construct this instance.
rank(). Method in class VisualNumerics.math.DoubleSVD
Return the rank of the matrix used to construct this instance.
rank(double). Method in class VisualNumerics.math.ComplexQR
Return the rank of the matrix using an input tolerance.
rank(double). Method in class VisualNumerics.math.DoubleQR
Return the rank of the matrix given an input tolerance.
re. Variable in class VisualNumerics.math.Complex
Real part of the Complex.
real(Complex[]). Static method in class VisualNumerics.math.ComplexVector
Return the real part of each Complex element of the array.

S

S(). Method in class VisualNumerics.math.ComplexSVD
Return the singular values of the matrix used to construct this instance in decreasing order of magnitude.
S(). Method in class VisualNumerics.math.DoubleSVD
Return the singular values of the matrix used to construct this instance in decreasing order of magnitude.
sign(double, double). Static method in class VisualNumerics.math.Sfun
Returns the value of x with the sign of y.
sin(Complex). Static method in class VisualNumerics.math.Complex
Returns the sine of a Complex.
sinh(double). Static method in class VisualNumerics.math.Sfun
Returns the hyperbolic sine.
skew(double[]). Static method in class VisualNumerics.math.Statistics
Returns the skew.
slope(double[], double[]). Static method in class VisualNumerics.math.Statistics
Returns the the slope of the best least squares fit of a line passing through the origin to the data.
solve(Complex[]). Static method in class VisualNumerics.math.ComplexCholesky
Solve a complex Hermitian positive definite system of linear equations.
solve(Complex[]). Method in class VisualNumerics.math.ComplexLU
Return the solution x of the linear system Ax=b using the LU factorization of A.
solve(Complex[]). Method in class VisualNumerics.math.ComplexQR
Calculate the solution to the least-squares problem Ax = b using information about the QR factorization of A.
solve(Complex[], double). Method in class VisualNumerics.math.ComplexQR
Calculate the solution to the least-squares problem Ax = b using information about the QR factorization of A and input tolerance.
solve(Complex[][], Complex[]). Static method in class VisualNumerics.math.ComplexMatrix
Solve ax=b for x using the LU factorization of a.
solve(double[]). Method in class VisualNumerics.math.DoubleCholesky
Solve Ax = b where A is a positive definite matrix with elements of type double.
solve(double[]). Method in class VisualNumerics.math.DoubleLU
Return the solution x of the linear system Ax = b using the LU factorization of A.
solve(double[]). Method in class VisualNumerics.math.DoubleQR
Calculate the solution to the least-squares problem Ax = b using information about the QR factorization of A.
solve(double[], double). Method in class VisualNumerics.math.DoubleQR
Calculate the solution to the least-squares problem Ax = b using information about the QR factorization of A and an input tolerance.
solve(double[][], double[]). Static method in class VisualNumerics.math.DoubleMatrix
Solve ax=b for x using the LU factorization of a.
sqrt(Complex). Static method in class VisualNumerics.math.Complex
Returns the square root of a Complex.
standardDeviation(double[]). Static method in class VisualNumerics.math.Statistics
Returns the sample standard deviation.
subtract(Complex). Method in class VisualNumerics.math.Complex
Subtracts a Complex and returns the difference, this -= y.
subtract(Complex, Complex). Static method in class VisualNumerics.math.Complex
Returns the difference of two Complexes, x-y.
subtract(Complex, double). Static method in class VisualNumerics.math.Complex
Returns the difference of a Complex and a double, x-y.
subtract(Complex[], Complex). Static method in class VisualNumerics.math.ComplexVector
Subtract a Complex scalar from a Complex vector, zi - b, for all values of the index i.
subtract(Complex[], Complex[]). Static method in class VisualNumerics.math.ComplexVector
Subtract a Complex vector from a Complex vector, b - z.
subtract(Complex[], double). Static method in class VisualNumerics.math.ComplexVector
Subtract a scalar of type double from a Complex vector, zi - b for all values of the index i.
subtract(Complex[], double[]). Static method in class VisualNumerics.math.ComplexVector
Subtract a double vector from a Complex vector, z - b.
subtract(Complex[][], Complex[][]). Static method in class VisualNumerics.math.ComplexMatrix
Take the difference between two arrays, a - b.
subtract(double). Method in class VisualNumerics.math.Complex
Subtracts a double and returns the difference, this -= y.
subtract(double, Complex). Static method in class VisualNumerics.math.Complex
Returns the difference of a double and a Complex, x-y.
subtract(double[], Complex[]). Static method in class VisualNumerics.math.ComplexVector
Subtract a Complex vector from a double vector, b - z.
subtract(double[], double[]). Static method in class VisualNumerics.math.DoubleVector
Calculate the difference between corresponding elements of two vectors, v1 - v2.
subtract(double[][], double[][]). Static method in class VisualNumerics.math.DoubleMatrix
Take the difference between two arrays, a - b.
suffix. Static variable in class VisualNumerics.math.Complex
String used in converting Complex to String.
sum(Complex[]). Static method in class VisualNumerics.math.ComplexVector
Calculate the sum of the array elements.
sum(double[]). Static method in class VisualNumerics.math.DoubleVector
Calculate the sum of the array elements.

T

tan(Complex). Static method in class VisualNumerics.math.Complex
tanh(double). Static method in class VisualNumerics.math.Sfun
Returns the hyperbolic tangent.
tCdf(double, double). Static method in class VisualNumerics.math.Statistics
toString(). Method in class VisualNumerics.math.Complex
Returns a String representation for the specified Complex.
trace(Complex[][]). Static method in class VisualNumerics.math.ComplexMatrix
Return the sum of the diagonal elements.
trace(double[][]). Static method in class VisualNumerics.math.DoubleMatrix
Return the sum of the diagonal elements.
transpose(Complex[][]). Static method in class VisualNumerics.math.ComplexMatrix
Return the transpose of a matrix.
transpose(double[][]). Static method in class VisualNumerics.math.DoubleMatrix
Return the transpose of a matrix.
twoNorm(Complex[]). Static method in class VisualNumerics.math.ComplexVector
Calculate the Euclidean or two norm of a vector.
twoNorm(double[]). Static method in class VisualNumerics.math.DoubleVector
Calculate the Euclidean or two norm of a vector.

U

U(). Method in class VisualNumerics.math.ComplexSVD
Return the left singular vectors resulting from the singular value decomposition of the matrix used to construct this instance.
U(). Method in class VisualNumerics.math.DoubleSVD
Return the left singular vectors resulting from the singular value decomposition of the matrix used to construct this instance.

V

V(). Method in class VisualNumerics.math.ComplexSVD
Return the right singular vectors resulting from the singular value decomposition of the matrix used to construct this instance.
V(). Method in class VisualNumerics.math.DoubleSVD
Return the right singular vectors resulting from the singular value decomposition of the matrix used to construct this instance.
variance(double[]). Static method in class VisualNumerics.math.Statistics
Returns the sample variance.