A B C D E G I J K L M N O P Q R S T U V

A

addColumn(int, double, double[]) - Method in class mpv2.AllMatrices
Add a column of the matrix multiplied by a factor to y, set y[n] = y[n] + s*A[n][k].
addColumn(int, double, double[]) - Method in class mpv2.BandMatrix
Add a column of the matrix multiplied by a factor to a given vector.
addColumn(int, double, double[]) - Method in class mpv2.DiagonalMatrix
Add a column of the matrix multiplied by a factor to x, x = x + A[][k] Legal range of the integer argument is 0 <= k < K.
addColumn(int, double, double[]) - Method in class mpv2.SimpleMatrix
Add a column of the matrix multiplied by a factor to x, x = x + A[][k] Legal range of the integer argument is 0 <= k < K.
addColumn(int, double, double[]) - Method in class mpv2.SparseMatrix
Add a column of the matrix multiplied by a factor to x, x = x + A[][k] Legal range of the integer argument is 0 <= k < K.
addColumn(int, double, double[]) - Method in class mpv2.SparseVectorMatrix
Add a column of the matrix multiplied by a factor to a given vector.
addToArray(double, double[]) - Method in class mpv2.SparseVector
Add this sparse vector multiplied by a factor to the given array.
AllMatrices - Class in mpv2
mpv2 = Matrix package version 2 The abstract class AllMatrices contains common stuff for several kinds of matrices.
AllMatrices() - Constructor for class mpv2.AllMatrices
 
arrayLeftDivide(JamaMatrix) - Method in class mpv2.JamaMatrix
Element-by-element left division, C = A.
arrayLeftDivideEquals(JamaMatrix) - Method in class mpv2.JamaMatrix
Element-by-element left division in place, A = A.
arrayRightDivide(JamaMatrix) - Method in class mpv2.JamaMatrix
Element-by-element right division, C = A.
arrayRightDivideEquals(JamaMatrix) - Method in class mpv2.JamaMatrix
Element-by-element right division in place, A = A.
arrayTimes(JamaMatrix) - Method in class mpv2.JamaMatrix
Element-by-element multiplication, C = A.
arrayTimesEquals(JamaMatrix) - Method in class mpv2.JamaMatrix
Element-by-element multiplication in place, A = A.

B

BandMatrix - Class in mpv2
This class is a band diagonal matrix implementation of the AllMatrices superclass.
BandMatrix(int, int) - Constructor for class mpv2.BandMatrix
Construct a N×K matrix with only zero values.
BandMatrix(int, int, double[]) - Constructor for class mpv2.BandMatrix
Construct a N×K matrix or dictionary with values from given one-dimensional array (which represents the matrix).
BandMatrix(double[][]) - Constructor for class mpv2.BandMatrix
Construct a matrix from a 2-D array.
BlockMatrix - Class in mpv2
This is a block matrix consisting of four submatrices, Matlab-notation: [ A, B; C, D].
BlockMatrix(AllMatrices, AllMatrices, AllMatrices, AllMatrices) - Constructor for class mpv2.BlockMatrix
Construct a Block matrix with four submatrices, [A, B; C, D].
BMP - Static variable in class mpv2.DictionaryLearning
 

C

checkNormalized() - Method in class mpv2.MatchingPursuit
Check if dictionary is normalized, and update the normalized indicator.
chol() - Method in class mpv2.AllMatrices
Cholesky Decomposition
chol() - Method in class mpv2.JamaMatrix
Cholesky Decomposition
CholeskyDecomposition - Class in mpv2
Cholesky Decomposition.
CholeskyDecomposition(JamaMatrix) - Constructor for class mpv2.CholeskyDecomposition
Cholesky algorithm for symmetric and positive definite matrix.
clearNormalized() - Method in class mpv2.MatchingPursuit
Clear dictionary normalized indicator, set it to false, without checking.
clone() - Method in class mpv2.DiagonalMatrix
Clone the Matrix object.
clone() - Method in class mpv2.JamaMatrix
Clone the JamaMatrix object.
clone() - Method in class mpv2.PermutationMatrix
Clone the Matrix object.
clone() - Method in class mpv2.SimpleMatrix
Clone the Matrix object.
clone() - Method in class mpv2.SparseVector
Clone the SparseVector object.
clone() - Method in class mpv2.SymmetricMatrix
Clone the Matrix object.
columnNorm0(int) - Method in class mpv2.AllMatrices
The pseudo-zero-norm for a given column
columnNorm1(int) - Method in class mpv2.AllMatrices
One columnNorm for a given column
columnNorm2(int) - Method in class mpv2.AllMatrices
Two columnNorm for a given column
columnNormInf(int) - Method in class mpv2.AllMatrices
Inf columnNorm for a given column
cond() - Method in class mpv2.AllMatrices
Matrix condition (2 norm)
cond() - Method in class mpv2.DiagonalMatrix
Matrix condition (2 norm)
cond() - Method in class mpv2.JamaMatrix
Matrix condition (2 norm)
cond() - Method in class mpv2.PermutationMatrix
Matrix condition (2 norm)
cond() - Method in class mpv2.SingularValueDecomposition
Two norm condition number
constructWithCopy(double[][]) - Static method in class mpv2.JamaMatrix
Construct a matrix from a copy of a 2-D array.
copy() - Method in class mpv2.DiagonalMatrix
Make a deep copy of a matrix
copy() - Method in class mpv2.JamaMatrix
Make a deep copy of a matrix
copy() - Method in class mpv2.PermutationMatrix
Make a deep copy of a matrix
copy() - Method in class mpv2.SimpleMatrix
Make a deep copy of a matrix
copy() - Method in class mpv2.SparseVector
Make a deep copy of a SparseVector.
copy() - Method in class mpv2.SymmetricMatrix
Make a deep copy of a matrix

D

det() - Method in class mpv2.AllMatrices
Matrix determinant
det() - Method in class mpv2.DiagonalMatrix
Matrix determinant
det() - Method in class mpv2.JamaMatrix
Matrix determinant
det() - Method in class mpv2.LUDecomposition
Determinant
det() - Method in class mpv2.LUPDecomposition
Determinant
det() - Method in class mpv2.PermutationMatrix
Matrix determinant
DiagonalMatrix - Class in mpv2
This is a diagonal matrix class made by implementing AllMatrices.
DiagonalMatrix(int) - Constructor for class mpv2.DiagonalMatrix
Construct an n-by-n diagonal matrix of zeros.
DiagonalMatrix(int, double) - Constructor for class mpv2.DiagonalMatrix
Construct an n-by-n diagonal matrix with constant value in each element
DiagonalMatrix(double[][]) - Constructor for class mpv2.DiagonalMatrix
Construct a diagonal matrix from a 2-D array, only values in the diagonal are copied.
DiagonalMatrix(double[]) - Constructor for class mpv2.DiagonalMatrix
Construct a diagonal matrix from a one-dimensional array
DiagonalMatrix(AllMatrices) - Constructor for class mpv2.DiagonalMatrix
Construct a diagonal matrix from another matrix (of any kind) by extracting the elements on the diagonal.
DictionaryLearning - Class in mpv2
 
