Uses of Class
org.ejml.data.DMatrixRMaj
Package
Description
-
Uses of DMatrixRMaj in org.ejml
Modifier and TypeMethodDescriptionstatic DMatrixRMaj
UtilEjml.parse_DDRM
(String s, int numColumns) Give a string of numbers it returns a DenseMatrixstatic DMatrixRMaj
UtilEjml.reshapeOrDeclare
(@Nullable DMatrixRMaj a, int rows, int cols) If the input matrix is null a new matrix is created and returned.Modifier and TypeMethodDescriptionstatic DMatrixRMaj
UtilEjml.reshapeOrDeclare
(@Nullable DMatrixRMaj a, int rows, int cols) If the input matrix is null a new matrix is created and returned. -
Uses of DMatrixRMaj in org.ejml.data
Modifier and TypeMethodDescriptionDMatrixRMaj.copy()
Creates and returns a matrix which is identical to this one.DMatrixRMaj.create
(int numRows, int numCols) DMatrixRMaj.createLike()
DSubmatrixD1.extract()
static DMatrixRMaj
DMatrixRMaj.wrap
(int numRows, int numCols, double[] data) Creates a new DMatrixRMaj around the provided data.ModifierConstructorDescriptionDEigenpair
(double value, DMatrixRMaj vector) DMatrixRMaj
(DMatrixRMaj orig) Creates a new matrix which is equivalent to the provided matrix. -
Uses of DMatrixRMaj in org.ejml.dense.block
Modifier and TypeMethodDescriptionstatic DMatrixRMaj
MatrixOps_DDRB.convert
(DMatrixRBlock src, DMatrixRMaj dst) Converts a row major block matrix into a row major matrix.static DMatrixRMaj
MatrixOps_DDRB.convertInplace
(DMatrixRBlock src, @Nullable DMatrixRMaj dst, @Nullable DGrowArray workspace) Converts a row major block matrix into a row major matrix.Modifier and TypeMethodDescriptionstatic DMatrixRMaj
MatrixOps_DDRB.convert
(DMatrixRBlock src, DMatrixRMaj dst) Converts a row major block matrix into a row major matrix.static DMatrixRBlock
MatrixOps_DDRB.convert
(DMatrixRMaj A) static DMatrixRBlock
MatrixOps_DDRB.convert
(DMatrixRMaj A, int blockLength) static void
MatrixOps_DDRB.convert
(DMatrixRMaj src, DMatrixRBlock dst) Converts a row major matrix into a row major block matrix.static DMatrixRMaj
MatrixOps_DDRB.convertInplace
(DMatrixRBlock src, @Nullable DMatrixRMaj dst, @Nullable DGrowArray workspace) Converts a row major block matrix into a row major matrix.static DMatrixRBlock
MatrixOps_DDRB.convertInplace
(DMatrixRMaj src, @Nullable DMatrixRBlock dst, @Nullable DGrowArray workspace) Converts a row major matrix into a row major block matrix.static void
MatrixOps_DDRB.convertTranSrc
(DMatrixRMaj src, DMatrixRBlock dst) Converts the transpose of a row major matrix into a row major block matrix. -
Uses of DMatrixRMaj in org.ejml.dense.block.decomposition.hessenberg
Modifier and TypeFieldDescriptionprotected DMatrixRMaj
TridiagonalDecompositionHouseholder_DDRB.zerosM
protected DMatrixRMaj
TridiagonalDecompositionHouseholder_MT_DDRB.zerosM
-
Uses of DMatrixRMaj in org.ejml.dense.row
Modifier and TypeMethodDescriptionstatic DMatrixRMaj
CommonOps_DDRM.apply
(DMatrixRMaj input, DOperatorUnary func) static DMatrixRMaj
CommonOps_DDRM.apply
(DMatrixRMaj input, DOperatorUnary func, @Nullable DMatrixRMaj output) This applies a given unary function on every value stored in the matrixstatic DMatrixRMaj[]
CommonOps_DDRM.columnsToVector
(DMatrixRMaj A, @Nullable DMatrixRMaj[] v) Converts the columns in a matrix into a set of vectors.static DMatrixRMaj
CommonOps_DDRM.concatColumns
(DMatrixRMaj a, DMatrixRMaj b, @Nullable DMatrixRMaj output) output = [a , b]static DMatrixRMaj
CommonOps_DDRM.concatColumnsMulti
(DMatrixRMaj... m) Concatenates all the matrices together along their columns.static DMatrixRMaj
CommonOps_DDRM.concatRowsMulti
(DMatrixRMaj... m) Concatenates all the matrices together along their columns.static DMatrixRMaj
SpecializedOps_DDRM.copyChangeRow
(int[] order, DMatrixRMaj src, @Nullable DMatrixRMaj dst) Creates a copy of a matrix but swaps the rows as specified by the order array.static DMatrixRMaj
SpecializedOps_DDRM.copyTriangle
(DMatrixRMaj src, @Nullable DMatrixRMaj dst, boolean upper) Copies just the upper or lower triangular portion of a matrix.static DMatrixRMaj
EigenOps_DDRM.createMatrixD
(EigenDecomposition_F64<?> eig) A diagonal matrix where real diagonal element contains a real eigenvalue.static DMatrixRMaj
EigenOps_DDRM.createMatrixV
(EigenDecomposition_F64<DMatrixRMaj> eig) Puts all the real eigenvectors into the columns of a matrix.static DMatrixRMaj
SpecializedOps_DDRM.createReflector
(DMatrix1Row u) Creates a reflector from the provided vector.
Q = I - γ u uT
γ = 2/||u||2static DMatrixRMaj
SpecializedOps_DDRM.createReflector
(DMatrixRMaj u, double gamma) Creates a reflector from the provided vector and gamma.
Q = I - γ u uTstatic DMatrixRMaj
CommonOps_DDRM.diag
(double... diagEl) Creates a new square matrix whose diagonal elements are specified by diagEl and all the other elements are zero.
aij = 0 if i ≤ j
aij = diag[i] if i = jstatic DMatrixRMaj
CommonOps_DDRM.diag
(@Nullable DMatrixRMaj ret, int width, double... diagEl) static DMatrixRMaj
Creates a random diagonal matrix where the diagonal elements are selected from a uniform distribution that goes from min to max.static DMatrixRMaj
Creates a random matrix where all elements are zero but diagonal elements.static DMatrixRMaj
CommonOps_DDRM.diagR
(int numRows, int numCols, double... diagEl) Creates a new rectangular matrix whose diagonal elements are specified by diagEl and all the other elements are zero.
aij = 0 if i ≤ j
aij = diag[i] if i = jstatic DMatrixRMaj
CommonOps_DDRM.elements
(DMatrixRMaj A, BMatrixRMaj marked, @Nullable DMatrixRMaj output) Returns a row matrix which contains all the elements in A which are flagged as true in 'marked'static DMatrixRMaj
CommonOps_DDRM.extract
(DMatrixRMaj src, int[] rows, int rowsSize, int[] cols, int colsSize, @Nullable DMatrixRMaj dst) Extracts out a matrix from source given a sub matrix with arbitrary rows and columns specified in two array listsstatic DMatrixRMaj
CommonOps_DDRM.extract
(DMatrixRMaj src, int[] indexes, int length, @Nullable DMatrixRMaj dst) Extracts the elements from the source matrix by their 1D index.static DMatrixRMaj
CommonOps_DDRM.extract
(DMatrixRMaj src, int srcY0, int srcY1, int srcX0, int srcX1) Creates a new matrix which is the specified submatrix of 'src'static DMatrixRMaj
CommonOps_DDRM.extractColumn
(DMatrixRMaj a, int column, @Nullable DMatrixRMaj out) Extracts the column from a matrix.static DMatrixRMaj
CommonOps_DDRM.extractDiag
(DMatrixRMaj src, @Nullable DMatrixRMaj dst) Extracts the diagonal elements 'src' write it to the 'dst' vector.static DMatrixRMaj
CommonOps_DDRM.extractRow
(DMatrixRMaj a, int row, @Nullable DMatrixRMaj out) Extracts the row from a matrix.static DMatrixRMaj
CommonOps_DDRM.identity
(int width) Creates an identity matrix of the specified size.
aij = 0 if i ≠ j
aij = 1 if i = jstatic DMatrixRMaj
CommonOps_DDRM.identity
(int numRows, int numCols) Creates a rectangular matrix which is zero except along the diagonals.static DMatrixRMaj
CommonOps_ZDRM.imaginary
(ZMatrixD1 input, @Nullable DMatrixRMaj output) Places the imaginary component of the input matrix into the output matrix.static DMatrixRMaj
RandomMatrices_DDRM.insideSpan
(DMatrixRMaj[] span, double min, double max, Random rand) Creates a random vector that is inside the specified span.static DMatrixRMaj
CommonOps_DDRM.kron
(DMatrixRMaj A, DMatrixRMaj B, @Nullable DMatrixRMaj C) The Kronecker product of two matrices is defined as:
Cij = aijB
where Cij is a sub matrix inside of C ∈ ℜ m*k × n*l, A ∈ ℜ m × n, and B ∈ ℜ k × l.static DMatrixRMaj
CommonOps_ZDRM.magnitude
(ZMatrixD1 input, @Nullable DMatrixRMaj output) Computes the magnitude of the complex number in the input matrix and stores the results in the output matrix.static DMatrixRMaj
CommonOps_DDRM.maxCols
(DMatrixRMaj input, @Nullable DMatrixRMaj output) Finds the element with the minimum value along column in the input matrix and returns the results in a vector:
bj = min(i=1:m ; aij)static DMatrixRMaj
CommonOps_DDRM.maxRows
(DMatrixRMaj input, @Nullable DMatrixRMaj output) Finds the element with the maximum value along each row in the input matrix and returns the results in a vector:
bj = max(i=1:n ; aji)static DMatrixRMaj
CommonOps_DDRM.minCols
(DMatrixRMaj input, @Nullable DMatrixRMaj output) Finds the element with the minimum value along column in the input matrix and returns the results in a vector:
bj = min(i=1:m ; aij)static DMatrixRMaj
CommonOps_DDRM.minRows
(DMatrixRMaj input, @Nullable DMatrixRMaj output) Finds the element with the minimum value along each row in the input matrix and returns the results in a vector:
bj = min(i=1:n ; aji)static DMatrixRMaj
SingularOps_DDRM.nullSpace
(SingularValueDecomposition_F64<DMatrixRMaj> svd, @Nullable DMatrixRMaj nullSpace, double tol) Returns the null-space from the singular value decomposition.static DMatrixRMaj
SingularOps_DDRM.nullspaceQR
(DMatrixRMaj A, int totalSingular) Computes the null space using QR decomposition.static DMatrixRMaj
SingularOps_DDRM.nullspaceQRP
(DMatrixRMaj A, int totalSingular) Computes the null space using QRP decomposition.static DMatrixRMaj
SingularOps_DDRM.nullspaceSVD
(DMatrixRMaj A, int totalSingular) Computes the null space using SVD.static DMatrixRMaj
SingularOps_DDRM.nullVector
(SingularValueDecomposition_F64<DMatrixRMaj> svd, boolean isRight, @Nullable DMatrixRMaj nullVector) The vector associated will the smallest singular value is returned as the null space of the decomposed system.static DMatrixRMaj
RandomMatrices_DDRM.orthogonal
(int numRows, int numCols, Random rand) Creates a random orthogonal or isometric matrix, depending on the number of rows and columns.static DMatrixRMaj
CommonOps_DDRM.permuteRowInv
(int[] pinv, DMatrixRMaj input, DMatrixRMaj output) Applies the row permutation specified by the vector to the input matrix and save the results in the output matrix.static DMatrixRMaj
SpecializedOps_DDRM.pivotMatrix
(@Nullable DMatrixRMaj ret, int[] pivots, int numPivots, boolean transposed) Creates a pivot matrix that exchanges the rows in a matrix:
A' = P*Astatic DMatrixRMaj
CommonOps_ZDRM.real
(ZMatrixD1 input, @Nullable DMatrixRMaj output) Places the real component of the input matrix into the output matrix.static DMatrixRMaj
Returns a matrix where all the elements are selected independently from a uniform distribution between 'min' and 'max' inclusive.static DMatrixRMaj
Returns a matrix where all the elements are selected independently from a uniform distribution between 0 and 1 inclusive.static DMatrixRMaj
RandomMatrices_DDRM.rectangleGaussian
(int numRow, int numCol, double mean, double stdev, Random rand) Sets each element in the matrix to a value drawn from an Gaussian distribution with the specified mean and standard deviationstatic DMatrixRMaj[]
CommonOps_DDRM.rowsToVector
(DMatrixRMaj A, @Nullable DMatrixRMaj[] v) Converts the rows in a matrix into a set of vectors.static DMatrixRMaj
CommonOps_DDRM.rref
(DMatrixRMaj A, int numUnknowns, @Nullable DMatrixRMaj reduced) Puts the augmented system matrix into reduced row echelon form (RREF) using Gauss-Jordan elimination with row (partial) pivots.static DMatrixRMaj
Creates a random matrix which will have the provided singular values.static DMatrixRMaj[]
Creates a randomly generated set of orthonormal vectors.static DMatrixRMaj[]
SpecializedOps_DDRM.splitIntoVectors
(DMatrix1Row A, boolean column) Takes a matrix and splits it into a set of row or column vectors.static DMatrixRMaj
CommonOps_DDRM.sumCols
(DMatrixRMaj input, @Nullable DMatrixRMaj output) Computes the sum of each column in the input matrix and returns the results in a vector:
bj = sum(i=1:m ; aij)static DMatrixRMaj
CommonOps_DDRM.sumRows
(DMatrixRMaj input, @Nullable DMatrixRMaj output) Computes the sum of each row in the input matrix and returns the results in a vector:
bj = sum(i=1:n ; aji)static DMatrixRMaj
Creates a random symmetric matrix whose values are selected from an uniform distribution from min to max, inclusive.static DMatrixRMaj
RandomMatrices_DDRM.symmetricPosDef
(int width, Random rand) Creates a random symmetric positive definite matrix.static DMatrixRMaj
RandomMatrices_DDRM.symmetricWithEigenvalues
(int num, Random rand, double... eigenvalues) Creates a new random symmetric matrix that will have the specified real eigenvalues.static DMatrixRMaj
CommonOps_DDRM.transpose
(DMatrixRMaj A, @Nullable DMatrixRMaj A_tran) Transposes matrix 'a' and stores the results in 'b':
bij = aji
where 'b' is the transpose of 'a'.static DMatrixRMaj
CommonOps_MT_DDRM.transpose
(DMatrixRMaj A, @Nullable DMatrixRMaj A_tran) Transposes matrix 'a' and stores the results in 'b':
bij = aji
where 'b' is the transpose of 'a'.static DMatrixRMaj
RandomMatrices_DDRM.triangularLower
(int dimen, int hessenberg, double min, double max, Random rand) Creates a lower triangular matrix whose values are selected from a uniform distribution.static DMatrixRMaj
RandomMatrices_DDRM.triangularUpper
(int dimen, int hessenberg, double min, double max, Random rand) Creates an upper triangular matrix whose values are selected from a uniform distribution.Modifier and TypeMethodDescriptionstatic void
RandomMatrices_DDRM.addUniform
(DMatrixRMaj A, double min, double max, Random rand) Adds random values to each element in the matrix from an uniform distribution.
aij = aij + U(min,max)static DMatrixRMaj
CommonOps_DDRM.apply
(DMatrixRMaj input, DOperatorUnary func) static DMatrixRMaj
CommonOps_DDRM.apply
(DMatrixRMaj input, DOperatorUnary func, @Nullable DMatrixRMaj output) This applies a given unary function on every value stored in the matrixstatic double[]
EigenOps_DDRM.boundLargestEigenValue
(DMatrixRMaj A, @org.jetbrains.annotations.Nullable double[] bound) Generates a bound for the largest eigen value of the provided matrix using Perron-Frobenius theorem.static void
SingularOps_DDRM.checkSvdMatrixSize
(@Nullable DMatrixRMaj U, boolean tranU, DMatrixRMaj W, @Nullable DMatrixRMaj V, boolean tranV) Checks to see if all the provided matrices are the expected size for an SVD.static DMatrixRMaj[]
CommonOps_DDRM.columnsToVector
(DMatrixRMaj A, @Nullable DMatrixRMaj[] v) Converts the columns in a matrix into a set of vectors.static double
EigenOps_DDRM.computeEigenValue
(DMatrixRMaj A, DMatrixRMaj eigenVector) Given matrix A and an eigen vector of A, compute the corresponding eigen value.static @Nullable DEigenpair
EigenOps_DDRM.computeEigenVector
(DMatrixRMaj A, double eigenvalue) Given an eigenvalue it computes an eigenvector using inverse iteration:
for i=1:MAX {
(A - μI)z(i) = q(i-1)
q(i) = z(i) / ||z(i)||
λ(i) = q(i)T A q(i)
}static DMatrixRMaj
CommonOps_DDRM.concatColumns
(DMatrixRMaj a, DMatrixRMaj b, @Nullable DMatrixRMaj output) output = [a , b]static DMatrixRMaj
CommonOps_DDRM.concatColumnsMulti
(DMatrixRMaj... m) Concatenates all the matrices together along their columns.static void
CommonOps_DDRM.concatRows
(DMatrixRMaj a, DMatrixRMaj b, DMatrixRMaj output) output = [a ; b]static DMatrixRMaj
CommonOps_DDRM.concatRowsMulti
(DMatrixRMaj... m) Concatenates all the matrices together along their columns.static double
NormOps_DDRM.conditionP
(DMatrixRMaj A, double p) The condition number of a matrix is used to measure the sensitivity of the linear system Ax=b.static double
NormOps_DDRM.conditionP2
(DMatrixRMaj A) The condition p = 2 number of a matrix is used to measure the sensitivity of the linear system Ax=b.static DMatrixRMaj
SpecializedOps_DDRM.copyChangeRow
(int[] order, DMatrixRMaj src, @Nullable DMatrixRMaj dst) Creates a copy of a matrix but swaps the rows as specified by the order array.static DMatrixRMaj
SpecializedOps_DDRM.copyTriangle
(DMatrixRMaj src, @Nullable DMatrixRMaj dst, boolean upper) Copies just the upper or lower triangular portion of a matrix.static int
MatrixFeatures_DDRM.countNonZero
(DMatrixRMaj A) Counts the number of elements in A which are not zero.static DMatrixRMaj
SpecializedOps_DDRM.createReflector
(DMatrixRMaj u, double gamma) Creates a reflector from the provided vector and gamma.
Q = I - γ u uTstatic void
SingularOps_DDRM.descendingOrder
(@Nullable DMatrixRMaj U, boolean tranU, double[] singularValues, int singularLength, @Nullable DMatrixRMaj V, boolean tranV) Similar toSingularOps_DDRM.descendingOrder(DMatrixRMaj, boolean, DMatrixRMaj, DMatrixRMaj, boolean)
but takes in an array of singular values instead.static void
SingularOps_DDRM.descendingOrder
(DMatrixRMaj U, boolean tranU, DMatrixRMaj W, DMatrixRMaj V, boolean tranV) Adjusts the matrices so that the singular values are in descending order.static double
CommonOps_DDRM.det
(DMatrixRMaj mat) Returns the determinant of the matrix.static DMatrixRMaj
CommonOps_DDRM.diag
(@Nullable DMatrixRMaj ret, int width, double... diagEl) static void
CommonOps_DDRM.divideCols
(DMatrixRMaj A, double[] values) Divides every element in column i by value[i].static void
CommonOps_DDRM.divideRows
(double[] values, DMatrixRMaj A) Divides every element in row i by value[i].static void
CommonOps_DDRM.divideRowsCols
(double[] diagA, int offsetA, DMatrixRMaj B, double[] diagC, int offsetC) Equivalent to multiplying a matrix B by the inverse of two diagonal matrices.static @Nullable DEigenpair
EigenOps_DDRM.dominantEigenpair
(DMatrixRMaj A) Computes the dominant eigen vector for a matrix.static BMatrixRMaj
CommonOps_DDRM.elementBoolean
(DMatrixRMaj input, DElementCoorBoolean func, @Nullable BMatrixRMaj output) Applies a binary operator to even element in the input matrix.static BMatrixRMaj
CommonOps_DDRM.elementLessThan
(DMatrixRMaj A, double value, @Nullable BMatrixRMaj output) Applies the > operator to each element in A.static BMatrixRMaj
CommonOps_DDRM.elementLessThan
(DMatrixRMaj A, DMatrixRMaj B, @Nullable BMatrixRMaj output) Applies the < operator to each element in A.static BMatrixRMaj
CommonOps_DDRM.elementLessThanOrEqual
(DMatrixRMaj A, double value, @Nullable BMatrixRMaj output) Applies the ≥ operator to each element in A.static BMatrixRMaj
CommonOps_DDRM.elementLessThanOrEqual
(DMatrixRMaj A, DMatrixRMaj B, @Nullable BMatrixRMaj output) Applies the A ≤ B operator to each element.static BMatrixRMaj
CommonOps_DDRM.elementMoreThan
(DMatrixRMaj A, double value, @Nullable BMatrixRMaj output) Applies the > operator to each element in A.static BMatrixRMaj
CommonOps_DDRM.elementMoreThanOrEqual
(DMatrixRMaj A, double value, @Nullable BMatrixRMaj output) Applies the ≥ operator to each element in A.static DMatrixRMaj
CommonOps_DDRM.elements
(DMatrixRMaj A, BMatrixRMaj marked, @Nullable DMatrixRMaj output) Returns a row matrix which contains all the elements in A which are flagged as true in 'marked'static DMatrixRMaj
CommonOps_DDRM.extract
(DMatrixRMaj src, int[] rows, int rowsSize, int[] cols, int colsSize, @Nullable DMatrixRMaj dst) Extracts out a matrix from source given a sub matrix with arbitrary rows and columns specified in two array listsstatic DMatrixRMaj
CommonOps_DDRM.extract
(DMatrixRMaj src, int[] indexes, int length, @Nullable DMatrixRMaj dst) Extracts the elements from the source matrix by their 1D index.static DMatrixRMaj
CommonOps_DDRM.extract
(DMatrixRMaj src, int srcY0, int srcY1, int srcX0, int srcX1) Creates a new matrix which is the specified submatrix of 'src'static DMatrixRMaj
CommonOps_DDRM.extractColumn
(DMatrixRMaj a, int column, @Nullable DMatrixRMaj out) Extracts the column from a matrix.static DMatrixRMaj
CommonOps_DDRM.extractDiag
(DMatrixRMaj src, @Nullable DMatrixRMaj dst) Extracts the diagonal elements 'src' write it to the 'dst' vector.static DMatrixRMaj
CommonOps_DDRM.extractRow
(DMatrixRMaj a, int row, @Nullable DMatrixRMaj out) Extracts the row from a matrix.static double
NormOps_DDRM.fastNormP
(DMatrixRMaj A, double p) An unsafe but faster version ofNormOps_DDRM.normP(org.ejml.data.DMatrixRMaj, double)
that calls routines which are faster but more prone to overflow/underflow problems.static double
NormOps_DDRM.fastNormP2
(DMatrixRMaj A) Computes the p=2 norm.static void
RandomMatrices_DDRM.fillUniform
(DMatrixRMaj mat, Random rand) Sets each element in the matrix to a value drawn from an uniform distribution from 0 to 1 inclusive.static DMatrixRMaj
CommonOps_ZDRM.imaginary
(ZMatrixD1 input, @Nullable DMatrixRMaj output) Places the imaginary component of the input matrix into the output matrix.static double
NormOps_DDRM.inducedP1
(DMatrixRMaj A) Computes the induced p = 1 matrix norm.
||A||1= max(j=1 to n; sum(i=1 to m; |aij|))static double
NormOps_DDRM.inducedP2
(DMatrixRMaj A) Computes the induced p = 2 matrix norm, which is the largest singular value.static double
NormOps_DDRM.inducedPInf
(DMatrixRMaj A) Induced matrix p = infinity norm.
||A||∞ = max(i=1 to m; sum(j=1 to n; |aij|))static void
CommonOps_DDRM.insert
(DMatrixRMaj src, DMatrixRMaj dst, int[] rows, int rowsSize, int[] cols, int colsSize) Inserts into the specified elements of dst the source matrix.static DMatrixRMaj
RandomMatrices_DDRM.insideSpan
(DMatrixRMaj[] span, double min, double max, Random rand) Creates a random vector that is inside the specified span.static boolean
CommonOps_DDRM.invert
(DMatrixRMaj mat) Performs a matrix inversion operation on the specified matrix and stores the results in the same matrix.
a = a-1static boolean
CommonOps_DDRM.invert
(DMatrixRMaj mat, DMatrixRMaj result) Performs a matrix inversion operation that does not modify the original and stores the results in another matrix.static boolean
CovarianceOps_DDRM.invert
(DMatrixRMaj cov) Performs a matrix inversion operations that takes advantage of the special properties of a covariance matrix.static boolean
CovarianceOps_DDRM.invert
(DMatrixRMaj cov, DMatrixRMaj cov_inv) Performs a matrix inversion operations that takes advantage of the special properties of a covariance matrix.static boolean
CommonOps_DDRM.invertSPD
(DMatrixRMaj mat, DMatrixRMaj result) Matrix inverse for symmetric positive definite matrices.static boolean
MatrixFeatures_DDRM.isConstantVal
(DMatrixRMaj mat, double val, double tol) Checks to see if every value in the matrix is the specified value.static boolean
MatrixFeatures_DDRM.isDiagonalNotNegative
(DMatrixRMaj a) Checks to see if diagonal element are all not negative, i.e.static boolean
MatrixFeatures_DDRM.isDiagonalPositive
(DMatrixRMaj a) Checks to see if all the diagonal elements in the matrix are positive.static boolean
MatrixFeatures_DDRM.isFullRank
(DMatrixRMaj a) static boolean
MatrixFeatures_DDRM.isIdentity
(DMatrixRMaj mat, double tol) Checks to see if the provided matrix is within tolerance to an identity matrix.static boolean
MatrixFeatures_DDRM.isInverse
(DMatrixRMaj a, DMatrixRMaj b, double tol) Checks to see if the two matrices are inverses of each other.static boolean
MatrixFeatures_DDRM.isLowerTriangle
(DMatrixRMaj A, int hessenberg, double tol) Checks to see if a matrix is lower triangular or Hessenberg.static boolean
MatrixFeatures_DDRM.isOrthogonal
(DMatrixRMaj Q, double tol) Checks to see if a matrix is orthogonal or isometric.static boolean
MatrixFeatures_DDRM.isPositiveDefinite
(DMatrixRMaj A) Checks to see if the matrix is positive definite.static boolean
MatrixFeatures_DDRM.isPositiveSemidefinite
(DMatrixRMaj A) Checks to see if the matrix is positive semidefinite:static boolean
MatrixFeatures_DDRM.isRowsLinearIndependent
(DMatrixRMaj A) Checks to see if the rows of the provided matrix are linearly independent.static boolean
MatrixFeatures_DDRM.isSkewSymmetric
(DMatrixRMaj A, double tol) Checks to see if a matrix is skew symmetric with in tolerance:
-A = AT
or
|aij + aji| ≤ tolstatic boolean
MatrixFeatures_DDRM.isSymmetric
(DMatrixRMaj m) Returns true if the matrix is perfectly symmetric.static boolean
MatrixFeatures_DDRM.isSymmetric
(DMatrixRMaj m, double tol) Returns true if the matrix is symmetric within the tolerance.static boolean
MatrixFeatures_DDRM.isUpperTriangle
(DMatrixRMaj A, int hessenberg, double tol) Checks to see if a matrix is upper triangular or Hessenberg.static int
CovarianceOps_DDRM.isValid
(DMatrixRMaj cov) Performs a variety of tests to see if the provided matrix is a valid covariance matrix, performing the fastest checks first.static boolean
CovarianceOps_DDRM.isValidFast
(DMatrixRMaj cov) This is a fairly light weight check to see of a covariance matrix is valid.static DMatrixRMaj
CommonOps_DDRM.kron
(DMatrixRMaj A, DMatrixRMaj B, @Nullable DMatrixRMaj C) The Kronecker product of two matrices is defined as:
Cij = aijB
where Cij is a sub matrix inside of C ∈ ℜ m*k × n*l, A ∈ ℜ m × n, and B ∈ ℜ k × l.static DMatrixRMaj
CommonOps_ZDRM.magnitude
(ZMatrixD1 input, @Nullable DMatrixRMaj output) Computes the magnitude of the complex number in the input matrix and stores the results in the output matrix.static DMatrixRMaj
CommonOps_DDRM.maxCols
(DMatrixRMaj input, @Nullable DMatrixRMaj output) Finds the element with the minimum value along column in the input matrix and returns the results in a vector:
bj = min(i=1:m ; aij)static DMatrixRMaj
CommonOps_DDRM.maxRows
(DMatrixRMaj input, @Nullable DMatrixRMaj output) Finds the element with the maximum value along each row in the input matrix and returns the results in a vector:
bj = max(i=1:n ; aji)static DMatrixRMaj
CommonOps_DDRM.minCols
(DMatrixRMaj input, @Nullable DMatrixRMaj output) Finds the element with the minimum value along column in the input matrix and returns the results in a vector:
bj = min(i=1:m ; aij)static DMatrixRMaj
CommonOps_DDRM.minRows
(DMatrixRMaj input, @Nullable DMatrixRMaj output) Finds the element with the minimum value along each row in the input matrix and returns the results in a vector:
bj = min(i=1:n ; aji)static void
CommonOps_DDRM.multCols
(DMatrixRMaj A, double[] values) Multiplies every element in column i by value[i].static void
SpecializedOps_DDRM.multLowerTranA
(DMatrixRMaj mat) Performs L = LT*Lstatic void
SpecializedOps_DDRM.multLowerTranB
(DMatrixRMaj mat) Performs L = L*LTstatic void
CommonOps_DDRM.multRows
(double[] values, DMatrixRMaj A) Multiplies every element in row i by value[i].void
CovarianceRandomDraw_DDRM.next
(DMatrixRMaj x) Makes a draw on the distribution.static void
NormOps_DDRM.normalizeF
(DMatrixRMaj A) Normalizes the matrix such that the Frobenius norm is equal to one.static double
NormOps_DDRM.normP
(DMatrixRMaj A, double p) Computes either the vector p-norm or the induced matrix p-norm depending on A being a vector or a matrix respectively.static double
NormOps_DDRM.normP1
(DMatrixRMaj A) Computes the p=1 norm.static double
NormOps_DDRM.normP2
(DMatrixRMaj A) Computes the p=2 norm.static double
NormOps_DDRM.normPInf
(DMatrixRMaj A) Computes the p=∞ norm.static int
MatrixFeatures_DDRM.nullity
(DMatrixRMaj A) Computes the nullity of a matrix using the default tolerance.static int
MatrixFeatures_DDRM.nullity
(DMatrixRMaj A, double threshold) Computes the nullity of a matrix using the specified tolerance.static int
SingularOps_DDRM.nullity
(DMatrixRMaj A, double threshold) Returns the matrix's nullitystatic DMatrixRMaj
SingularOps_DDRM.nullSpace
(SingularValueDecomposition_F64<DMatrixRMaj> svd, @Nullable DMatrixRMaj nullSpace, double tol) Returns the null-space from the singular value decomposition.static DMatrixRMaj
SingularOps_DDRM.nullspaceQR
(DMatrixRMaj A, int totalSingular) Computes the null space using QR decomposition.static DMatrixRMaj
SingularOps_DDRM.nullspaceQRP
(DMatrixRMaj A, int totalSingular) Computes the null space using QRP decomposition.static DMatrixRMaj
SingularOps_DDRM.nullspaceSVD
(DMatrixRMaj A, int totalSingular) Computes the null space using SVD.static DMatrixRMaj
SingularOps_DDRM.nullVector
(SingularValueDecomposition_F64<DMatrixRMaj> svd, boolean isRight, @Nullable DMatrixRMaj nullVector) The vector associated will the smallest singular value is returned as the null space of the decomposed system.static DMatrixRMaj
CommonOps_DDRM.permuteRowInv
(int[] pinv, DMatrixRMaj input, DMatrixRMaj output) Applies the row permutation specified by the vector to the input matrix and save the results in the output matrix.static void
CommonOps_DDRM.pinv
(DMatrixRMaj A, DMatrixRMaj invA) Computes the Moore-Penrose pseudo-inverse:
pinv(A) = (ATA)-1 AT
or
pinv(A) = AT(AAT)-1static DMatrixRMaj
SpecializedOps_DDRM.pivotMatrix
(@Nullable DMatrixRMaj ret, int[] pivots, int numPivots, boolean transposed) Creates a pivot matrix that exchanges the rows in a matrix:
A' = P*Astatic void
CovarianceOps_DDRM.randomVector
(DMatrixRMaj cov, DMatrixRMaj vector, Random rand) Sets vector to a random value based upon a zero-mean multivariate Gaussian distribution with covariance 'cov'.static int
MatrixFeatures_DDRM.rank
(DMatrixRMaj A) Computes the rank of a matrix using a default tolerance.static int
MatrixFeatures_DDRM.rank
(DMatrixRMaj A, double threshold) Computes the rank of a matrix using the specified tolerance.static int
SingularOps_DDRM.rank
(DMatrixRMaj A) Returns the matrix's rank.static int
SingularOps_DDRM.rank
(DMatrixRMaj A, double threshold) Returns the matrix's rankstatic DMatrixRMaj
CommonOps_ZDRM.real
(ZMatrixD1 input, @Nullable DMatrixRMaj output) Places the real component of the input matrix into the output matrix.static void
CommonOps_DDRM.removeColumns
(DMatrixRMaj A, int col0, int col1) Removes columns from the matrix.static DMatrixRMaj[]
CommonOps_DDRM.rowsToVector
(DMatrixRMaj A, @Nullable DMatrixRMaj[] v) Converts the rows in a matrix into a set of vectors.static DMatrixRMaj
CommonOps_DDRM.rref
(DMatrixRMaj A, int numUnknowns, @Nullable DMatrixRMaj reduced) Puts the augmented system matrix into reduced row echelon form (RREF) using Gauss-Jordan elimination with row (partial) pivots.static void
CommonOps_DDRM.scaleCol
(double alpha, DMatrixRMaj A, int col) In-place scaling of a column in Astatic void
CommonOps_DDRM.scaleRow
(double alpha, DMatrixRMaj A, int row) In-place scaling of a row in Astatic double[]
SingularOps_DDRM.singularValues
(DMatrixRMaj A) Returns an array of all the singular values in A sorted in ascending orderstatic boolean
CommonOps_DDRM.solve
(DMatrixRMaj a, DMatrixRMaj b, DMatrixRMaj x) Solves for x in the following equation:
A*x = bstatic boolean
CommonOps_DDRM.solveSPD
(DMatrixRMaj A, DMatrixRMaj b, DMatrixRMaj x) Linear solver for systems which are symmetric positive definite.
A*x = bstatic DMatrixRMaj
CommonOps_DDRM.sumCols
(DMatrixRMaj input, @Nullable DMatrixRMaj output) Computes the sum of each column in the input matrix and returns the results in a vector:
bj = sum(i=1:m ; aij)static DMatrixRMaj
CommonOps_DDRM.sumRows
(DMatrixRMaj input, @Nullable DMatrixRMaj output) Computes the sum of each row in the input matrix and returns the results in a vector:
bj = sum(i=1:n ; aji)static boolean
SingularOps_DDRM.svd
(DMatrixRMaj A, @Nullable DMatrixRMaj U, DGrowArray sv, @Nullable DMatrixRMaj Vt) Computes the SVD and sorts singular values in descending order.static void
RandomMatrices_DDRM.symmetric
(DMatrixRMaj A, double min, double max, Random rand) Sets the provided square matrix to be a random symmetric matrix whose values are selected from an uniform distribution from min to max, inclusive.static void
CommonOps_DDRM.symmLowerToFull
(DMatrixRMaj A) Given a symmetric matrix which is represented by a lower triangular matrix convert it back into a full symmetric matrix.static void
CommonOps_DDRM.symmUpperToFull
(DMatrixRMaj A) Given a symmetric matrix which is represented by a lower triangular matrix convert it back into a full symmetric matrix.static void
CommonOps_DDRM.transpose
(DMatrixRMaj mat) Performs an "in-place" transpose.static DMatrixRMaj
CommonOps_DDRM.transpose
(DMatrixRMaj A, @Nullable DMatrixRMaj A_tran) Transposes matrix 'a' and stores the results in 'b':
bij = aji
where 'b' is the transpose of 'a'.static void
CommonOps_MT_DDRM.transpose
(DMatrixRMaj mat) Performs an "in-place" transpose.static DMatrixRMaj
CommonOps_MT_DDRM.transpose
(DMatrixRMaj A, @Nullable DMatrixRMaj A_tran) Transposes matrix 'a' and stores the results in 'b':
bij = aji
where 'b' is the transpose of 'a'.Modifier and TypeMethodDescriptionstatic DMatrixRMaj
EigenOps_DDRM.createMatrixV
(EigenDecomposition_F64<DMatrixRMaj> eig) Puts all the real eigenvectors into the columns of a matrix.static DMatrixRMaj
SingularOps_DDRM.nullSpace
(SingularValueDecomposition_F64<DMatrixRMaj> svd, @Nullable DMatrixRMaj nullSpace, double tol) Returns the null-space from the singular value decomposition.static DMatrixRMaj
SingularOps_DDRM.nullVector
(SingularValueDecomposition_F64<DMatrixRMaj> svd, boolean isRight, @Nullable DMatrixRMaj nullVector) The vector associated will the smallest singular value is returned as the null space of the decomposed system.ModifierConstructorDescriptionCovarianceRandomDraw_DDRM
(Random rand, DMatrixRMaj cov) Creates a random distribution with the specified mean and covariance. -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition
Modifier and TypeMethodDescriptionstatic DMatrixRMaj
UtilDecompositons_DDRM.checkZerosLT
(@Nullable DMatrixRMaj A, int numRows, int numCols) Creates a zeros matrix only if A does not already exist.static DMatrixRMaj
UtilDecompositons_DDRM.checkZerosUT
(@Nullable DMatrixRMaj A, int numRows, int numCols) Creates a zeros matrix only if A does not already exist.static DMatrixRMaj
UtilDecompositons_DDRM.ensureIdentity
(@Nullable DMatrixRMaj A, int numRows, int numCols) static DMatrixRMaj
UtilDecompositons_DDRM.ensureZeros
(@Nullable DMatrixRMaj A, int numRows, int numCols) Modifier and TypeMethodDescriptionstatic DMatrixRMaj
UtilDecompositons_DDRM.checkZerosLT
(@Nullable DMatrixRMaj A, int numRows, int numCols) Creates a zeros matrix only if A does not already exist.static DMatrixRMaj
UtilDecompositons_DDRM.checkZerosUT
(@Nullable DMatrixRMaj A, int numRows, int numCols) Creates a zeros matrix only if A does not already exist.boolean
BaseDecomposition_DDRB_to_DDRM.decompose
(DMatrixRMaj A) static DMatrixRMaj
UtilDecompositons_DDRM.ensureIdentity
(@Nullable DMatrixRMaj A, int numRows, int numCols) static DMatrixRMaj
UtilDecompositons_DDRM.ensureZeros
(@Nullable DMatrixRMaj A, int numRows, int numCols) -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.bidiagonal
Modifier and TypeMethodDescriptionBidiagonalDecompositionRow_DDRM.getB
(@Nullable DMatrixRMaj B, boolean compact) Returns the bidiagonal matrix.BidiagonalDecompositionTall_DDRM.getB
(@Nullable DMatrixRMaj B, boolean compact) BidiagonalDecompositionTall_MT_DDRM.getB
(@Nullable DMatrixRMaj B, boolean compact) BidiagonalDecompositionRow_DDRM.getU
(@Nullable DMatrixRMaj U, boolean transpose, boolean compact) Returns the orthogonal U matrix.BidiagonalDecompositionTall_DDRM.getU
(@Nullable DMatrixRMaj U, boolean transpose, boolean compact) BidiagonalDecompositionTall_MT_DDRM.getU
(@Nullable DMatrixRMaj U, boolean transpose, boolean compact) BidiagonalDecompositionRow_DDRM.getUBV()
The raw UBV matrix that is stored internally.BidiagonalDecompositionRow_DDRM.getV
(@Nullable DMatrixRMaj V, boolean transpose, boolean compact) Returns the orthogonal V matrix.BidiagonalDecompositionTall_DDRM.getV
(@Nullable DMatrixRMaj V, boolean transpose, boolean compact) BidiagonalDecompositionTall_MT_DDRM.getV
(@Nullable DMatrixRMaj V, boolean transpose, boolean compact) static DMatrixRMaj
BidiagonalDecompositionRow_DDRM.handleB
(@Nullable DMatrixRMaj B, boolean compact, int m, int n, int min) static DMatrixRMaj
BidiagonalDecompositionRow_DDRM.handleU
(@Nullable DMatrixRMaj U, boolean transpose, boolean compact, int m, int n, int min) static DMatrixRMaj
BidiagonalDecompositionRow_DDRM.handleV
(@Nullable DMatrixRMaj V, boolean transpose, boolean compact, int m, int n, int min) Modifier and TypeMethodDescriptionboolean
BidiagonalDecompositionRow_DDRM.decompose
(DMatrixRMaj A) Computes the decomposition of the provided matrix.boolean
BidiagonalDecompositionTall_DDRM.decompose
(DMatrixRMaj orig) boolean
BidiagonalDecompositionTall_MT_DDRM.decompose
(DMatrixRMaj orig) BidiagonalDecompositionRow_DDRM.getB
(@Nullable DMatrixRMaj B, boolean compact) Returns the bidiagonal matrix.BidiagonalDecompositionTall_DDRM.getB
(@Nullable DMatrixRMaj B, boolean compact) BidiagonalDecompositionTall_MT_DDRM.getB
(@Nullable DMatrixRMaj B, boolean compact) BidiagonalDecompositionRow_DDRM.getU
(@Nullable DMatrixRMaj U, boolean transpose, boolean compact) Returns the orthogonal U matrix.BidiagonalDecompositionTall_DDRM.getU
(@Nullable DMatrixRMaj U, boolean transpose, boolean compact) BidiagonalDecompositionTall_MT_DDRM.getU
(@Nullable DMatrixRMaj U, boolean transpose, boolean compact) BidiagonalDecompositionRow_DDRM.getV
(@Nullable DMatrixRMaj V, boolean transpose, boolean compact) Returns the orthogonal V matrix.BidiagonalDecompositionTall_DDRM.getV
(@Nullable DMatrixRMaj V, boolean transpose, boolean compact) BidiagonalDecompositionTall_MT_DDRM.getV
(@Nullable DMatrixRMaj V, boolean transpose, boolean compact) static DMatrixRMaj
BidiagonalDecompositionRow_DDRM.handleB
(@Nullable DMatrixRMaj B, boolean compact, int m, int n, int min) static DMatrixRMaj
BidiagonalDecompositionRow_DDRM.handleU
(@Nullable DMatrixRMaj U, boolean transpose, boolean compact, int m, int n, int min) static DMatrixRMaj
BidiagonalDecompositionRow_DDRM.handleV
(@Nullable DMatrixRMaj V, boolean transpose, boolean compact, int m, int n, int min) protected void
BidiagonalDecompositionRow_DDRM.init
(DMatrixRMaj A) Sets up internal data structures and creates a copy of the input matrix.protected void
BidiagonalDecompositionRow_DDRM.rank1UpdateMultL
(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected void
BidiagonalDecompositionRow_MT_DDRM.rank1UpdateMultL
(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected void
BidiagonalDecompositionRow_DDRM.rank1UpdateMultR
(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected void
BidiagonalDecompositionRow_MT_DDRM.rank1UpdateMultR
(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.chol
Modifier and TypeMethodDescriptionCholeskyDecompositionLDL_DDRM.getD
(@Nullable DMatrixRMaj D) CholeskyDecompositionLDL_DDRM.getL()
Returns L matrix from the decomposition.
L*D*LT=ACholeskyDecompositionLDL_DDRM.getL
(@Nullable DMatrixRMaj L) CholeskyDecomposition_DDRB_to_DDRM.getT
(@Nullable DMatrixRMaj T) CholeskyDecompositionCommon_DDRM.getT()
Returns the triangular matrix from the decomposition.CholeskyDecompositionCommon_DDRM.getT
(@Nullable DMatrixRMaj T) Modifier and TypeMethodDescriptionboolean
CholeskyDecompositionCommon_DDRM.decompose
(DMatrixRMaj mat) Performs Choleksy decomposition on the provided matrix.boolean
CholeskyDecompositionLDL_DDRM.decompose
(DMatrixRMaj mat) Performs Choleksy decomposition on the provided matrix.CholeskyDecompositionLDL_DDRM.getD
(@Nullable DMatrixRMaj D) CholeskyDecompositionLDL_DDRM.getL
(@Nullable DMatrixRMaj L) CholeskyDecomposition_DDRB_to_DDRM.getT
(@Nullable DMatrixRMaj T) CholeskyDecompositionCommon_DDRM.getT
(@Nullable DMatrixRMaj T) void
CholeskyDecompositionBlock_DDRM.solveL_special
(double[] L, DMatrixRMaj b_src, int indexSrc, int indexDst, DMatrixRMaj B) This is a variation on theTriangularSolver_DDRM.solveL(double[], double[], int)
function.void
CholeskyDecompositionBlock_MT_DDRM.solveL_special
(double[] L, DMatrixRMaj b_src, int indexSrc, int indexDst, DMatrixRMaj B) void
CholeskyDecompositionBlock_DDRM.symmRankTranA_sub
(DMatrixRMaj a, DMatrixRMaj c, int startIndexC) Performs this operation:
c = c - aTa
where c is a submatrix.void
CholeskyDecompositionBlock_MT_DDRM.symmRankTranA_sub
(DMatrixRMaj a, DMatrixRMaj c, int startIndexC) -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.eig
Modifier and TypeMethodDescriptionEigenPowerMethod_DDRM.getEigenVector()
SwitchingEigenDecomposition_DDRM.getEigenVector
(int index) SymmetricQRAlgorithmDecomposition_DDRM.getEigenVector
(int index) WatchedDoubleStepQRDecomposition_DDRM.getEigenVector
(int index) Modifier and TypeMethodDescriptionboolean
EigenPowerMethod_DDRM.computeDirect
(DMatrixRMaj A) This method computes the eigen vector with the largest eigen value by using the direct power method.boolean
EigenPowerMethod_DDRM.computeShiftDirect
(DMatrixRMaj A, double alpha) Computes the most dominant eigen vector of A using a shifted matrix.boolean
EigenPowerMethod_DDRM.computeShiftInvert
(DMatrixRMaj A, double alpha) Computes the most dominant eigen vector of A using an inverted shifted matrix.boolean
SwitchingEigenDecomposition_DDRM.decompose
(DMatrixRMaj orig) boolean
SymmetricQRAlgorithmDecomposition_DDRM.decompose
(DMatrixRMaj orig) Decomposes the matrix using the QR algorithm.boolean
WatchedDoubleStepQRDecomposition_DDRM.decompose
(DMatrixRMaj A) boolean
EigenvalueExtractor_DDRM.process
(DMatrixRMaj A) void
EigenPowerMethod_DDRM.setSeed
(DMatrixRMaj seed) Sets the value of the vector to use in the start of the iterations.ModifierConstructorDescriptionSwitchingEigenDecomposition_DDRM
(EigenDecomposition_F64<DMatrixRMaj> symmetricAlg, EigenDecomposition_F64<DMatrixRMaj> generalAlg, double tol) SymmetricQRAlgorithmDecomposition_DDRM
(TridiagonalSimilarDecomposition_F64<DMatrixRMaj> decomp, boolean computeVectors) -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.eig.symm
Modifier and TypeMethodDescriptionvoid
SymmetricQrAlgorithm_DDRM.setQ
(@Nullable DMatrixRMaj q) void
SymmetricQREigenHelper_DDRM.setQ
(DMatrixRMaj q) -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.eig.watched
Modifier and TypeFieldDescriptionprotected DMatrixRMaj
WatchedDoubleStepQREigen_DDRM._temp
@Nullable DMatrixRMaj
WatchedDoubleStepQREigen_DDRM.Q
protected DMatrixRMaj
WatchedDoubleStepQREigen_DDRM.u
Modifier and TypeMethodDescriptionWatchedDoubleStepQREigenvector_DDRM.getEigenvectors()
WatchedDoubleStepQREigenvector_DDRM.getQ()
Modifier and TypeMethodDescriptionboolean
WatchedDoubleStepQREigenvector_DDRM.extractVectors
(DMatrixRMaj Q_h) boolean
WatchedDoubleStepQREigenvalue_DDRM.process
(DMatrixRMaj origA) boolean
WatchedDoubleStepQREigenvector_DDRM.process
(WatchedDoubleStepQREigen_DDRM implicit, DMatrixRMaj A, DMatrixRMaj Q_h) protected void
WatchedDoubleStepQREigen_DDRM.rank1UpdateMultL
(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected void
WatchedDoubleStepQREigen_MT_DDRM.rank1UpdateMultL
(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected void
WatchedDoubleStepQREigen_DDRM.rank1UpdateMultR
(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected void
WatchedDoubleStepQREigen_MT_DDRM.rank1UpdateMultR
(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) void
WatchedDoubleStepQREigen_DDRM.setQ
(@Nullable DMatrixRMaj Q) void
WatchedDoubleStepQREigen_DDRM.setup
(DMatrixRMaj A) void
WatchedDoubleStepQREigenvalue_DDRM.setup
(DMatrixRMaj A) -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.hessenberg
Modifier and TypeFieldDescriptionprotected DMatrixRMaj
TridiagonalDecompositionHouseholder_DDRM.QT
Only the upper right triangle is used.Modifier and TypeMethodDescriptionHessenbergSimilarDecomposition_DDRM.getH
(@Nullable DMatrixRMaj H) An upper Hessenberg matrix from the decomposition.HessenbergSimilarDecomposition_DDRM.getQ
(@Nullable DMatrixRMaj Q) An orthogonal matrix that has the following property: H = QTAQTridiagonalDecomposition_DDRB_to_DDRM.getQ
(@Nullable DMatrixRMaj Q, boolean transposed) TridiagonalDecompositionHouseholder_DDRM.getQ
(@Nullable DMatrixRMaj Q, boolean transposed) An orthogonal matrix that has the following property: T = QTAQTridiagonalDecompositionHouseholderOrig_DDRM.getQ
(@Nullable DMatrixRMaj Q) An orthogonal matrix that has the following property: T = QTAQHessenbergSimilarDecomposition_DDRM.getQH()
The raw QH matrix that is stored internally.TridiagonalDecompositionHouseholder_DDRM.getQT()
Returns the internal matrix where the decomposed results are stored.TridiagonalDecompositionHouseholderOrig_DDRM.getQT()
Returns the interal matrix where the decomposed results are stored.TridiagonalDecomposition_DDRB_to_DDRM.getT
(@Nullable DMatrixRMaj T) TridiagonalDecompositionHouseholder_DDRM.getT
(@Nullable DMatrixRMaj T) Extracts the tridiagonal matrix found in the decomposition.TridiagonalDecompositionHouseholderOrig_DDRM.getT
(@Nullable DMatrixRMaj T) Extracts the tridiagonal matrix found in the decomposition.Modifier and TypeMethodDescriptionboolean
HessenbergSimilarDecomposition_DDRM.decompose
(DMatrixRMaj A) Computes the decomposition of the provided matrix.boolean
TridiagonalDecompositionHouseholder_DDRM.decompose
(DMatrixRMaj A) Decomposes the provided symmetric matrix.void
TridiagonalDecompositionHouseholderOrig_DDRM.decompose
(DMatrixRMaj A) Decomposes the provided symmetric matrix.HessenbergSimilarDecomposition_DDRM.getH
(@Nullable DMatrixRMaj H) An upper Hessenberg matrix from the decomposition.HessenbergSimilarDecomposition_DDRM.getQ
(@Nullable DMatrixRMaj Q) An orthogonal matrix that has the following property: H = QTAQTridiagonalDecomposition_DDRB_to_DDRM.getQ
(@Nullable DMatrixRMaj Q, boolean transposed) TridiagonalDecompositionHouseholder_DDRM.getQ
(@Nullable DMatrixRMaj Q, boolean transposed) An orthogonal matrix that has the following property: T = QTAQTridiagonalDecompositionHouseholderOrig_DDRM.getQ
(@Nullable DMatrixRMaj Q) An orthogonal matrix that has the following property: T = QTAQTridiagonalDecomposition_DDRB_to_DDRM.getT
(@Nullable DMatrixRMaj T) TridiagonalDecompositionHouseholder_DDRM.getT
(@Nullable DMatrixRMaj T) Extracts the tridiagonal matrix found in the decomposition.TridiagonalDecompositionHouseholderOrig_DDRM.getT
(@Nullable DMatrixRMaj T) Extracts the tridiagonal matrix found in the decomposition.void
TridiagonalDecompositionHouseholder_DDRM.init
(DMatrixRMaj A) If needed declares and sets up internal data structures.void
TridiagonalDecompositionHouseholderOrig_DDRM.init
(DMatrixRMaj A) If needed declares and sets up internal data structures.protected void
HessenbergSimilarDecomposition_DDRM.rank1UpdateMultL
(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected void
HessenbergSimilarDecomposition_MT_DDRM.rank1UpdateMultL
(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected void
TridiagonalDecompositionHouseholder_DDRM.rank1UpdateMultL
(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected void
TridiagonalDecompositionHouseholder_MT_DDRM.rank1UpdateMultL
(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected void
HessenbergSimilarDecomposition_DDRM.rank1UpdateMultR
(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected void
HessenbergSimilarDecomposition_MT_DDRM.rank1UpdateMultR
(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected void
TridiagonalDecompositionHouseholder_DDRM.rank1UpdateMultR
(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected void
TridiagonalDecompositionHouseholder_MT_DDRM.rank1UpdateMultR
(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.lu
Modifier and TypeMethodDescriptionLUDecompositionBase_DDRM.getLower
(@Nullable DMatrixRMaj lower) Writes the lower triangular matrix into the specified matrix.LUDecompositionBase_DDRM.getLU()
LUDecompositionBase_DDRM.getRowPivot
(@Nullable DMatrixRMaj pivot) LUDecompositionBase_DDRM.getUpper
(@Nullable DMatrixRMaj upper) Writes the upper triangular matrix into the specified matrix.Modifier and TypeMethodDescriptionboolean
LUDecompositionAlt_DDRM.decompose
(DMatrixRMaj a) This is a modified version of what was found in the JAMA package.protected void
LUDecompositionBase_DDRM.decomposeCommonInit
(DMatrixRMaj a) LUDecompositionBase_DDRM.getLower
(@Nullable DMatrixRMaj lower) Writes the lower triangular matrix into the specified matrix.LUDecompositionBase_DDRM.getRowPivot
(@Nullable DMatrixRMaj pivot) LUDecompositionBase_DDRM.getUpper
(@Nullable DMatrixRMaj upper) Writes the upper triangular matrix into the specified matrix. -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.qr
Modifier and TypeFieldDescriptionprotected DMatrixRMaj
QRDecompositionHouseholder_DDRM.QR
Where the Q and R matrices are stored.protected DMatrixRMaj
QRDecompositionHouseholderTran_DDRM.QR
Where the Q and R matrices are stored.Modifier and TypeMethodDescriptionQRColPivDecompositionHouseholderColumn_DDRM.getColPivotMatrix
(@Nullable DMatrixRMaj P) QRColPivDecompositionHouseholderColumn_DDRM.getQ
(@Nullable DMatrixRMaj Q, boolean compact) Computes the Q matrix from the information stored in the QR matrix.QRDecomposition_DDRB_to_DDRM.getQ
(@Nullable DMatrixRMaj Q, boolean compact) QRDecompositionHouseholder_DDRM.getQ
(@Nullable DMatrixRMaj Q, boolean compact) Computes the Q matrix from the imformation stored in the QR matrix.QRDecompositionHouseholderColumn_DDRM.getQ
(@Nullable DMatrixRMaj Q, boolean compact) Computes the Q matrix from the imformation stored in the QR matrix.QRDecompositionHouseholderColumn_MT_DDRM.getQ
(@Nullable DMatrixRMaj Q, boolean compact) QRDecompositionHouseholderTran_DDRM.getQ
(@Nullable DMatrixRMaj Q, boolean compact) Computes the Q matrix from the information stored in the QR matrix.QRDecompositionHouseholder_DDRM.getQR()
Returns a single matrix which contains the combined values of Q and R.QRDecompositionHouseholderTran_DDRM.getQR()
Inner matrix that stores the decompositionQRDecomposition_DDRB_to_DDRM.getR
(@Nullable DMatrixRMaj R, boolean compact) QRDecompositionHouseholder_DDRM.getR
(@Nullable DMatrixRMaj R, boolean compact) Returns an upper triangular matrix which is the R in the QR decomposition.QRDecompositionHouseholderColumn_DDRM.getR
(@Nullable DMatrixRMaj R, boolean compact) Returns an upper triangular matrix which is the R in the QR decomposition.QRDecompositionHouseholderTran_DDRM.getR
(@Nullable DMatrixRMaj R, boolean compact) Returns an upper triangular matrix which is the R in the QR decomposition.QrUpdate_DDRM.getU_tran()
Modifier and TypeMethodDescriptionvoid
QrUpdate_DDRM.addRow
(DMatrixRMaj Q, DMatrixRMaj R, double[] row, int rowIndex, boolean resizeR) Adjusts the values of the Q and R matrices to take in account the effects of inserting a row to the 'A' matrix at the specified location.void
QRDecompositionHouseholderTran_DDRM.applyQ
(DMatrixRMaj A) A = Q*Avoid
QRDecompositionHouseholderTran_DDRM.applyTranQ
(DMatrixRMaj A) A = QT*Aprotected void
QRDecompositionHouseholder_DDRM.commonSetup
(DMatrixRMaj A) This function performs sanity check on the input for decompose and sets up the QR matrix.protected void
QRDecompositionHouseholderColumn_DDRM.convertToColumnMajor
(DMatrixRMaj A) Converts the standard row-major matrix into a column-major vector that is advantageous for this problem.boolean
QRColPivDecompositionHouseholderColumn_DDRM.decompose
(DMatrixRMaj A) To decompose the matrix 'A' it must have full rank.boolean
QRDecompositionHouseholder_DDRM.decompose
(DMatrixRMaj A) In order to decompose the matrix 'A' it must have full rank.boolean
QRDecompositionHouseholderColumn_DDRM.decompose
(DMatrixRMaj A) To decompose the matrix 'A' it must have full rank.boolean
QRDecompositionHouseholderTran_DDRM.decompose
(DMatrixRMaj A) To decompose the matrix 'A' it must have full rank.void
QrUpdate_DDRM.deleteRow
(DMatrixRMaj Q, DMatrixRMaj R, int rowIndex, boolean resizeR) Adjusts the values of the Q and R matrices to take in account the effects of removing a row from the 'A' matrix at the specified location.QRColPivDecompositionHouseholderColumn_DDRM.getColPivotMatrix
(@Nullable DMatrixRMaj P) QRColPivDecompositionHouseholderColumn_DDRM.getQ
(@Nullable DMatrixRMaj Q, boolean compact) Computes the Q matrix from the information stored in the QR matrix.QRDecomposition_DDRB_to_DDRM.getQ
(@Nullable DMatrixRMaj Q, boolean compact) QRDecompositionHouseholder_DDRM.getQ
(@Nullable DMatrixRMaj Q, boolean compact) Computes the Q matrix from the imformation stored in the QR matrix.QRDecompositionHouseholderColumn_DDRM.getQ
(@Nullable DMatrixRMaj Q, boolean compact) Computes the Q matrix from the imformation stored in the QR matrix.QRDecompositionHouseholderColumn_MT_DDRM.getQ
(@Nullable DMatrixRMaj Q, boolean compact) QRDecompositionHouseholderTran_DDRM.getQ
(@Nullable DMatrixRMaj Q, boolean compact) Computes the Q matrix from the information stored in the QR matrix.QRDecomposition_DDRB_to_DDRM.getR
(@Nullable DMatrixRMaj R, boolean compact) QRDecompositionHouseholder_DDRM.getR
(@Nullable DMatrixRMaj R, boolean compact) Returns an upper triangular matrix which is the R in the QR decomposition.QRDecompositionHouseholderColumn_DDRM.getR
(@Nullable DMatrixRMaj R, boolean compact) Returns an upper triangular matrix which is the R in the QR decomposition.QRDecompositionHouseholderTran_DDRM.getR
(@Nullable DMatrixRMaj R, boolean compact) Returns an upper triangular matrix which is the R in the QR decomposition.static void
QrHelperFunctions_DDRM.rank1UpdateMultL
(DMatrixRMaj A, double[] u, double gamma, int colA0, int w0, int w1) Performs a rank-1 update operation on the submatrix specified by w with the multiply on the left.
A = A(I - γ*u*uT)static void
QrHelperFunctions_MT_DDRM.rank1UpdateMultL
(DMatrixRMaj A, double[] u, double gamma, int colA0, int w0, int w1) Performs a rank-1 update operation on the submatrix specified by w with the multiply on the left.
A = A(I - γ*u*uT)static void
QrHelperFunctions_DDRM.rank1UpdateMultR
(DMatrixRMaj A, double[] u, double gamma, int colA0, int w0, int w1, double[] _temp) Performs a rank-1 update operation on the submatrix specified by w with the multiply on the right.
A = (I - γ*u*uT)*Astatic void
QrHelperFunctions_DDRM.rank1UpdateMultR
(DMatrixRMaj A, double[] u, int offsetU, double gamma, int colA0, int w0, int w1, double[] _temp) static void
QrHelperFunctions_MT_DDRM.rank1UpdateMultR
(DMatrixRMaj A, double[] u, double gamma, int colA0, int w0, int w1, double[] _temp) Performs a rank-1 update operation on the submatrix specified by w with the multiply on the right.
A = (I - γ*u*uT)*Astatic void
QrHelperFunctions_MT_DDRM.rank1UpdateMultR
(DMatrixRMaj A, double[] u, int offsetU, double gamma, int colA0, int w0, int w1, double[] _temp) static void
QrHelperFunctions_DDRM.rank1UpdateMultR_u0
(DMatrixRMaj A, double[] u, double u_0, double gamma, int colA0, int w0, int w1, double[] _temp) static void
QrHelperFunctions_MT_DDRM.rank1UpdateMultR_u0
(DMatrixRMaj A, double[] u, double u_0, double gamma, int colA0, int w0, int w1, double[] _temp) -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.svd
Modifier and TypeFieldDescriptionprotected BidiagonalDecomposition_F64<DMatrixRMaj>
SvdImplicitQrDecompose_DDRM.bidiag
Modifier and TypeMethodDescriptionSafeSvd_DDRM.getU
(@Nullable DMatrixRMaj U, boolean transposed) SvdImplicitQrDecompose_DDRM.getU
(@Nullable DMatrixRMaj U, boolean transpose) SafeSvd_DDRM.getV
(@Nullable DMatrixRMaj V, boolean transposed) SvdImplicitQrDecompose_DDRM.getV
(@Nullable DMatrixRMaj V, boolean transpose) SafeSvd_DDRM.getW
(@Nullable DMatrixRMaj W) SvdImplicitQrDecompose_DDRM.getW
(@Nullable DMatrixRMaj W) Modifier and TypeMethodDescriptionboolean
SafeSvd_DDRM.decompose
(DMatrixRMaj orig) boolean
SvdImplicitQrDecompose_DDRM.decompose
(DMatrixRMaj orig) SafeSvd_DDRM.getU
(@Nullable DMatrixRMaj U, boolean transposed) SvdImplicitQrDecompose_DDRM.getU
(@Nullable DMatrixRMaj U, boolean transpose) SafeSvd_DDRM.getV
(@Nullable DMatrixRMaj V, boolean transposed) SvdImplicitQrDecompose_DDRM.getV
(@Nullable DMatrixRMaj V, boolean transpose) SafeSvd_DDRM.getW
(@Nullable DMatrixRMaj W) SvdImplicitQrDecompose_DDRM.getW
(@Nullable DMatrixRMaj W) protected void
SvdImplicitQrDecompose_DDRM.transpose
(@NotNull DMatrixRMaj V, DMatrixRMaj Vt) protected void
SvdImplicitQrDecompose_MT_DDRM.transpose
(@NotNull DMatrixRMaj V, DMatrixRMaj Vt) -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.svd.implicitqr
Modifier and TypeFieldDescriptionprotected @Nullable DMatrixRMaj
SvdImplicitQrAlgorithm_DDRM.Ut
protected @Nullable DMatrixRMaj
SvdImplicitQrAlgorithm_DDRM.Vt
Modifier and TypeMethodDescription@Nullable DMatrixRMaj
SvdImplicitQrAlgorithm_DDRM.getUt()
@Nullable DMatrixRMaj
SvdImplicitQrAlgorithm_DDRM.getVt()
Modifier and TypeMethodDescriptionvoid
SvdImplicitQrAlgorithm_DDRM.setUt
(@Nullable DMatrixRMaj ut) void
SvdImplicitQrAlgorithm_DDRM.setVt
(@Nullable DMatrixRMaj vt) protected void
SvdImplicitQrAlgorithm_DDRM.updateRotator
(DMatrixRMaj Q, int m, int n, double c, double s) Multiplied a transpose orthogonal matrix Q by the specified rotator. -
Uses of DMatrixRMaj in org.ejml.dense.row.factory
Modifier and TypeMethodDescriptionstatic CholeskyDecomposition_F64<DMatrixRMaj>
DecompositionFactory_DDRM.chol
(boolean lower) Returns aCholeskyDecomposition_F64
that isn't specialized for any specific matrix size.static CholeskyDecomposition_F64<DMatrixRMaj>
DecompositionFactory_DDRM.chol
(int matrixSize, boolean lower) Returns aCholeskyDecomposition_F64
that has been optimized for the specified matrix size.static CholeskyDecomposition_F64<DMatrixRMaj>
DecompositionFactory_MT_DDRM.chol
(boolean lower) Returns aCholeskyDecomposition_F64
that isn't specialized for any specific matrix size.static CholeskyDecomposition_F64<DMatrixRMaj>
DecompositionFactory_MT_DDRM.chol
(int matrixSize, boolean lower) Returns aCholeskyDecomposition_F64
that has been optimized for the specified matrix size.static LinearSolverDense<DMatrixRMaj>
LinearSolverFactory_DDRM.chol
(int numRows) Creates a linear solver using Cholesky decompositionstatic LinearSolverDense<DMatrixRMaj>
LinearSolverFactory_MT_DDRM.chol
(int numRows) Creates a linear solver using Cholesky decompositionDecompositionFactory_DDRM.cholLDL()
DecompositionFactory_DDRM.cholLDL
(int matrixSize) Returns aCholeskyDecompositionLDL_DDRM
that has been optimized for the specified matrix size.static EigenDecomposition_F64<DMatrixRMaj>
DecompositionFactory_DDRM.eig
(boolean needVectors) static EigenDecomposition_F64<DMatrixRMaj>
DecompositionFactory_DDRM.eig
(boolean computeVectors, boolean isSymmetric) static EigenDecomposition_F64<DMatrixRMaj>
DecompositionFactory_DDRM.eig
(int matrixSize, boolean needVectors) Returns anEigenDecomposition
that has been optimized for the specified matrix size.static EigenDecomposition_F64<DMatrixRMaj>
DecompositionFactory_DDRM.eig
(int matrixSize, boolean computeVectors, boolean isSymmetric) Returns anEigenDecomposition
which is specialized for symmetric matrices or the general problem.static EigenDecomposition_F64<DMatrixRMaj>
DecompositionFactory_MT_DDRM.eig
(boolean needVectors) static EigenDecomposition_F64<DMatrixRMaj>
DecompositionFactory_MT_DDRM.eig
(boolean computeVectors, boolean isSymmetric) static EigenDecomposition_F64<DMatrixRMaj>
DecompositionFactory_MT_DDRM.eig
(int matrixSize, boolean needVectors) Returns anEigenDecomposition
that has been optimized for the specified matrix size.static EigenDecomposition_F64<DMatrixRMaj>
DecompositionFactory_MT_DDRM.eig
(int matrixSize, boolean computeVectors, boolean isSymmetric) Returns anEigenDecomposition
which is specialized for symmetric matrices or the general problem.static LinearSolverDense<DMatrixRMaj>
LinearSolverFactory_DDRM.general
(int numRows, int numCols) Creates a general purpose solver.static LinearSolverDense<DMatrixRMaj>
LinearSolverFactory_DDRM.leastSquares
(int numRows, int numCols) Creates a good general purpose solver for over determined systems and returns the optimal least-squares solution.static LinearSolverDense<DMatrixRMaj>
LinearSolverFactory_MT_DDRM.leastSquares
(int numRows, int numCols) Creates a good general purpose solver for over determined systems and returns the optimal least-squares solution.static LinearSolverDense<DMatrixRMaj>
LinearSolverFactory_DDRM.leastSquaresQrPivot
(boolean computeNorm2, boolean computeQ) Linear solver which uses QR pivot decomposition.static LinearSolverDense<DMatrixRMaj>
LinearSolverFactory_DDRM.linear
(int matrixSize) Creates a solver for linear systems.static LUDecomposition_F64<DMatrixRMaj>
DecompositionFactory_DDRM.lu()
static LUDecomposition_F64<DMatrixRMaj>
DecompositionFactory_DDRM.lu
(int numRows, int numCol) Returns aLUDecomposition
that has been optimized for the specified matrix size.static LinearSolverDense<DMatrixRMaj>
LinearSolverFactory_DDRM.lu
(int numRows) Creates a linear solver using LU decompositionstatic LinearSolverDense<DMatrixRMaj>
LinearSolverFactory_DDRM.pseudoInverse
(boolean useSVD) Returns a solver which uses the pseudo inverse.static QRDecomposition<DMatrixRMaj>
DecompositionFactory_DDRM.qr()
static QRDecomposition<DMatrixRMaj>
DecompositionFactory_DDRM.qr
(int numRows, int numCols) Returns aQRDecomposition
that has been optimized for the specified matrix size.static QRDecomposition<DMatrixRMaj>
DecompositionFactory_MT_DDRM.qr()
static QRDecomposition<DMatrixRMaj>
DecompositionFactory_MT_DDRM.qr
(int numRows, int numCols) Returns aQRDecomposition
that has been optimized for the specified matrix size.static LinearSolverDense<DMatrixRMaj>
LinearSolverFactory_DDRM.qr
(int numRows, int numCols) Creates a linear solver using QR decompositionstatic LinearSolverDense<DMatrixRMaj>
LinearSolverFactory_MT_DDRM.qr
(int numRows, int numCols) Creates a linear solver using QR decompositionstatic QRPDecomposition_F64<DMatrixRMaj>
DecompositionFactory_DDRM.qrp()
static QRPDecomposition_F64<DMatrixRMaj>
DecompositionFactory_DDRM.qrp
(int numRows, int numCols) Returns aQRPDecomposition_F64
that has been optimized for the specified matrix size.static LinearSolverDense<DMatrixRMaj>
LinearSolverFactory_DDRM.qrp
(boolean computeNorm2, boolean computeQ) Creates a linear solver using QRP decompositionDecompositionFactory_DDRM.svd
(boolean needU, boolean needV, boolean compact) Returns aSingularValueDecomposition
that is NOT optimized for any specified matrix size.DecompositionFactory_DDRM.svd
(int numRows, int numCols, boolean needU, boolean needV, boolean compact) Returns aSingularValueDecomposition
that has been optimized for the specified matrix size.DecompositionFactory_MT_DDRM.svd
(boolean needU, boolean needV, boolean compact) Returns aSingularValueDecomposition
that is NOT optimized for any specified matrix size.DecompositionFactory_MT_DDRM.svd
(int numRows, int numCols, boolean needU, boolean needV, boolean compact) Returns aSingularValueDecomposition
that has been optimized for the specified matrix size.static LinearSolverDense<DMatrixRMaj>
LinearSolverFactory_DDRM.symmPosDef
(int matrixWidth) Creates a solver for symmetric positive definite matrices.static LinearSolverDense<DMatrixRMaj>
LinearSolverFactory_MT_DDRM.symmPosDef
(int matrixWidth) Creates a solver for symmetric positive definite matrices.DecompositionFactory_DDRM.tridiagonal
(int matrixSize) Checks to see if the passed in tridiagonal decomposition is of the appropriate type for the matrix of the provided size.DecompositionFactory_MT_DDRM.tridiagonal
(int matrixSize) Checks to see if the passed in tridiagonal decomposition is of the appropriate type for the matrix of the provided size.Modifier and TypeMethodDescriptionstatic double
DecompositionFactory_DDRM.quality
(DMatrixRMaj orig, DMatrixRMaj U, DMatrixRMaj W, DMatrixRMaj Vt) static double
DecompositionFactory_DDRM.quality
(DMatrixRMaj orig, EigenDecomposition_F64<DMatrixRMaj> eig) Computes a metric which measures the the quality of an eigen value decomposition.static double
DecompositionFactory_DDRM.quality
(DMatrixRMaj orig, SingularValueDecomposition<DMatrixRMaj> svd) Computes a metric which measures the the quality of a singular value decomposition.Modifier and TypeMethodDescriptionstatic double
DecompositionFactory_DDRM.quality
(DMatrixRMaj orig, EigenDecomposition_F64<DMatrixRMaj> eig) Computes a metric which measures the the quality of an eigen value decomposition.static double
DecompositionFactory_DDRM.quality
(DMatrixRMaj orig, SingularValueDecomposition<DMatrixRMaj> svd) Computes a metric which measures the the quality of a singular value decomposition. -
Uses of DMatrixRMaj in org.ejml.dense.row.linsol
Modifier and TypeMethodDescriptionprotected void
LinearSolverAbstract_DDRM._setA
(DMatrixRMaj A) static void
InvertUsingSolve_DDRM.invert
(LinearSolverDense<DMatrixRMaj> solver, DMatrix1Row A, DMatrixRMaj A_inv) static void
InvertUsingSolve_DDRM.invert
(LinearSolverDense<DMatrixRMaj> solver, DMatrix1Row A, DMatrixRMaj A_inv, DMatrixRMaj storage) void
LinearSolver_DDRB_to_DDRM.invert
(DMatrixRMaj A_inv) Creates a block matrix the same size as A_inv, inverts the matrix and copies the results back onto A_inv.void
LinearSolverAbstract_DDRM.invert
(DMatrixRMaj A_inv) void
LinearSolverUnrolled_DDRM.invert
(DMatrixRMaj A_inv) boolean
LinearSolver_DDRB_to_DDRM.setA
(DMatrixRMaj A) Converts 'A' into a block matrix and call setA() on the block matrix solver.boolean
LinearSolverUnrolled_DDRM.setA
(DMatrixRMaj A) void
LinearSolver_DDRB_to_DDRM.solve
(DMatrixRMaj B, DMatrixRMaj X) Converts B and X into block matrices and calls the block matrix solve routine.void
LinearSolverUnrolled_DDRM.solve
(DMatrixRMaj B, DMatrixRMaj X) Modifier and TypeMethodDescriptionstatic void
InvertUsingSolve_DDRM.invert
(LinearSolverDense<DMatrixRMaj> solver, DMatrix1Row A, DMatrixRMaj A_inv) static void
InvertUsingSolve_DDRM.invert
(LinearSolverDense<DMatrixRMaj> solver, DMatrix1Row A, DMatrixRMaj A_inv, DMatrixRMaj storage) -
Uses of DMatrixRMaj in org.ejml.dense.row.linsol.chol
Modifier and TypeMethodDescriptionLinearSolverChol_DDRM.getDecomposition()
LinearSolverCholLDL_DDRM.getDecomposition()
Modifier and TypeMethodDescriptionvoid
LinearSolverChol_DDRM.invert
(DMatrixRMaj inv) Sets the matrix 'inv' equal to the inverse of the matrix that was decomposed.void
LinearSolverCholLDL_DDRM.invert
(DMatrixRMaj inv) Sets the matrix 'inv' equal to the inverse of the matrix that was decomposed.boolean
LinearSolverChol_DDRM.setA
(DMatrixRMaj A) boolean
LinearSolverCholLDL_DDRM.setA
(DMatrixRMaj A) void
LinearSolverChol_DDRB.solve
(DMatrixRMaj B, DMatrixRMaj X) Only converts the B matrix and passes that onto solve.void
LinearSolverChol_DDRM.solve
(DMatrixRMaj B, DMatrixRMaj X) Using the decomposition, finds the value of 'X' in the linear equation below:
A*x = b
where A has dimension of n by n, x and b are n by m dimension.void
LinearSolverCholLDL_DDRM.solve
(DMatrixRMaj B, DMatrixRMaj X) Using the decomposition, finds the value of 'X' in the linear equation below:
A*x = b
where A has dimension of n by n, x and b are n by m dimension.static void
LinearSolverChol_DDRM.solveLower
(DMatrixRMaj L, DMatrixRMaj B, DMatrixRMaj X, double[] vv) -
Uses of DMatrixRMaj in org.ejml.dense.row.linsol.lu
Modifier and TypeMethodDescriptionvoid
LinearSolverLuBase_DDRM.improveSol
(DMatrixRMaj b, DMatrixRMaj x) This attempts to improve upon the solution generated by account for numerical imprecisions.void
LinearSolverLuBase_DDRM.invert
(DMatrixRMaj A_inv) boolean
LinearSolverLuBase_DDRM.setA
(DMatrixRMaj A) boolean
LinearSolverLuKJI_DDRM.setA
(DMatrixRMaj A) void
LinearSolverLu_DDRM.solve
(DMatrixRMaj B, DMatrixRMaj X) void
LinearSolverLuKJI_DDRM.solve
(DMatrixRMaj B, DMatrixRMaj X) An other implementation of solve() that processes the matrices in a different order. -
Uses of DMatrixRMaj in org.ejml.dense.row.linsol.qr
Modifier and TypeFieldDescriptionprotected final DMatrixRMaj
LinearSolverQrHouseCol_DDRM.a
protected DMatrixRMaj
BaseLinearSolverQrp_DDRM.I
protected DMatrixRMaj
LinearSolverQr_DDRM.Q
protected DMatrixRMaj
BaseLinearSolverQrp_DDRM.R
protected DMatrixRMaj
LinearSolverQr_DDRM.R
protected final DMatrixRMaj
LinearSolverQrHouseCol_DDRM.R
protected DMatrixRMaj
BaseLinearSolverQrp_DDRM.R11
protected final DMatrixRMaj
LinearSolverQrHouseCol_DDRM.temp
protected DMatrixRMaj
BaseLinearSolverQrp_DDRM.Y
Modifier and TypeFieldDescriptionprotected LinearSolverDense<DMatrixRMaj>
BaseLinearSolverQrp_DDRM.internalSolver
Modifier and TypeMethodDescriptionAdjLinearSolverQr_DDRM.getA()
Compute the A matrix from the Q and R matrices.LinearSolverQr_DDRM.getQ()
SolveNullSpaceQR_DDRM.getQ()
SolveNullSpaceQRP_DDRM.getQ()
LinearSolverQr_DDRM.getR()
Modifier and TypeMethodDescriptionLinearSolverQr_DDRM.getDecomposer()
BaseLinearSolverQrp_DDRM.getDecomposition()
LinearSolverQr_DDRM.getDecomposition()
LinearSolverQrHouse_DDRM.getDecomposition()
LinearSolverQrHouseCol_DDRM.getDecomposition()
LinearSolverQrHouseTran_DDRM.getDecomposition()
Modifier and TypeMethodDescriptionvoid
BaseLinearSolverQrp_DDRM.invert
(DMatrixRMaj A_inv) boolean
SolveNullSpaceQR_DDRM.process
(DMatrixRMaj A, int numSingularValues, DMatrixRMaj nullspace) Finds the null space of Aboolean
SolveNullSpaceQRP_DDRM.process
(DMatrixRMaj A, int numSingularValues, DMatrixRMaj nullspace) Finds the null space of Aboolean
BaseLinearSolverQrp_DDRM.setA
(DMatrixRMaj A) boolean
LinearSolverQr_DDRM.setA
(DMatrixRMaj A) Performs QR decomposition on Aboolean
LinearSolverQrHouse_DDRM.setA
(DMatrixRMaj A) Performs QR decomposition on Aboolean
LinearSolverQrHouseCol_DDRM.setA
(DMatrixRMaj A) Performs QR decomposition on Aboolean
LinearSolverQrHouseTran_DDRM.setA
(DMatrixRMaj A) Performs QR decomposition on Aboolean
SolvePseudoInverseQrp_DDRM.setA
(DMatrixRMaj A) void
LinearSolverQr_DDRM.solve
(DMatrixRMaj B, DMatrixRMaj X) Solves for X using the QR decomposition.void
LinearSolverQrHouse_DDRM.solve
(DMatrixRMaj B, DMatrixRMaj X) Solves for X using the QR decomposition.void
LinearSolverQrHouseCol_DDRM.solve
(DMatrixRMaj B, DMatrixRMaj X) Solves for X using the QR decomposition.void
LinearSolverQrHouseCol_MT_DDRM.solve
(DMatrixRMaj B, DMatrixRMaj X) Solves for X using the QR decomposition.void
LinearSolverQrHouseTran_DDRM.solve
(DMatrixRMaj B, DMatrixRMaj X) Solves for X using the QR decomposition.void
LinearSolverQrpHouseCol_DDRM.solve
(DMatrixRMaj B, DMatrixRMaj X) void
SolvePseudoInverseQrp_DDRM.solve
(DMatrixRMaj B, DMatrixRMaj X) protected void
BaseLinearSolverQrp_DDRM.upgradeSolution
(DMatrixRMaj X) Upgrades the basic solution to the optimal 2-norm solution.ModifierConstructorDescriptionprotected
BaseLinearSolverQrp_DDRM
(QRPDecomposition_F64<DMatrixRMaj> decomposition, boolean norm2Solution) Configures internal parameters.LinearSolverQr_DDRM
(QRDecomposition<DMatrixRMaj> decomposer) Creates a linear solver that uses QR decomposition.SolvePseudoInverseQrp_DDRM
(QRPDecomposition_F64<DMatrixRMaj> decomposition, boolean norm2Solution) Configure and provide decomposition -
Uses of DMatrixRMaj in org.ejml.dense.row.linsol.svd
Modifier and TypeMethodDescriptionSolvePseudoInverseSvd_DDRM.getDecomposer()
SolvePseudoInverseSvd_DDRM.getDecomposition()
SolveNullSpaceSvd_DDRM.getSvd()
Modifier and TypeMethodDescriptionvoid
SolvePseudoInverseSvd_DDRM.invert
(DMatrixRMaj A_inv) boolean
SolveNullSpaceSvd_DDRM.process
(DMatrixRMaj input, int numberOfSingular, DMatrixRMaj nullspace) boolean
SolvePseudoInverseSvd_DDRM.setA
(DMatrixRMaj A) void
SolvePseudoInverseSvd_DDRM.solve
(DMatrixRMaj b, DMatrixRMaj x) -
Uses of DMatrixRMaj in org.ejml.dense.row.misc
Modifier and TypeMethodDescriptionstatic void
ImplCommonOps_DDRM.extract
(DMatrixRMaj src, int srcY0, int srcX0, DMatrixRMaj dst, int dstY0, int dstX0, int numRows, int numCols) static void
UnrolledInverseFromMinor_DDRM.inv
(DMatrixRMaj mat, DMatrixRMaj inv) static void
UnrolledInverseFromMinor_DDRM.inv2
(DMatrixRMaj mat, DMatrixRMaj inv, double scale) static void
UnrolledInverseFromMinor_DDRM.inv3
(DMatrixRMaj mat, DMatrixRMaj inv, double scale) static void
UnrolledInverseFromMinor_DDRM.inv4
(DMatrixRMaj mat, DMatrixRMaj inv, double scale) static void
UnrolledInverseFromMinor_DDRM.inv5
(DMatrixRMaj mat, DMatrixRMaj inv, double scale) void
RrefGaussJordanRowPivot_DDRM.reduce
(DMatrixRMaj A, int coefficientColumns) protected static void
RrefGaussJordanRowPivot_DDRM.swapRows
(DMatrixRMaj A, int rowA, int rowB) -
Uses of DMatrixRMaj in org.ejml.dense.row.mult
Modifier and TypeMethodDescriptionstatic void
VectorVectorMult_DDRM.rank1Update
(double gamma, DMatrixRMaj A, DMatrixRMaj u, DMatrixRMaj w) Performs a rank one update on matrix A using vectors u and w.static void
VectorVectorMult_DDRM.rank1Update
(double gamma, DMatrixRMaj A, DMatrixRMaj u, DMatrixRMaj w, DMatrixRMaj B) Performs a rank one update on matrix A using vectors u and w. -
Uses of DMatrixRMaj in org.ejml.equation
Modifier and TypeMethodDescriptionvoid
Equation.alias
(DMatrixRMaj variable, String name) Adds a new Matrix variable.protected void
MatrixConstructor.setToRequiredSize
(DMatrixRMaj matrix) ModifierConstructorDescriptionVariableMatrix
(DMatrixRMaj matrix) Initializes the matrix variable. -
Uses of DMatrixRMaj in org.ejml.ops
Modifier and TypeMethodDescriptionstatic DMatrixRMaj
DConvertArrays.convert
(double[][] src, @Nullable DMatrixRMaj dst) static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix2 input, @Nullable DMatrixRMaj output) ConvertsDMatrix2
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix2x2 input, @Nullable DMatrixRMaj output) ConvertsDMatrix2x2
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix3 input, @Nullable DMatrixRMaj output) ConvertsDMatrix3
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix3x3 input, @Nullable DMatrixRMaj output) ConvertsDMatrix3x3
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix4 input, @Nullable DMatrixRMaj output) ConvertsDMatrix4
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix4x4 input, @Nullable DMatrixRMaj output) ConvertsDMatrix4x4
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix5 input, @Nullable DMatrixRMaj output) ConvertsDMatrix5
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix5x5 input, @Nullable DMatrixRMaj output) ConvertsDMatrix5x5
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix6 input, @Nullable DMatrixRMaj output) ConvertsDMatrix6
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix6x6 input, @Nullable DMatrixRMaj output) ConvertsDMatrix6x6
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrixRBlock src, @Nullable DMatrixRMaj dst) ConvertsDMatrixRBlock
intoDMatrixRMaj
static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrixSparseCSC src, @Nullable DMatrixRMaj dst) static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrixSparseTriplet src, @Nullable DMatrixRMaj dst) static DMatrixRMaj
Reads a matrix in which has been encoded using a Column Space Value (CSV) file format.static DMatrixRMaj
MatrixIO.loadMatrixMarketDDRM
(Reader reader) Reads a stream in Matrix Market Coordinate formatstatic DMatrixRMaj
MatrixIO.matlabToDDRM
(String text) Converts a text string in matlab format into a DDRM matrixReadMatrixCsv.readDDRM
(int numRows, int numCols) Reads in aDMatrixRMaj
from the IO stream where the user specifies the matrix dimensions.Modifier and TypeMethodDescriptionstatic void
ConvertMatrixData.convert
(DMatrixRMaj src, CMatrixRMaj dst) static void
ConvertMatrixData.convert
(DMatrixRMaj src, FMatrixRMaj dst) static void
ConvertMatrixData.convert
(DMatrixRMaj src, ZMatrixRMaj dst) static void
ConvertMatrixData.convert
(FMatrixRMaj src, DMatrixRMaj dst) static DMatrixRMaj
DConvertArrays.convert
(double[][] src, @Nullable DMatrixRMaj dst) static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix2 input, @Nullable DMatrixRMaj output) ConvertsDMatrix2
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix2x2 input, @Nullable DMatrixRMaj output) ConvertsDMatrix2x2
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix3 input, @Nullable DMatrixRMaj output) ConvertsDMatrix3
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix3x3 input, @Nullable DMatrixRMaj output) ConvertsDMatrix3x3
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix4 input, @Nullable DMatrixRMaj output) ConvertsDMatrix4
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix4x4 input, @Nullable DMatrixRMaj output) ConvertsDMatrix4x4
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix5 input, @Nullable DMatrixRMaj output) ConvertsDMatrix5
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix5x5 input, @Nullable DMatrixRMaj output) ConvertsDMatrix5x5
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix6 input, @Nullable DMatrixRMaj output) ConvertsDMatrix6
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrix6x6 input, @Nullable DMatrixRMaj output) ConvertsDMatrix6x6
intoDMatrixRMaj
.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrixRBlock src, @Nullable DMatrixRMaj dst) ConvertsDMatrixRBlock
intoDMatrixRMaj
static DMatrix2
DConvertMatrixStruct.convert
(DMatrixRMaj input, @Nullable DMatrix2 output) ConvertsDMatrixRMaj
intoDMatrix2
static DMatrix2x2
DConvertMatrixStruct.convert
(DMatrixRMaj input, @Nullable DMatrix2x2 output) ConvertsDMatrixRMaj
intoDMatrix2x2
static DMatrix3
DConvertMatrixStruct.convert
(DMatrixRMaj input, @Nullable DMatrix3 output) ConvertsDMatrixRMaj
intoDMatrix3
static DMatrix3x3
DConvertMatrixStruct.convert
(DMatrixRMaj input, @Nullable DMatrix3x3 output) ConvertsDMatrixRMaj
intoDMatrix3x3
static DMatrix4
DConvertMatrixStruct.convert
(DMatrixRMaj input, @Nullable DMatrix4 output) ConvertsDMatrixRMaj
intoDMatrix4
static DMatrix4x4
DConvertMatrixStruct.convert
(DMatrixRMaj input, @Nullable DMatrix4x4 output) ConvertsDMatrixRMaj
intoDMatrix4x4
static DMatrix5
DConvertMatrixStruct.convert
(DMatrixRMaj input, @Nullable DMatrix5 output) ConvertsDMatrixRMaj
intoDMatrix5
static DMatrix5x5
DConvertMatrixStruct.convert
(DMatrixRMaj input, @Nullable DMatrix5x5 output) ConvertsDMatrixRMaj
intoDMatrix5x5
static DMatrix6
DConvertMatrixStruct.convert
(DMatrixRMaj input, @Nullable DMatrix6 output) ConvertsDMatrixRMaj
intoDMatrix6
static DMatrix6x6
DConvertMatrixStruct.convert
(DMatrixRMaj input, @Nullable DMatrix6x6 output) ConvertsDMatrixRMaj
intoDMatrix6x6
static DMatrixSparseCSC
DConvertMatrixStruct.convert
(DMatrixRMaj src, @Nullable DMatrixSparseCSC dst, double tol) Converts DMatrixRMaj into a DMatrixSparseCSCstatic DMatrixSparseTriplet
DConvertMatrixStruct.convert
(DMatrixRMaj src, @Nullable DMatrixSparseTriplet dst, double tol) static void
DConvertMatrixStruct.convert
(DMatrixRMaj src, DMatrixRBlock dst) ConvertsDMatrixRMaj
intoDMatrixRBlock
Can't handle null output matrix since block size needs to be specified.static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrixSparseCSC src, @Nullable DMatrixRMaj dst) static DMatrixRMaj
DConvertMatrixStruct.convert
(DMatrixSparseTriplet src, @Nullable DMatrixRMaj dst) static void
MatrixIO.saveMatrixMarket
(DMatrixRMaj matrix, String floatFormat, Writer writer) Writes a stream using the Matrix Market Coordinate format. -
Uses of DMatrixRMaj in org.ejml.simple
-
Uses of DMatrixRMaj in org.ejml.simple.ops
Modifier and TypeMethodDescriptionvoid
SimpleOperations_DDRM.changeSign
(DMatrixRMaj a) double
SimpleOperations_DDRM.conditionP2
(DMatrixRMaj A) double
SimpleOperations_DDRM.determinant
(DMatrixRMaj A) SimpleOperations_DDRM.diag
(DMatrixRMaj A) void
SimpleOperations_DDRM.divide
(DMatrixRMaj A, double val, DMatrixRMaj output) double
SimpleOperations_DDRM.dot
(DMatrixRMaj A, DMatrixRMaj v) void
SimpleOperations_DDRM.elementDiv
(DMatrixRMaj A, DMatrixRMaj B, DMatrixRMaj output) void
SimpleOperations_DDRM.elementExp
(DMatrixRMaj A, DMatrixRMaj output) void
SimpleOperations_DDRM.elementLog
(DMatrixRMaj A, DMatrixRMaj output) double
SimpleOperations_DDRM.elementMax
(DMatrixRMaj A) double
SimpleOperations_DDRM.elementMaxAbs
(DMatrixRMaj A) double
SimpleOperations_DDRM.elementMin
(DMatrixRMaj A) double
SimpleOperations_DDRM.elementMinAbs
(DMatrixRMaj A) void
SimpleOperations_DDRM.elementMult
(DMatrixRMaj A, DMatrixRMaj B, DMatrixRMaj output) void
SimpleOperations_DDRM.elementOp
(DMatrixRMaj A, SimpleOperations.ElementOpComplex op, DMatrixRMaj output) void
SimpleOperations_DDRM.elementOp
(DMatrixRMaj A, SimpleOperations.ElementOpReal op, DMatrixRMaj output) void
SimpleOperations_DDRM.elementPower
(DMatrixRMaj A, double b, DMatrixRMaj output) void
SimpleOperations_DDRM.elementPower
(DMatrixRMaj A, DMatrixRMaj B, DMatrixRMaj output) double
SimpleOperations_DDRM.elementSum
(DMatrixRMaj A) void
SimpleOperations_DDRM.extract
(DMatrixRMaj src, int srcY0, int srcY1, int srcX0, int srcX1, DMatrixRMaj dst, int dstY0, int dstX0) void
SimpleOperations_DSCC.extractDiag
(DMatrixSparseCSC input, DMatrixRMaj output) void
SimpleOperations_DDRM.fill
(DMatrixRMaj A, double value) double
SimpleOperations_DDRM.get
(DMatrixRMaj A, int row, int column) void
SimpleOperations_DDRM.get
(DMatrixRMaj A, int row, int column, Complex_F64 value) double[]
SimpleOperations_DDRM.getColumn
(DMatrixRMaj A, int col, int row0, int row1) double
SimpleOperations_DDRM.getImaginary
(DMatrixRMaj A, int row, int column) double
SimpleOperations_DDRM.getReal
(DMatrixRMaj A, int row, int column) double[]
SimpleOperations_DDRM.getRow
(DMatrixRMaj A, int row, int idx0, int idx1) boolean
SimpleOperations_DDRM.hasUncountable
(DMatrixRMaj M) boolean
SimpleOperations_DDRM.invert
(DMatrixRMaj A, DMatrixRMaj output) boolean
SimpleOperations_DDRM.isIdentical
(DMatrixRMaj A, DMatrixRMaj B, double tol) void
SimpleOperations_DDRM.kron
(DMatrixRMaj A, DMatrixRMaj B, DMatrixRMaj output) void
SimpleOperations_DDRM.minus
(DMatrixRMaj A, double b, DMatrixRMaj output) void
SimpleOperations_DDRM.minus
(DMatrixRMaj A, DMatrixRMaj B, DMatrixRMaj output) void
SimpleOperations_DDRM.mult
(DMatrixRMaj A, DMatrixRMaj B, DMatrixRMaj output) void
SimpleOperations_DSCC.mult
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj output) void
SimpleOperations_DDRM.multTransA
(DMatrixRMaj A, DMatrixRMaj B, DMatrixRMaj output) void
SimpleOperations_DSCC.multTransA
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj output) double
SimpleOperations_DDRM.normF
(DMatrixRMaj A) void
SimpleOperations_DDRM.plus
(double alpha, DMatrixRMaj A, double beta, DMatrixRMaj b, DMatrixRMaj output) void
SimpleOperations_DDRM.plus
(DMatrixRMaj A, double b, DMatrixRMaj output) void
SimpleOperations_DDRM.plus
(DMatrixRMaj A, double beta, DMatrixRMaj b, DMatrixRMaj output) void
SimpleOperations_DDRM.plus
(DMatrixRMaj A, DMatrixRMaj B, DMatrixRMaj output) void
SimpleOperations_DDRM.pseudoInverse
(DMatrixRMaj A, DMatrixRMaj output) void
SimpleOperations_DDRM.scale
(DMatrixRMaj A, double val, DMatrixRMaj output) void
SimpleOperations_DDRM.set
(DMatrixRMaj A, int row, int column, double value) void
SimpleOperations_DDRM.set
(DMatrixRMaj A, int row, int column, double real, double imaginary) void
SimpleOperations_DDRM.setColumn
(DMatrixRMaj A, int column, int startRow, double... values) void
SimpleOperations_DDRM.setIdentity
(DMatrixRMaj A) void
SimpleOperations_DDRM.setRow
(DMatrixRMaj A, int row, int startColumn, double... values) boolean
SimpleOperations_DDRM.solve
(DMatrixRMaj A, DMatrixRMaj X, DMatrixRMaj B) boolean
SimpleOperations_DSCC.solve
(DMatrixSparseCSC A, DMatrixRMaj X, DMatrixRMaj B) double
SimpleOperations_DDRM.trace
(DMatrixRMaj A) void
SimpleOperations_DDRM.transpose
(DMatrixRMaj input, DMatrixRMaj output) void
SimpleOperations_DDRM.zero
(DMatrixRMaj A) -
Uses of DMatrixRMaj in org.ejml.sparse.csc
Modifier and TypeMethodDescriptionstatic DMatrixRMaj
CommonOps_DSCC.maxCols
(DMatrixSparseCSC input, @Nullable DMatrixRMaj output) Computes the maximums of each column in the input matrix and returns the results in a vector:
bj = max(i=1:m ; aij)static DMatrixRMaj
CommonOps_DSCC.maxRows
(DMatrixSparseCSC input, @Nullable DMatrixRMaj output, @Nullable IGrowArray gw) Computes the maximum of each row in the input matrix and returns the results in a vector:
bj = max(i=1:n ; aji)static DMatrixRMaj
CommonOps_DSCC.minCols
(DMatrixSparseCSC input, @Nullable DMatrixRMaj output) Computes the minimum of each column in the input matrix and returns the results in a vector:
bj = min(i=1:m ; aij)static DMatrixRMaj
CommonOps_DSCC.minRows
(DMatrixSparseCSC input, @Nullable DMatrixRMaj output, @Nullable IGrowArray gw) Computes the minimum of each row in the input matrix and returns the results in a vector:
bj = min(i=1:n ; aji)static DMatrixRMaj
CommonOps_DSCC.mult
(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC) Performs matrix multiplication.static DMatrixRMaj
CommonOps_MT_DSCC.mult
(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable GrowArray<DGrowArray> workspace) Performs matrix multiplication.static DMatrixRMaj
CommonOpsWithSemiRing_DSCC.mult
(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj output, DSemiRing semiRing) Performs matrix multiplication.static DMatrixRMaj
CommonOps_DSCC.multTransA
(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable DGrowArray work) Performs matrix multiplication.static DMatrixRMaj
CommonOps_MT_DSCC.multTransA
(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable GrowArray<DGrowArray> workspace) Performs matrix multiplication.static DMatrixRMaj
CommonOpsWithSemiRing_DSCC.multTransA
(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj output, DSemiRing semiRing) Performs matrix multiplication.static DMatrixRMaj
CommonOps_DSCC.multTransAB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC) Performs matrix multiplication.static DMatrixRMaj
CommonOps_MT_DSCC.multTransAB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC) Performs matrix multiplication.static DMatrixRMaj
CommonOpsWithSemiRing_DSCC.multTransAB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj output, DSemiRing semiRing) Performs matrix multiplication.static DMatrixRMaj
CommonOps_DSCC.multTransB
(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable DGrowArray work) Performs matrix multiplication.static DMatrixRMaj
CommonOps_MT_DSCC.multTransB
(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable GrowArray<DGrowArray> workspace) Performs matrix multiplication.static DMatrixRMaj
CommonOpsWithSemiRing_DSCC.multTransB
(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj output, DSemiRing semiRing) Performs matrix multiplication.static DMatrixRMaj
CommonOps_DSCC.reduceColumnWise
(DMatrixSparseCSC input, double initValue, DOperatorBinary func, @Nullable DMatrixRMaj output, @Nullable Mask mask) This accumulates the values per column to a scalar valuestatic DMatrixRMaj
CommonOps_DSCC.reduceRowWise
(DMatrixSparseCSC input, double initValue, DOperatorBinary func, @Nullable DMatrixRMaj output) This accumulates the values per row to a scalar valuestatic DMatrixRMaj
CommonOps_DSCC.sumCols
(DMatrixSparseCSC input, @Nullable DMatrixRMaj output) Computes the sum of each column in the input matrix and returns the results in a vector:
bj = sum(i=1:m ; aij)static DMatrixRMaj
CommonOps_DSCC.sumRows
(DMatrixSparseCSC input, @Nullable DMatrixRMaj output) Computes the sum of each row in the input matrix and returns the results in a vector:
bj = sum(i=1:n ; aji)Modifier and TypeMethodDescriptionstatic void
CommonOps_DSCC.extractDiag
(DMatrixSparseCSC A, DMatrixRMaj outputB) Extracts the diagonal elements 'src' write it to the 'dst' vector.static boolean
CommonOps_DSCC.invert
(DMatrixSparseCSC A, DMatrixRMaj inverse) Performs a matrix inversion operation that does not modify the original and stores the results in another matrix.static void
CommonOps_DSCC.maxAbsCols
(DMatrixSparseCSC A, @Nullable DMatrixRMaj outputB) Finds the maximum abs in each column of A and stores it into valuesstatic DMatrixRMaj
CommonOps_DSCC.maxCols
(DMatrixSparseCSC input, @Nullable DMatrixRMaj output) Computes the maximums of each column in the input matrix and returns the results in a vector:
bj = max(i=1:m ; aij)static DMatrixRMaj
CommonOps_DSCC.maxRows
(DMatrixSparseCSC input, @Nullable DMatrixRMaj output, @Nullable IGrowArray gw) Computes the maximum of each row in the input matrix and returns the results in a vector:
bj = max(i=1:n ; aji)static DMatrixRMaj
CommonOps_DSCC.minCols
(DMatrixSparseCSC input, @Nullable DMatrixRMaj output) Computes the minimum of each column in the input matrix and returns the results in a vector:
bj = min(i=1:m ; aij)static DMatrixRMaj
CommonOps_DSCC.minRows
(DMatrixSparseCSC input, @Nullable DMatrixRMaj output, @Nullable IGrowArray gw) Computes the minimum of each row in the input matrix and returns the results in a vector:
bj = min(i=1:n ; aji)static DMatrixRMaj
CommonOps_DSCC.mult
(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC) Performs matrix multiplication.static DMatrixRMaj
CommonOps_MT_DSCC.mult
(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable GrowArray<DGrowArray> workspace) Performs matrix multiplication.static DMatrixRMaj
CommonOpsWithSemiRing_DSCC.mult
(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj output, DSemiRing semiRing) Performs matrix multiplication.static void
CommonOps_DSCC.multAdd
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC) C = C + A*Bstatic void
CommonOps_MT_DSCC.multAdd
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC, @Nullable GrowArray<DGrowArray> workspace) C = C + AT*Bstatic void
CommonOpsWithSemiRing_DSCC.multAdd
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj output, DSemiRing semiRing) output = output + A*Bstatic void
CommonOps_DSCC.multAddTransA
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC, @Nullable DGrowArray work) C = C + AT*Bstatic void
CommonOps_MT_DSCC.multAddTransA
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC, @Nullable GrowArray<DGrowArray> workspace) C = C + AT*Bstatic void
CommonOpsWithSemiRing_DSCC.multAddTransA
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj output, DSemiRing semiRing) output = output + AT*Bstatic void
CommonOps_DSCC.multAddTransAB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC) C = C + AT*BTstatic void
CommonOps_MT_DSCC.multAddTransAB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC) C = C + AT*BTstatic void
CommonOpsWithSemiRing_DSCC.multAddTransAB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DSemiRing semiRing) C = C + AT*BTstatic void
CommonOps_DSCC.multAddTransB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC, @Nullable DGrowArray work) C = C + A*BTstatic void
CommonOps_MT_DSCC.multAddTransB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC, @Nullable GrowArray<DGrowArray> workspace) C = C + A*BTstatic void
CommonOpsWithSemiRing_DSCC.multAddTransB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj output, DSemiRing semiRing) output = output + A*BTstatic DMatrixRMaj
CommonOps_DSCC.multTransA
(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable DGrowArray work) Performs matrix multiplication.static DMatrixRMaj
CommonOps_MT_DSCC.multTransA
(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable GrowArray<DGrowArray> workspace) Performs matrix multiplication.static DMatrixRMaj
CommonOpsWithSemiRing_DSCC.multTransA
(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj output, DSemiRing semiRing) Performs matrix multiplication.static DMatrixRMaj
CommonOps_DSCC.multTransAB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC) Performs matrix multiplication.static DMatrixRMaj
CommonOps_MT_DSCC.multTransAB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC) Performs matrix multiplication.static DMatrixRMaj
CommonOpsWithSemiRing_DSCC.multTransAB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj output, DSemiRing semiRing) Performs matrix multiplication.static DMatrixRMaj
CommonOps_DSCC.multTransB
(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable DGrowArray work) Performs matrix multiplication.static DMatrixRMaj
CommonOps_MT_DSCC.multTransB
(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable GrowArray<DGrowArray> workspace) Performs matrix multiplication.static DMatrixRMaj
CommonOpsWithSemiRing_DSCC.multTransB
(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj output, DSemiRing semiRing) Performs matrix multiplication.static DMatrixRMaj
CommonOps_DSCC.reduceColumnWise
(DMatrixSparseCSC input, double initValue, DOperatorBinary func, @Nullable DMatrixRMaj output, @Nullable Mask mask) This accumulates the values per column to a scalar valuestatic DMatrixRMaj
CommonOps_DSCC.reduceRowWise
(DMatrixSparseCSC input, double initValue, DOperatorBinary func, @Nullable DMatrixRMaj output) This accumulates the values per row to a scalar valuestatic boolean
CommonOps_DSCC.solve
(DMatrixSparseCSC a, DMatrixRMaj b, DMatrixRMaj x) Solves for x in the following equation:
A*x = bstatic DMatrixRMaj
CommonOps_DSCC.sumCols
(DMatrixSparseCSC input, @Nullable DMatrixRMaj output) Computes the sum of each column in the input matrix and returns the results in a vector:
bj = sum(i=1:m ; aij)static DMatrixRMaj
CommonOps_DSCC.sumRows
(DMatrixSparseCSC input, @Nullable DMatrixRMaj output) Computes the sum of each row in the input matrix and returns the results in a vector:
bj = sum(i=1:n ; aji) -
Uses of DMatrixRMaj in org.ejml.sparse.csc.factory
Modifier and TypeMethodDescriptionLinearSolverFactory_DSCC.cholesky
(FillReducing permutation) LinearSolverFactory_DSCC.lu
(FillReducing permutation) LinearSolverFactory_DSCC.qr
(FillReducing permutation) -
Uses of DMatrixRMaj in org.ejml.sparse.csc.linsol.chol
Modifier and TypeMethodDescriptionvoid
LinearSolverCholesky_DSCC.solve
(DMatrixRMaj B, DMatrixRMaj X) -
Uses of DMatrixRMaj in org.ejml.sparse.csc.linsol.lu
-
Uses of DMatrixRMaj in org.ejml.sparse.csc.linsol.qr
Modifier and TypeMethodDescriptionvoid
LinearSolverQrLeftLooking_DSCC.solve
(DMatrixRMaj B, DMatrixRMaj X) -
Uses of DMatrixRMaj in org.ejml.sparse.csc.mult
Modifier and TypeMethodDescriptionstatic double
MatrixVectorMult_DSCC.innerProduct
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixSparseCSC C) scalar = AT*B*Cstatic double
MatrixVectorMult_DSCC.innerProductSelfSymmetrical
(DMatrixSparseCSC A, DMatrixRMaj B) scalar = AT*B*Astatic void
ImplMultiplication_DSCC.mult
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C) Invoke throughCommonOps_DSCC
static void
ImplMultiplication_MT_DSCC.mult
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, boolean add, GrowArray<DGrowArray> listWork) Invoke throughCommonOps_MT_DSCC
as it will manage the input contractstatic void
ImplMultiplication_MT_DSCC.mult
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, GrowArray<DGrowArray> listWork) Invoke throughCommonOps_MT_DSCC
as it will manage the input contractstatic void
ImplMultiplicationWithSemiRing_DSCC.mult
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DSemiRing semiRing) static void
ImplMultiplication_DSCC.multAdd
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C) Invoke throughCommonOps_DSCC
static void
ImplMultiplication_MT_DSCC.multAdd
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, GrowArray<DGrowArray> listWork) Invoke throughCommonOps_MT_DSCC
as it will manage the input contractstatic void
ImplMultiplicationWithSemiRing_DSCC.multAdd
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DSemiRing semiRing) static void
ImplMultiplication_DSCC.multAddTransA
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DGrowArray workArray) Invoke throughCommonOps_DSCC
static void
ImplMultiplication_MT_DSCC.multAddTransA
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, GrowArray<DGrowArray> listWork) Invoke throughCommonOps_MT_DSCC
as it will manage the input contractstatic void
ImplMultiplicationWithSemiRing_DSCC.multAddTransA
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DSemiRing semiRing) static void
ImplMultiplication_DSCC.multAddTransAB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C) Invoke throughCommonOps_DSCC
static void
ImplMultiplication_MT_DSCC.multAddTransAB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C) Invoke throughCommonOps_MT_DSCC
as it will manage the input contractstatic void
ImplMultiplicationWithSemiRing_DSCC.multAddTransAB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DSemiRing semiRing) static void
ImplMultiplication_DSCC.multAddTransB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DGrowArray workArray) Invoke throughCommonOps_DSCC
static void
ImplMultiplication_MT_DSCC.multAddTransB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, GrowArray<DGrowArray> listWork) Invoke throughCommonOps_MT_DSCC
as it will manage the input contractstatic void
ImplMultiplicationWithSemiRing_DSCC.multAddTransB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DSemiRing semiRing) static void
ImplMultiplication_DSCC.multTransA
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DGrowArray workArray) Invoke throughCommonOps_DSCC
static void
ImplMultiplication_DSCC.multTransA
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DGrowArray workArray, DOperatorBinary op) Invoke throughCommonOps_DSCC
static void
ImplMultiplication_MT_DSCC.multTransA
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, GrowArray<DGrowArray> listWork) Invoke throughCommonOps_MT_DSCC
as it will manage the input contractstatic void
ImplMultiplicationWithSemiRing_DSCC.multTransA
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DSemiRing semiRing) static void
ImplMultiplication_DSCC.multTransAB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C) Invoke throughCommonOps_DSCC
static void
ImplMultiplication_MT_DSCC.multTransAB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C) Invoke throughCommonOps_MT_DSCC
as it will manage the input contractstatic void
ImplMultiplicationWithSemiRing_DSCC.multTransAB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DSemiRing semiRing) static void
ImplMultiplication_DSCC.multTransB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DGrowArray workArray) Invoke throughCommonOps_DSCC
static void
ImplMultiplication_MT_DSCC.multTransB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, boolean add, GrowArray<DGrowArray> listWork) Invoke throughCommonOps_MT_DSCC
as it will manage the input contractstatic void
ImplMultiplication_MT_DSCC.multTransB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, GrowArray<DGrowArray> listWork) Invoke throughCommonOps_MT_DSCC
as it will manage the input contractstatic void
ImplMultiplicationWithSemiRing_DSCC.multTransB
(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DSemiRing semiRing)