DictionaryLearning(AllMatrices, boolean, int) - Constructor for class mpv2.DictionaryLearning
Instantiate an object of this class by giving initial dictionary.
DictionaryLearning(AllMatrices, boolean) - Constructor for class mpv2.DictionaryLearning
 

E

eig() - Method in class mpv2.AllMatrices
Eigenvalue Decomposition
eig() - Method in class mpv2.JamaMatrix
Eigenvalue Decomposition
EigenvalueDecomposition - Class in mpv2
Eigenvalues and eigenvectors of a real matrix.
EigenvalueDecomposition(JamaMatrix) - Constructor for class mpv2.EigenvalueDecomposition
Check for symmetry, then construct the eigenvalue decomposition Constructor returns a structure to access D and V.
eqConstant(double) - Method in class mpv2.AllMatrices
Set the matrix (this = A) to a constant s, A = s.
eqCopy(AllMatrices) - Method in class mpv2.AllMatrices
Set the matrix (this = A) to B, A = B.
eqCopy(AllMatrices, int, int, int, int) - Method in class mpv2.AllMatrices
Set the matrix (this = A) to a submatrix of B, A = B(i0:i1, j0:j1).
eqCopy(AllMatrices, int[], int[]) - Method in class mpv2.AllMatrices
Set the matrix (this = A) to a submatrix of B, A = B(r[], c[]).
eqCopy(AllMatrices, int, int, int[]) - Method in class mpv2.AllMatrices
Set the matrix (this = A) to a submatrix of B, A = B(i0:i1, c[]).
eqCopy(AllMatrices, int[], int, int) - Method in class mpv2.AllMatrices
Set the matrix (this = A) to a submatrix of B, A = B(r[], j0:j1).
eqDifference(AllMatrices, AllMatrices) - Method in class mpv2.AllMatrices
Set the matrix (this = A) to difference of B and C, A = B - C.
eqEProduct(AllMatrices, AllMatrices) - Method in class mpv2.AllMatrices
Set the matrix (this = A) to elementwise multiplication of B and C, A = B.
eqEQuotient(AllMatrices, AllMatrices) - Method in class mpv2.AllMatrices
Set the matrix (this = A) to elementwise division of B and C, A = B.
eqIdentity() - Method in class mpv2.AllMatrices
Set the matrix (this = A) to identity, A = I.
eqInnerProductMatrix(AllMatrices) - Method in class mpv2.SymmetricMatrix
Set inner-products of matrix B into this, i.e.
eqInverse(AllMatrices) - Method in class mpv2.AllMatrices
Set the matrix (this = A) to the inverse of B, A = inv(B) Matrix dimension must agree, if A is N-by-K then B is K-by-N If the (normal) inverse does not exist, then the Moore-Penrose pseudoivnverse should be returned
eqIProduct(AllMatrices, AllMatrices) - Method in class mpv2.AllMatrices
Set the matrix (this = X) to product of A inverse and B, X = inv(A) * B.
eqNegate(AllMatrices) - Method in class mpv2.AllMatrices
Set the matrix (this = A) to the negative of B, A = -B.
eqOnes() - Method in class mpv2.AllMatrices
Set the matrix (this = A) to ones, A = 1.
eqPermuteColumns(AllMatrices, PermutationMatrix) - Method in class mpv2.AllMatrices
Permute the columns of matrix B and put result in this, A = B * P.
eqPermuteColumns(AllMatrices, PermutationMatrix) - Method in class mpv2.SymmetricMatrix
Permute the columns of matrix B and put result in this, A = B * P.
eqPermuteRows(PermutationMatrix, AllMatrices) - Method in class mpv2.AllMatrices
Permute the rows of matrix B and put result in this, A = P * B.
eqPermuteRows(PermutationMatrix, AllMatrices) - Method in class mpv2.SymmetricMatrix
Permute the rows of matrix B and put result in this, A = P * B.
eqProduct(AllMatrices, double) - Method in class mpv2.AllMatrices
Set the matrix (this = A) to B*s, A = B*s.
eqProduct(AllMatrices, AllMatrices) - Method in class mpv2.AllMatrices
Set the matrix (this = A) to product of B and C, A = B * C.
eqProduct(AllMatrices, double) - Method in class mpv2.SymmetricMatrix
Set the matrix (this = A) to B*s, A = B*s.
eqRandom() - Method in class mpv2.AllMatrices
Set the matrix (this = A) to random elements, A = rand.
eqScaleColumns(AllMatrices, DiagonalMatrix) - Method in class mpv2.AllMatrices
Scale the columns of matrix B and put result in this, A = B * D.
eqScaleColumns(AllMatrices, DiagonalMatrix) - Method in class mpv2.SymmetricMatrix
Scale the columns of matrix B and put result in this, A = B * D.
eqScaleRows(DiagonalMatrix, AllMatrices) - Method in class mpv2.AllMatrices
Scale the rows of matrix B and put result in this, A = D * B.
eqScaleRows(DiagonalMatrix, AllMatrices) - Method in class mpv2.SymmetricMatrix
Scale the rows of matrix B and put result in this, A = D * B.
eqScaleRowsAndColumns(SymmetricMatrix, DiagonalMatrix) - Method in class mpv2.SymmetricMatrix
Scale the rows and columns of symmtric matrix B and put result in this, A = D * B * D.
eqScaleRowsAndColumns(DiagonalMatrix, SymmetricMatrix) - Method in class mpv2.SymmetricMatrix
Scale the rows and columns of symmtric matrix B and put result in this, A = D * B * D.
eqSum(AllMatrices, AllMatrices) - Method in class mpv2.AllMatrices
Set the matrix (this = A) to sum of B and C, A = B + C.
eqTProduct(AllMatrices, AllMatrices) - Method in class mpv2.AllMatrices
Set the matrix (this = A) to product of B transposed and C, A = B' * C.
eqTranspose(AllMatrices) - Method in class mpv2.AllMatrices
Set the matrix (this = A) to the transposed of B, A = B' Matrix dimension must agree.
eqZeros() - Method in class mpv2.AllMatrices
Set the matrix (this = A) to zeros, A = 0.

G

get(int, int) - Method in class mpv2.AllMatrices
Get a single element.
get(int, int) - Method in class mpv2.BandMatrix
Return an entry of the matrix.
get(int, int) - Method in class mpv2.BlockMatrix
Get a single element.
get(int) - Method in class mpv2.DiagonalMatrix
Get a single element, A(n,n).
get(int, int) - Method in class mpv2.DiagonalMatrix
Get a single element, A(n,k).
get(int, int) - Method in class mpv2.JamaMatrix
Get a single element.
get(int, int) - Method in class mpv2.PermutationMatrix
Get a single element, A(n,k).
get(int, int) - Method in class mpv2.RepeatBlockMatrix
Get a single element.
get(int, int) - Method in class mpv2.SimpleMatrix
Get a single element.
get(int, int) - Method in class mpv2.SparseMatrix
Get a single element.
get() - Method in class mpv2.SparseVector
Get the whole vector as an array
get(int) - Method in class mpv2.SparseVector
Get a vector element.
get(int, int) - Method in class mpv2.SparseVectorMatrix
Return an entry of the matrix.
get(int, int) - Method in class mpv2.SymmetricMatrix
Get a single element.
getAll() - Method in class mpv2.AllMatrices
Get all entries of the matrix, as a one-dimensional column-packed array.
getAll(double[]) - Method in class mpv2.AllMatrices
Get all entries of the matrix into argument vals in a column-packed way.
getAll(double[]) - Method in class mpv2.JamaMatrix
Get all entries of the matrix into argument vals in a column-packed way.
getArray() - Method in class mpv2.JamaMatrix
Access the internal two-dimensional array.
getArrayCopy() - Method in class mpv2.JamaMatrix
Copy the internal two-dimensional array.
getCapacity() - Method in class mpv2.SparseMatrix
Returns current size (capacity for non-zero values) in sparse matrix.
getColumn(int) - Method in class mpv2.AllMatrices
Get a column of the matrix.
getColumn(int, double[]) - Method in class mpv2.AllMatrices
Get a column of the matrix into argument y.
getColumn(int, double[]) - Method in class mpv2.BandMatrix
Copy a column of the matrix into argument d Legal range of the integer argument is 0 <= k < K.
getColumn(int, double[]) - Method in class mpv2.BlockMatrix
Copy a column of the matrix into argument y Legal range of the integer argument is 0 <= k < K.
getColumn(int, double[]) - Method in class mpv2.SimpleMatrix
Copy a column of the matrix into argument d Legal range of the integer argument is 0 <= k < K.
getColumn(int) - Method in class mpv2.SparseMatrix
Copy a column of the matrix Legal range of the integer argument is 0 <= k < K.
getColumn(int, double[]) - Method in class mpv2.SparseMatrix
Sets argument d to a column of the matrix, i.e. a dictionary element or atom.
getColumn(int) - Method in class mpv2.SparseVectorMatrix
Get a column in the matrix as an array
getColumn(int, double[]) - Method in class mpv2.SymmetricMatrix
Copy a column of the matrix into argument d Legal range of the integer argument is 0 <= k < K.
getColumnDimension() - Method in class mpv2.AllMatrices
Get column dimension.
getColumnDimension() - Method in class mpv2.JamaMatrix
Get column dimension.
getColumnPackedCopy() - Method in class mpv2.JamaMatrix
Make a one-dimensional column packed copy of the internal array.
getColumnPackedCopy() - Method in class mpv2.SparseMatrix
Make a one-dimensional column packed copy of the matrix.
getD() - Method in class mpv2.EigenvalueDecomposition
Return the block diagonal eigenvalue matrix
getDictionary() - Method in class mpv2.DictionaryLearning
 
getDoublePivot() - Method in class mpv2.LUDecomposition
Return pivot permutation vector as a one-dimensional double array
getH() - Method in class mpv2.QRDecomposition
Return the Householder vectors
getImagEigenvalues() - Method in class mpv2.EigenvalueDecomposition
Return the imaginary parts of the eigenvalues
getIndexW() - Method in class mpv2.DictionaryLearning
 
getIndices() - Method in class mpv2.SparseVector
Access the non-zero indices
getInnerProductMatrix() - Method in class mpv2.DictionaryLearning
 
getK() - Method in class mpv2.AllMatrices
Get number of columns in the matrix, i.e. length of each row vector.
getK() - Method in class mpv2.LUPDecomposition
Get number of columns in the original matrix A, i.e. length of each row vector.
getL() - Method in class mpv2.CholeskyDecomposition
Return triangular factor.
getL() - Method in class mpv2.LUDecomposition
Return lower triangular factor
getLambda() - Method in class mpv2.DictionaryLearning
Calculate and return lambda, the forgetting factor.
getLambda(double) - Method in class mpv2.DictionaryLearning
Calculate and return lambda, the forgetting factor.
getLArray() - Method in class mpv2.LUPDecomposition
Return lower triangular factor as a column-ordered array of length N*M.
getLength() - Method in class mpv2.SparseVector
Returns the lengt of the sparse vector
getLMatrix() - Method in class mpv2.LUPDecomposition
Return lower triangular factor as a BandMatrix object.
getM() - Method in class mpv2.LUPDecomposition
Get number of columns in L and rows in U.
getMatrix(int, int, int, int) - Method in class mpv2.JamaMatrix
Get a submatrix.
getMatrix(int[], int[]) - Method in class mpv2.JamaMatrix
Get a submatrix.
getMatrix(int, int, int[]) - Method in class mpv2.JamaMatrix
Get a submatrix.
getMatrix(int[], int, int) - Method in class mpv2.JamaMatrix
Get a submatrix.
getMPMet() - Method in class mpv2.DictionaryLearning
 
getN() - Method in class mpv2.AllMatrices
Get number of rows in the matrix, i.e. length of each column vector.
getN() - Method in class mpv2.LUPDecomposition
Get number of rows in the original matrix A, i.e. length of each column vector.
getN() - Method in class mpv2.SparseVector
Returns the lengt of the sparse vector
getNonZeroCount() - Method in class mpv2.SparseMatrix
Returns number of non-zeros elements in sparse matrix.
getNonZeroCount() - Method in class mpv2.SparseVector
Returns number of non-zeros elements in sparse matrix.
getNormalized() - Method in class mpv2.MatchingPursuit
Get dictionary normalized indicator without checking dictionary.
getNoTV() - Method in class mpv2.DictionaryLearning
 
getPivot() - Method in class mpv2.LUDecomposition
Return pivot permutation vector
getPivot() - Method in class mpv2.LUPDecomposition
Return pivot permutation vector, P(n,k)=1 when p[n]=k.
getPmatrix() - Method in class mpv2.LUPDecomposition
Return the permutation matrix, P as a PermutationMatrix object.
getPos() - Method in class mpv2.PermutationMatrix
Access the internal array pos, we have A(n,k)==1 <=> pos[n]==k.
getQ() - Method in class mpv2.QRDecomposition
Generate and return the (economy-sized) orthogonal factor
getR() - Method in class mpv2.QRDecomposition
Return the upper triangular factor
getRealEigenvalues() - Method in class mpv2.EigenvalueDecomposition
Return the real parts of the eigenvalues
getResidual() - Method in class mpv2.DictionaryLearning
 
getRow(int) - Method in class mpv2.AllMatrices
Get a row of the matrix.
getRow(int, double[]) - Method in class mpv2.AllMatrices
Get a row of the matrix into argument x.
getRow(int, double[]) - Method in class mpv2.BlockMatrix
Get a row of the matrix into argument x.
getRow(int, double[]) - Method in class mpv2.JamaMatrix
Get a row of the matrix into argument x.
getRow(int, double[]) - Method in class mpv2.SimpleMatrix
Copy a row of the matrix Legal range of the integer argument is 0 <= n < N.
getRow(int) - Method in class mpv2.SparseMatrix
Copy a row of the matrix Legal range of the integer argument is 0 <= n < N.
getRow(int, double[]) - Method in class mpv2.SparseMatrix
Copy a row of the matrix Legal range of the integer argument is 0 <= n < N.
getRow(int, double[]) - Method in class mpv2.SymmetricMatrix
Copy a row of the matrix into argument d
getRowDimension() - Method in class mpv2.AllMatrices
Get row dimension.
getRowDimension() - Method in class mpv2.JamaMatrix
Get row dimension.
getRowPackedCopy() - Method in class mpv2.JamaMatrix
Make a one-dimensional row packed copy of the internal array.
getRowPackedCopy() - Method in class mpv2.SparseMatrix
Make a one-dimensional row packed copy of the matrix.
getS() - Method in class mpv2.SingularValueDecomposition
Return the diagonal matrix of singular values
getSingularValues() - Method in class mpv2.SingularValueDecomposition
Return the one-dimensional array of singular values
getSnrTab() - Method in class mpv2.DictionaryLearning
 
getSparseColumn(int) - Method in class mpv2.SparseVectorMatrix
Get a copy of a column in the matrix as a SparseVector
getSubMatrix(int, int, int, int) - Method in class mpv2.AllMatrices
Get a one-dimensional column packed copy of a submatrix.
getSubMatrix(int[], int[]) - Method in class mpv2.AllMatrices
Get a one-dimensional column packed copy of a submatrix.
getSubMatrix(int, int, int[]) - Method in class mpv2.AllMatrices
Get a one-dimensional column packed copy of a submatrix.
getSubMatrix(int[], int, int) - Method in class mpv2.AllMatrices
Get a one-dimensional column packed copy of a submatrix.
getSubVector(int, int) - Method in class mpv2.SparseVector
Get a subvector as an array
getSumAllrrTab() - Method in class mpv2.DictionaryLearning
 
getSumAllwwTab() - Method in class mpv2.DictionaryLearning
 
getSumAllxxTab() - Method in class mpv2.DictionaryLearning
 
getSumrr() - Method in class mpv2.DictionaryLearning
 
getSumrrTab() - Method in class mpv2.DictionaryLearning
 
getSumww() - Method in class mpv2.DictionaryLearning
 
getSumwwTab() - Method in class mpv2.DictionaryLearning
 
getSumxx() - Method in class mpv2.DictionaryLearning
 
getSumxxTab() - Method in class mpv2.DictionaryLearning
 
getTheCMatrix() - Method in class mpv2.DictionaryLearning
 
getU() - Method in class mpv2.LUDecomposition
Return upper triangular factor
getU() - Method in class mpv2.SingularValueDecomposition
Return the left singular vectors
getUArray() - Method in class mpv2.LUPDecomposition
Return upper triangular factor as a column-ordered array of length M*K.
getUMatrix() - Method in class mpv2.LUPDecomposition
Return upper triangular factor as a BandMatrix object.
getV() - Method in class mpv2.EigenvalueDecomposition
Return the eigenvector matrix
getV() - Method in class mpv2.SingularValueDecomposition
Return the right singular vectors
getValue(int, int) - Method in class mpv2.AllMatrices
Get a single element, i.e. the value of an entry of the matrix.
getValues() - Method in class mpv2.SparseVector
Access the non-zero values
getValueW() - Method in class mpv2.DictionaryLearning
 
getWeights() - Method in class mpv2.DictionaryLearning
 

I

identity(int, int) - Static method in class mpv2.JamaMatrix
Generate identity matrix
identity(int) - Static method in class mpv2.PermutationMatrix
Generate identity matrix
identity(int) - Static method in class mpv2.SymmetricMatrix
Generate identity matrix
ilsdla(double[], int) - Method in class mpv2.DictionaryLearning
ILS-DLA, prosess several training vectors by Iterative Least Squares, ILS-DLA.
innerProduct(int, int) - Method in class mpv2.AllMatrices
Returns the inner product of two matrix column vectors.
innerProduct(int, int) - Method in class mpv2.BandMatrix
Returns the inner product of two matrix column vectors.
innerProduct(int, int) - Method in class mpv2.DiagonalMatrix
Returns the inner product of two matrix column vectors, which for a diagonal matrix is zero.
innerProduct(int, int) - Method in class mpv2.PermutationMatrix
Returns the inner product of two matrix column vectors, which for a diagonal matrix is zero.
innerProduct(int, int) - Method in class mpv2.SparseMatrix
Returns the inner product of two dictionary elements, i.e. matrix column vectors.
innerProduct() - Method in class mpv2.SparseVector
innerProduct of this sparse vector to itself
innerProduct(double[]) - Method in class mpv2.SparseVector
innerProduct of this and an array if lengths do not match, the shortest vector is extended with zeros
innerProduct(SparseVector) - Method in class mpv2.SparseVector
innerProduct of this and another sparse vector if lengths do not match, the shortest vector is extended with zeros
innerProduct(int, int) - Method in class mpv2.SparseVectorMatrix
Returns the inner product of two matrix column vectors.
innerProductMatrix(AllMatrices) - Static method in class mpv2.SymmetricMatrix
Generate inner-product matrix from input matrix B, i.e.
inverse() - Method in class mpv2.JamaMatrix
Matrix inverse or pseudoinverse
isFullRank() - Method in class mpv2.QRDecomposition
Is the matrix full rank?
isNonsingular() - Method in class mpv2.LUDecomposition
Is the matrix nonsingular?
isNonsingular() - Method in class mpv2.LUPDecomposition
Is the matrix nonsingular?
isSPD() - Method in class mpv2.CholeskyDecomposition
Is the matrix symmetric and positive definite?

J

JamaMatrix - Class in mpv2
Jama = Java Matrix class.
JamaMatrix(int, int) - Constructor for class mpv2.JamaMatrix
Construct an m-by-n matrix of zeros.
JamaMatrix(int, int, double) - Constructor for class mpv2.JamaMatrix
Construct an m-by-n constant matrix.
JamaMatrix(double[][]) - Constructor for class mpv2.JamaMatrix
Construct a matrix from a 2-D array.
JamaMatrix(double[][], int, int) - Constructor for class mpv2.JamaMatrix
Construct a matrix quickly without checking arguments.
JamaMatrix(double[], int) - Constructor for class mpv2.JamaMatrix
Construct a matrix from a one-dimensional packed array
JamaMatrix(AllMatrices) - Constructor for class mpv2.JamaMatrix
Construct a new matrix from another matrix (of any kind) if argument B is an object of class JamaMatrix this is the same as (deep) copy (or clone).

K

K - Variable in class mpv2.AllMatrices
Row and column dimensions.

L

lu() - Method in class mpv2.AllMatrices
LU Decomposition
lu() - Method in class mpv2.JamaMatrix
LU Decomposition
LUDecomposition - Class in mpv2
LU Decomposition.
LUDecomposition(JamaMatrix) - Constructor for class mpv2.LUDecomposition
LU Decomposition Constructor returns a structure to access L, U and piv.
lup() - Method in class mpv2.AllMatrices
LUP Decomposition
LUPDecomposition - Class in mpv2
LUP Decomposition, P*A = L*U A is N-by-K, P is N-by-N, M is Math.min(N,K), then L is N-by-M and U is M-by-K
LUPDecomposition(AllMatrices) - Constructor for class mpv2.LUPDecomposition
LUP Decomposition, P*A = L*U Constructor returns a structure to access L, U and P.
LUPDecomposition(int, int, double[]) - Constructor for class mpv2.LUPDecomposition
LUP Decomposition, P*A = L*U Constructor returns a structure to access L, U and P.
LUPDecomposition(double[]) - Constructor for class mpv2.LUPDecomposition
LUP Decomposition, P*A = L*U.

M

main(String[]) - Static method in class mpv2.QuickSort
 
MatchingPursuit - Class in mpv2
This class includes several closely related algorithmes for Matching Pursuit (MP).
MatchingPursuit(AllMatrices) - Constructor for class mpv2.MatchingPursuit
Instantiate an object of this class, and thus making the vector selection algorithms available to the calling program.
MatchingPursuit(AllMatrices, SymmetricMatrix) - Constructor for class mpv2.MatchingPursuit
Instantiate an object of this class, and thus making the vector selection algorithms available to the calling program.
minus(JamaMatrix) - Method in class mpv2.JamaMatrix
C = A - B
minusEquals(JamaMatrix) - Method in class mpv2.JamaMatrix
A = A - B
mpv2 - package mpv2
 

N

N - Variable in class mpv2.AllMatrices
Row and column dimensions.
norm0() - Method in class mpv2.SparseVector
The pseudo-zero-norm, do not count any zeros stored (which may happen)
norm1() - Method in class mpv2.AllMatrices
One norm
norm1() - Method in class mpv2.JamaMatrix
One norm
norm1() - Method in class mpv2.SparseVector
One norm
norm2() - Method in class mpv2.AllMatrices
Two norm
norm2() - Method in class mpv2.DiagonalMatrix
Two norm
norm2() - Method in class mpv2.JamaMatrix
Two norm
norm2() - Method in class mpv2.PermutationMatrix
Two norm
norm2() - Method in class mpv2.SingularValueDecomposition
Two norm
norm2() - Method in class mpv2.SparseVector
Two norm
normF() - Method in class mpv2.AllMatrices
Frobenius norm
normF() - Method in class mpv2.DiagonalMatrix
Frobenius norm
normF() - Method in class mpv2.JamaMatrix
Frobenius norm
normF() - Method in class mpv2.PermutationMatrix
Frobenius norm
normF() - Method in class mpv2.SparseMatrix
Frobenius norm
normInf() - Method in class mpv2.AllMatrices
Infinity norm
normInf() - Method in class mpv2.JamaMatrix
Infinity norm
normInf() - Method in class mpv2.SparseVector
Inf norm

O

OMP - Static variable in class mpv2.DictionaryLearning
 
ORMP - Static variable in class mpv2.DictionaryLearning
 

P

perfectShuffle(int, int) - Static method in class mpv2.PermutationMatrix
Generate perfect shuffle (stride) permutation matrix.
PermutationMatrix - Class in mpv2
This is a permutation matrix class made by implementing AllMatrices.
PermutationMatrix(int) - Constructor for class mpv2.PermutationMatrix
Construct an n-by-n permutation matrix with ones on the diagonal, i.e. identity matrix.
PermutationMatrix(int[]) - Constructor for class mpv2.PermutationMatrix
Construct an N-by-N permutation matrix from a vector p, A(n,k)==1 <=> p[n]==k.
PermutationMatrix(double[]) - Constructor for class mpv2.PermutationMatrix
Construct an n-by-n permutation matrix which will make the given array when the matrix is applied to the sorted sequence, ord = A*ascending(ord).
plus(JamaMatrix) - Method in class mpv2.JamaMatrix
C = A + B
pluseqOuterProduct(double, double, double[], double[]) - Method in class mpv2.AllMatrices
Add outer product of two vectors to this, A = s1*A + s2*(u*v').
pluseqOuterProduct(double, double, double[], double[]) - Method in class mpv2.SymmetricMatrix
Add outer product of two vectors to this, A = s1*A + s2*(u*v'+v*u').
pluseqOuterProduct(double, double, double[]) - Method in class mpv2.SymmetricMatrix
Add outer product of a vector to scaled this, A = s1*A + s2*(u*u').
plusEquals(JamaMatrix) - Method in class mpv2.JamaMatrix
A = A + B
print(int, int) - Method in class mpv2.AllMatrices
Print the matrix to stdout.
print(PrintWriter, int, int) - Method in class mpv2.AllMatrices
Print the matrix to the output stream.
print(NumberFormat, int) - Method in class mpv2.AllMatrices
Print the matrix to stdout.
print(PrintWriter, NumberFormat, int) - Method in class mpv2.AllMatrices
Print the matrix to the output stream.
print(int, int) - Method in class mpv2.JamaMatrix
Print the matrix to stdout.
print(PrintWriter, int, int) - Method in class mpv2.JamaMatrix
Print the matrix to the output stream.
print(NumberFormat, int) - Method in class mpv2.JamaMatrix
Print the matrix to stdout.
print(PrintWriter, NumberFormat, int) - Method in class mpv2.JamaMatrix
Print the matrix to the output stream.
print() - Method in class mpv2.SparseVector
Print the sparse vector to stdout.
print(int, int) - Method in class mpv2.SparseVector
Print the sparse vector to stdout.
print(PrintWriter, int, int) - Method in class mpv2.SparseVector
Print the sparse vector to stdout.
print(NumberFormat, int) - Method in class mpv2.SparseVector
Print the sparse vector to stdout.
print(PrintWriter, NumberFormat, int) - Method in class mpv2.SparseVector
Print the sparse vector to stdout.
PS - Static variable in class mpv2.DictionaryLearning
 

Q

qr() - Method in class mpv2.AllMatrices
QR Decomposition
qr() - Method in class mpv2.JamaMatrix
QR Decomposition
QRDecomposition - Class in mpv2
QR Decomposition.
QRDecomposition(JamaMatrix) - Constructor for class mpv2.QRDecomposition
QR Decomposition, computed by Householder reflections.
QuickSort - Class in mpv2
 
QuickSort() - Constructor for class mpv2.QuickSort
 
quicksort(double[]) - Static method in class mpv2.QuickSort
Quicksort code from Sedgewick 7.1, 7.2.
quicksort(double[], int, int) - Static method in class mpv2.QuickSort
 
quicksort(double[], double[]) - Static method in class mpv2.QuickSort
 
quicksort(double[], double[], int, int) - Static method in class mpv2.QuickSort
 
quicksort(int[], double[]) - Static method in class mpv2.QuickSort
 
quicksort(int[], double[], int, int) - Static method in class mpv2.QuickSort
 
quicksort(double[], int[]) - Static method in class mpv2.QuickSort
 
quicksort(double[], int[], int, int) - Static method in class mpv2.QuickSort
 
quicksort(int[]) - Static method in class mpv2.QuickSort
 
quicksort(int[], int, int) - Static method in class mpv2.QuickSort
 
quicksort(int[], int[]) - Static method in class mpv2.QuickSort
 
quicksort(int[], int[], int, int) - Static method in class mpv2.QuickSort
 

R

random(int, int) - Static method in class mpv2.JamaMatrix
Generate matrix with random elements
random(int) - Static method in class mpv2.PermutationMatrix
Generate randon permutation matrix
rank() - Method in class mpv2.AllMatrices
Matrix rank
rank() - Method in class mpv2.DiagonalMatrix
Matrix rank
rank() - Method in class mpv2.JamaMatrix
Matrix rank
rank() - Method in class mpv2.PermutationMatrix
Matrix rank
rank() - Method in class mpv2.SingularValueDecomposition
Effective numerical matrix rank
read(BufferedReader) - Static method in class mpv2.JamaMatrix
Read a matrix from a stream.
RepeatBlockMatrix - Class in mpv2
This is a block (e.g. band) diagonal matrix where the block is the same each time it is repeated.
RepeatBlockMatrix(AllMatrices, int, int, int) - Constructor for class mpv2.RepeatBlockMatrix
Construct a Block matrix with given matrix M.
reverse(int) - Static method in class mpv2.PermutationMatrix
Generate reverse matrix
rlsdla(double[], int) - Method in class mpv2.DictionaryLearning
RLS-DLA, prosess several training vectors by RLS-DLA.
rlsdla1(double[]) - Method in class mpv2.DictionaryLearning
RLS-DLA-1 Prosess a single training vector, one iteration of RLS-DLA.

S

set(int, int, double) - Method in class mpv2.AllMatrices
Set a single element.
set(int, int, double) - Method in class mpv2.BandMatrix
Set an entry (a value) in the matrix.
set(int, int, double) - Method in class mpv2.BlockMatrix
Set a single element.
set(int, double) - Method in class mpv2.DiagonalMatrix
Set a single element, A(n,n)=s.
set(int, int, double) - Method in class mpv2.DiagonalMatrix
Set a single element, A(n,k)=s, but only if (n==k).
set(int, int, double) - Method in class mpv2.JamaMatrix
Set a single element.
set(int, int, double) - Method in class mpv2.PermutationMatrix
Set a single element, A(n,k)=s, this is not allowed som method just return.
set(int, int, double) - Method in class mpv2.RepeatBlockMatrix
Set a single element.
set(int, int, double) - Method in class mpv2.SimpleMatrix
Set a single element.
set(int, int, double) - Method in class mpv2.SparseMatrix
Set an entry (a value) in the dictionary.
set(int, double) - Method in class mpv2.SparseVector
Set a vector element.
set(int, int, double) - Method in class mpv2.SparseVectorMatrix
Set an entry (a value) in the matrix.
set(int, int, double) - Method in class mpv2.SymmetricMatrix
Set one or two elements in the symmetric matrix A(n,k)=A(k,n)=s.
setAll(double[]) - Method in class mpv2.AllMatrices
Set all entries of the matrix to the supplied new values.
setAll(double[]) - Method in class mpv2.BandMatrix
Set all entries of to matrix to the supplied new values If argument is wrong length an IllegalArgumentException is thrown.
setAll(double[]) - Method in class mpv2.DiagonalMatrix
Set all entries of to matrix to the supplied new values If argument is wrong length an IllegalArgumentException is thrown.
setAll(double[]) - Method in class mpv2.JamaMatrix
Set all entries of the matrix to the supplied new values.
setAll(double[]) - Method in class mpv2.SimpleMatrix
Set all entries of to matrix to the supplied new values If argument is wrong length an IllegalArgumentException is thrown.
setAll(double[]) - Method in class mpv2.SparseMatrix
Set all entries of to matrix to the supplied new values If argument is wrong length an IllegalArgumentException is thrown.
setAll(double[]) - Method in class mpv2.SparseVectorMatrix
Set all entries of to matrix to the supplied new values If argument is wrong length an IllegalArgumentException is thrown.
setAll(double[]) - Method in class mpv2.SymmetricMatrix
Set all entries of the matrix to the supplied new values.
setBMP() - Method in class mpv2.DictionaryLearning
 
setBMP(int) - Method in class mpv2.DictionaryLearning
Set the Matching Pursuit Method to BMP and parameters to use.
setColumn(int, double[]) - Method in class mpv2.AllMatrices
Copy an array (y) into a column of the matrix.
setColumn(int, double[]) - Method in class mpv2.BandMatrix
Replace a column in the dictionary with the given column vector.
setColumn(int, double[]) - Method in class mpv2.SimpleMatrix
Copy an array (d) into a column of the matrix Legal range of the integer argument is 0 <= k < K.
setColumn(int, double[]) - Method in class mpv2.SparseVectorMatrix
Replace a column in the matrix with the given column vector.
setColumn(int, SparseVector) - Method in class mpv2.SparseVectorMatrix
Replace a column in the matrix with a copy of the given column.
setColumn(int, double[]) - Method in class mpv2.SymmetricMatrix
Copy an array (d) into a column, and a row, of the matrix
setLambda(char, double, double, double) - Method in class mpv2.DictionaryLearning
Set how to calculate the class variable lambda, the forgetting factor.
setLoggOff() - Method in class mpv2.DictionaryLearning
 
setLoggOn() - Method in class mpv2.DictionaryLearning
 
setMatrix(int, int, int, int, JamaMatrix) - Method in class mpv2.JamaMatrix
Set a submatrix.
setMatrix(int[], int[], JamaMatrix) - Method in class mpv2.JamaMatrix
Set a submatrix.
setMatrix(int[], int, int, JamaMatrix) - Method in class mpv2.JamaMatrix
Set a submatrix.
setMatrix(int, int, int[], JamaMatrix) - Method in class mpv2.JamaMatrix
Set a submatrix.
setNormalized() - Method in class mpv2.MatchingPursuit
Set dictionary normalized indicator to true without checking.
setOMP() - Method in class mpv2.DictionaryLearning
 
setOMP(int, double, double) - Method in class mpv2.DictionaryLearning
Set the Matching Pursuit Method to OMP and parameters to use.
setORMP() - Method in class mpv2.DictionaryLearning
 
setORMP(int, double, double) - Method in class mpv2.DictionaryLearning
Set the Matching Pursuit Method to ORMP and parameters to use.
setPS() - Method in class mpv2.DictionaryLearning
 
setPS(int, double, double, int) - Method in class mpv2.DictionaryLearning
Set the Matching Pursuit Method to Partial Search and parameters to use.
setRow(int, double[]) - Method in class mpv2.AllMatrices
Copy an array (x) into a row of the matrix.
setRow(int, double[]) - Method in class mpv2.JamaMatrix
Copy an array (x) into a row of the matrix.
setRow(int, double[]) - Method in class mpv2.SimpleMatrix
Set a row of the matrix Legal range of the integer argument is 0 <= n < N.
setRow(int, double[]) - Method in class mpv2.SymmetricMatrix
Set a row, and a column, of the matrix
setValue(int, int, double) - Method in class mpv2.AllMatrices
Set a single element, i.e. an entry (a value) in the matrix.
setVerbose(int) - Method in class mpv2.DictionaryLearning
Set verbose and veryVerbose
SimpleMatrix - Class in mpv2
This is a simple matrix class made by implementing AllMatrices as simple as possible.
SimpleMatrix(int, int) - Constructor for class mpv2.SimpleMatrix
Construct an m-by-n matrix of zeros.
SimpleMatrix(int, int, double) - Constructor for class mpv2.SimpleMatrix
Construct an m-by-n constant matrix.
SimpleMatrix(double[][]) - Constructor for class mpv2.SimpleMatrix
Construct a matrix from a 2-D array, all values are copied.
SimpleMatrix(double[], int) - Constructor for class mpv2.SimpleMatrix
Construct a matrix from a one-dimensional packed array
SimpleMatrix(AllMatrices) - Constructor for class mpv2.SimpleMatrix
Construct a new matrix from another matrix (of any kind) if argument B is an object of class SimpleMatrix this is the same as (deep) copy (or clone).
SingularValueDecomposition - Class in mpv2
Singular Value Decomposition.
SingularValueDecomposition(JamaMatrix) - Constructor for class mpv2.SingularValueDecomposition
Construct the singular value decomposition Constructor returns a structure to access U, S and V.
solve(JamaMatrix) - Method in class mpv2.CholeskyDecomposition
Solve A*X = B
solve(JamaMatrix) - Method in class mpv2.JamaMatrix
Solve A*X = B
solve(JamaMatrix) - Method in class mpv2.LUDecomposition
Solve A*X = B
solve(JamaMatrix) - Method in class mpv2.QRDecomposition
Least squares solution of A*X = B
solveArray(double[]) - Method in class mpv2.LUPDecomposition
Solve A*x = b
solveArray(AllMatrices) - Method in class mpv2.LUPDecomposition
Solve A*X = B, X is returned as an array.
solveMatrix(AllMatrices) - Method in class mpv2.LUPDecomposition
Solve A*X = B, X is returned as a SimpleMatrix object.
solveTranspose(JamaMatrix) - Method in class mpv2.JamaMatrix
Solve X*A = B, which is also A'*X' = B'
SparseMatrix - Class in mpv2
This class is a sparse matrix implementation.
SparseMatrix(int, int) - Constructor for class mpv2.SparseMatrix
Construct an m-by-n sparse matrix of zeros.
SparseMatrix(double[][]) - Constructor for class mpv2.SparseMatrix
Construct a matrix from a 2-D array.
SparseMatrix(double[], int) - Constructor for class mpv2.SparseMatrix
Construct a matrix from a one-dimensional packed array
SparseMatrix(AllMatrices) - Constructor for class mpv2.SparseMatrix
Construct a new matrix from another matrix (of any kind)
SparseVector - Class in mpv2
This class is a sparse vector implementation.
SparseVector(int) - Constructor for class mpv2.SparseVector
Construct a length n sparse vector of zeros.
SparseVector(double[]) - Constructor for class mpv2.SparseVector
Construct a sparse vector from an array.
SparseVector(int, int[], double[]) - Constructor for class mpv2.SparseVector
Construct a length n sparse vector with non-zero indices and values supplied.
SparseVectorMatrix - Class in mpv2
This class is a matrix implementation of the AllMatrices superclass, where each column is a SparseVector.
SparseVectorMatrix(int, int) - Constructor for class mpv2.SparseVectorMatrix
Construct a N×K matrix with only zero values.
SparseVectorMatrix(double[], int) - Constructor for class mpv2.SparseVectorMatrix
Construct a matrix from a one-dimensional packed array
SparseVectorMatrix(double[][]) - Constructor for class mpv2.SparseVectorMatrix
Construct a matrix from a 2-D array, all values are copied.
SparseVectorMatrix(AllMatrices) - Constructor for class mpv2.SparseVectorMatrix
Construct a new matrix from another matrix (of any kind)
sumAll() - Method in class mpv2.AllMatrices
Sum of all elements in matrix
sumAll() - Method in class mpv2.SimpleMatrix
Sum of all elements in matrix
svd() - Method in class mpv2.AllMatrices
Singular Value Decomposition
svd() - Method in class mpv2.JamaMatrix
Singular Value Decomposition
SymmetricMatrix - Class in mpv2
This is a symmetric matrix class made by implementing AllMatrices.
SymmetricMatrix(int) - Constructor for class mpv2.SymmetricMatrix
Construct an n-by-n matrix of zeros.
SymmetricMatrix(int, int) - Constructor for class mpv2.SymmetricMatrix
Construct an n-by-n matrix of zeros.
SymmetricMatrix(int, int, double) - Constructor for class mpv2.SymmetricMatrix
Construct an m-by-n constant matrix.
SymmetricMatrix(double[][]) - Constructor for class mpv2.SymmetricMatrix
Construct a matrix from a 2-D array, only lower-left-values are used.
SymmetricMatrix(AllMatrices) - Constructor for class mpv2.SymmetricMatrix
Construct a new matrix from another matrix (of any kind), only lower-left-values are used.

T

test(int) - Static method in class mpv2.QuickSort
 
times(double[]) - Method in class mpv2.AllMatrices
Multiplies the matrix by an array (vector), return y = A*x.
times(SparseVector) - Method in class mpv2.AllMatrices
Multiplies the matrix by a SparseVector x, return y = A*x.
times(double[], double[]) - Method in class mpv2.AllMatrices
Multiplies the matrix by an array (vector), set y = A*x.
times(SparseVector, double[]) - Method in class mpv2.AllMatrices
Multiplies the matrix by a SparseVector x, set y = A*x.
times(double[], double[]) - Method in class mpv2.BandMatrix
Multiplies the matrix by an array.
times(double[], double[]) - Method in class mpv2.DiagonalMatrix
Multiplies the matrix by an array, x = A*y.
times(double) - Method in class mpv2.JamaMatrix
Multiply a matrix by a scalar, C = s*A
times(JamaMatrix) - Method in class mpv2.JamaMatrix
Linear algebraic matrix multiplication, A * B
times(double[], double[]) - Method in class mpv2.PermutationMatrix
Multiplies the matrix by an array, x = A*y.
times(double[], double[]) - Method in class mpv2.SparseMatrix
Multiplies the dictionary D by array y.
times(AllMatrices) - Method in class mpv2.SparseMatrix
Multiplies the matrix by an another matrix, return C = A * B
times(double[], double[]) - Method in class mpv2.SparseVectorMatrix
Multiplies the matrix by an array.
timeseqScaleColumns(DiagonalMatrix) - Method in class mpv2.SimpleMatrix
Scale the columns of this, A *= D which is A = A * D.
timeseqScaleRows(DiagonalMatrix) - Method in class mpv2.SimpleMatrix
Scale the rows of this, A *= D which is A = D * A.
timesEquals(double) - Method in class mpv2.JamaMatrix
Multiply a matrix by a scalar in place, A = s*A
trace() - Method in class mpv2.AllMatrices
Matrix trace.
trace() - Method in class mpv2.JamaMatrix
Matrix trace.
transpose() - Method in class mpv2.JamaMatrix
JamaMatrix transpose.
transposeTimes(double[]) - Method in class mpv2.AllMatrices
Multiplies the transposed matrix by an array (vector), return x = A'*y.
transposeTimes(SparseVector) - Method in class mpv2.AllMatrices
Multiplies the transposed matrix by a SparseVector y, return x = A'*y.
transposeTimes(double[], double[]) - Method in class mpv2.AllMatrices
Multiplies the transposed matrix by an array (vector), set x = A'*y.
transposeTimes(SparseVector, double[]) - Method in class mpv2.AllMatrices
Multiplies the transposed matrix by a SparseVector y, set x = A'*y.
transposeTimes(double[], double[]) - Method in class mpv2.BandMatrix
Multiplies the transposed matrix by an array.
transposeTimes(double[], double[]) - Method in class mpv2.DiagonalMatrix
Multiplies the transposed matrix by an array, y = A'*x.
transposeTimes(double[], double[]) - Method in class mpv2.PermutationMatrix
Multiplies the transposed matrix by an array, y = A'*x.
transposeTimes(double[], double[]) - Method in class mpv2.SparseMatrix
Multiplies the transposed dictionary D' by array x.
transposeTimes(AllMatrices) - Method in class mpv2.SparseMatrix
Multiplies the transposed matrix by an another matrix, return B = A' * C
transposeTimes(double[], double[]) - Method in class mpv2.SparseVectorMatrix
Multiplies the transposed matrix by an array.

U

uminus() - Method in class mpv2.JamaMatrix
Unary minus

V

vsBMP(double[], int) - Method in class mpv2.MatchingPursuit
Use the Basic Matching Pursuit algoritm to find the sparse weight vector w such that ||x-D·w|| is minimized (but not minimal) subject to sparseness in w.
vsOMP(double[], int) - Method in class mpv2.MatchingPursuit
Uses the Orthogonal Matching Pursuit algoritm to find the sparse weight vector w such that ||x-D·w|| is minimized (but not minimal) subject to sparseness in w.
vsOMP(double[], double) - Method in class mpv2.MatchingPursuit
Uses the Orthogonal Matching Pursuit algoritm to find the sparse weight vector w such that ||x-D·w|| is minimized (but not minimal) subject to sparseness in w.
vsOMP(double[], int, double) - Method in class mpv2.MatchingPursuit
Uses the Orthogonal Matching Pursuit algoritm to find the sparse weight vector w such that ||x-D·w|| is minimized (but not minimal) subject to sparseness in w.
vsORMP(double[], int) - Method in class mpv2.MatchingPursuit
Uses the Order Recursive Matching Pursuit algoritm to find the sparse weight vector w such that ||x-D·w|| is minimized (but not minimal) subject to sparseness in w.
vsORMP(double[], double) - Method in class mpv2.MatchingPursuit
Uses the Order Recursive Matching Pursuit algoritm to find the sparse weight vector w such that ||x-D·w|| is minimized (but not minimal) subject to sparseness in w.
vsORMP(double[], int, double) - Method in class mpv2.MatchingPursuit
Uses the Order Recursive Matching Pursuit algoritm to find the sparse weight vector w such that ||x-D·w|| is minimized (but not minimal) subject to sparseness in w.
vsPS(double[], int, double, int) - Method in class mpv2.MatchingPursuit
Do Vector Selection by Partial Search.
vsSelectBest(double[]) - Method in class mpv2.MatchingPursuit
Finds the dictionary vector that best match the given signal.

A B C D E G I J K L M N O P Q R S T U V