Uses of Class
org.ejml.data.FMatrixRMaj
Package
Description
-
Uses of FMatrixRMaj in org.ejml
Modifier and TypeMethodDescriptionstatic FMatrixRMaj
UtilEjml.parse_FDRM
(String s, int numColumns) Give a string of numbers it returns a DenseMatrixstatic FMatrixRMaj
UtilEjml.reshapeOrDeclare
(@Nullable FMatrixRMaj a, int rows, int cols) If the input matrix is null a new matrix is created and returned.Modifier and TypeMethodDescriptionstatic FMatrixRMaj
UtilEjml.reshapeOrDeclare
(@Nullable FMatrixRMaj a, int rows, int cols) If the input matrix is null a new matrix is created and returned. -
Uses of FMatrixRMaj in org.ejml.data
Modifier and TypeMethodDescriptionFMatrixRMaj.copy()
Creates and returns a matrix which is identical to this one.FMatrixRMaj.create
(int numRows, int numCols) FMatrixRMaj.createLike()
FSubmatrixD1.extract()
static FMatrixRMaj
FMatrixRMaj.wrap
(int numRows, int numCols, float[] data) Creates a new FMatrixRMaj around the provided data.ModifierConstructorDescriptionFEigenpair
(float value, FMatrixRMaj vector) FMatrixRMaj
(FMatrixRMaj orig) Creates a new matrix which is equivalent to the provided matrix. -
Uses of FMatrixRMaj in org.ejml.dense.block
Modifier and TypeMethodDescriptionstatic FMatrixRMaj
MatrixOps_FDRB.convert
(FMatrixRBlock src, FMatrixRMaj dst) Converts a row major block matrix into a row major matrix.static FMatrixRMaj
MatrixOps_FDRB.convertInplace
(FMatrixRBlock src, @Nullable FMatrixRMaj dst, @Nullable FGrowArray workspace) Converts a row major block matrix into a row major matrix.Modifier and TypeMethodDescriptionstatic FMatrixRMaj
MatrixOps_FDRB.convert
(FMatrixRBlock src, FMatrixRMaj dst) Converts a row major block matrix into a row major matrix.static FMatrixRBlock
MatrixOps_FDRB.convert
(FMatrixRMaj A) static FMatrixRBlock
MatrixOps_FDRB.convert
(FMatrixRMaj A, int blockLength) static void
MatrixOps_FDRB.convert
(FMatrixRMaj src, FMatrixRBlock dst) Converts a row major matrix into a row major block matrix.static FMatrixRMaj
MatrixOps_FDRB.convertInplace
(FMatrixRBlock src, @Nullable FMatrixRMaj dst, @Nullable FGrowArray workspace) Converts a row major block matrix into a row major matrix.static FMatrixRBlock
MatrixOps_FDRB.convertInplace
(FMatrixRMaj src, @Nullable FMatrixRBlock dst, @Nullable FGrowArray workspace) Converts a row major matrix into a row major block matrix.static void
MatrixOps_FDRB.convertTranSrc
(FMatrixRMaj src, FMatrixRBlock dst) Converts the transpose of a row major matrix into a row major block matrix. -
Uses of FMatrixRMaj in org.ejml.dense.block.decomposition.hessenberg
Modifier and TypeFieldDescriptionprotected FMatrixRMaj
TridiagonalDecompositionHouseholder_FDRB.zerosM
protected FMatrixRMaj
TridiagonalDecompositionHouseholder_MT_FDRB.zerosM
-
Uses of FMatrixRMaj in org.ejml.dense.row
Modifier and TypeMethodDescriptionstatic FMatrixRMaj
CommonOps_FDRM.apply
(FMatrixRMaj input, FOperatorUnary func) static FMatrixRMaj
CommonOps_FDRM.apply
(FMatrixRMaj input, FOperatorUnary func, @Nullable FMatrixRMaj output) This applies a given unary function on every value stored in the matrixstatic FMatrixRMaj[]
CommonOps_FDRM.columnsToVector
(FMatrixRMaj A, @Nullable FMatrixRMaj[] v) Converts the columns in a matrix into a set of vectors.static FMatrixRMaj
CommonOps_FDRM.concatColumns
(FMatrixRMaj a, FMatrixRMaj b, @Nullable FMatrixRMaj output) output = [a , b]static FMatrixRMaj
CommonOps_FDRM.concatColumnsMulti
(FMatrixRMaj... m) Concatenates all the matrices together along their columns.static FMatrixRMaj
CommonOps_FDRM.concatRowsMulti
(FMatrixRMaj... m) Concatenates all the matrices together along their columns.static FMatrixRMaj
SpecializedOps_FDRM.copyChangeRow
(int[] order, FMatrixRMaj src, @Nullable FMatrixRMaj dst) Creates a copy of a matrix but swaps the rows as specified by the order array.static FMatrixRMaj
SpecializedOps_FDRM.copyTriangle
(FMatrixRMaj src, @Nullable FMatrixRMaj dst, boolean upper) Copies just the upper or lower triangular portion of a matrix.static FMatrixRMaj
EigenOps_FDRM.createMatrixD
(EigenDecomposition_F32<?> eig) A diagonal matrix where real diagonal element contains a real eigenvalue.static FMatrixRMaj
EigenOps_FDRM.createMatrixV
(EigenDecomposition_F32<FMatrixRMaj> eig) Puts all the real eigenvectors into the columns of a matrix.static FMatrixRMaj
SpecializedOps_FDRM.createReflector
(FMatrix1Row u) Creates a reflector from the provided vector.
Q = I - γ u uT
γ = 2/||u||2static FMatrixRMaj
SpecializedOps_FDRM.createReflector
(FMatrixRMaj u, float gamma) Creates a reflector from the provided vector and gamma.
Q = I - γ u uTstatic FMatrixRMaj
CommonOps_FDRM.diag
(float... 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 FMatrixRMaj
CommonOps_FDRM.diag
(@Nullable FMatrixRMaj ret, int width, float... diagEl) static FMatrixRMaj
Creates a random diagonal matrix where the diagonal elements are selected from a uniform distribution that goes from min to max.static FMatrixRMaj
Creates a random matrix where all elements are zero but diagonal elements.static FMatrixRMaj
CommonOps_FDRM.diagR
(int numRows, int numCols, float... 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 FMatrixRMaj
CommonOps_FDRM.elements
(FMatrixRMaj A, BMatrixRMaj marked, @Nullable FMatrixRMaj output) Returns a row matrix which contains all the elements in A which are flagged as true in 'marked'static FMatrixRMaj
CommonOps_FDRM.extract
(FMatrixRMaj src, int[] rows, int rowsSize, int[] cols, int colsSize, @Nullable FMatrixRMaj dst) Extracts out a matrix from source given a sub matrix with arbitrary rows and columns specified in two array listsstatic FMatrixRMaj
CommonOps_FDRM.extract
(FMatrixRMaj src, int[] indexes, int length, @Nullable FMatrixRMaj dst) Extracts the elements from the source matrix by their 1D index.static FMatrixRMaj
CommonOps_FDRM.extract
(FMatrixRMaj src, int srcY0, int srcY1, int srcX0, int srcX1) Creates a new matrix which is the specified submatrix of 'src'static FMatrixRMaj
CommonOps_FDRM.extractColumn
(FMatrixRMaj a, int column, @Nullable FMatrixRMaj out) Extracts the column from a matrix.static FMatrixRMaj
CommonOps_FDRM.extractDiag
(FMatrixRMaj src, @Nullable FMatrixRMaj dst) Extracts the diagonal elements 'src' write it to the 'dst' vector.static FMatrixRMaj
CommonOps_FDRM.extractRow
(FMatrixRMaj a, int row, @Nullable FMatrixRMaj out) Extracts the row from a matrix.static FMatrixRMaj
CommonOps_FDRM.identity
(int width) Creates an identity matrix of the specified size.
aij = 0 if i ≠ j
aij = 1 if i = jstatic FMatrixRMaj
CommonOps_FDRM.identity
(int numRows, int numCols) Creates a rectangular matrix which is zero except along the diagonals.static FMatrixRMaj
CommonOps_CDRM.imaginary
(CMatrixD1 input, @Nullable FMatrixRMaj output) Places the imaginary component of the input matrix into the output matrix.static FMatrixRMaj
RandomMatrices_FDRM.insideSpan
(FMatrixRMaj[] span, float min, float max, Random rand) Creates a random vector that is inside the specified span.static FMatrixRMaj
CommonOps_FDRM.kron
(FMatrixRMaj A, FMatrixRMaj B, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_CDRM.magnitude
(CMatrixD1 input, @Nullable FMatrixRMaj output) Computes the magnitude of the complex number in the input matrix and stores the results in the output matrix.static FMatrixRMaj
CommonOps_FDRM.maxCols
(FMatrixRMaj input, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_FDRM.maxRows
(FMatrixRMaj input, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_FDRM.minCols
(FMatrixRMaj input, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_FDRM.minRows
(FMatrixRMaj input, @Nullable FMatrixRMaj 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 FMatrixRMaj
SingularOps_FDRM.nullSpace
(SingularValueDecomposition_F32<FMatrixRMaj> svd, @Nullable FMatrixRMaj nullSpace, float tol) Returns the null-space from the singular value decomposition.static FMatrixRMaj
SingularOps_FDRM.nullspaceQR
(FMatrixRMaj A, int totalSingular) Computes the null space using QR decomposition.static FMatrixRMaj
SingularOps_FDRM.nullspaceQRP
(FMatrixRMaj A, int totalSingular) Computes the null space using QRP decomposition.static FMatrixRMaj
SingularOps_FDRM.nullspaceSVD
(FMatrixRMaj A, int totalSingular) Computes the null space using SVD.static FMatrixRMaj
SingularOps_FDRM.nullVector
(SingularValueDecomposition_F32<FMatrixRMaj> svd, boolean isRight, @Nullable FMatrixRMaj nullVector) The vector associated will the smallest singular value is returned as the null space of the decomposed system.static FMatrixRMaj
RandomMatrices_FDRM.orthogonal
(int numRows, int numCols, Random rand) Creates a random orthogonal or isometric matrix, depending on the number of rows and columns.static FMatrixRMaj
CommonOps_FDRM.permuteRowInv
(int[] pinv, FMatrixRMaj input, FMatrixRMaj output) Applies the row permutation specified by the vector to the input matrix and save the results in the output matrix.static FMatrixRMaj
SpecializedOps_FDRM.pivotMatrix
(@Nullable FMatrixRMaj ret, int[] pivots, int numPivots, boolean transposed) Creates a pivot matrix that exchanges the rows in a matrix:
A' = P*Astatic FMatrixRMaj
CommonOps_CDRM.real
(CMatrixD1 input, @Nullable FMatrixRMaj output) Places the real component of the input matrix into the output matrix.static FMatrixRMaj
Returns a matrix where all the elements are selected independently from a uniform distribution between 'min' and 'max' inclusive.static FMatrixRMaj
Returns a matrix where all the elements are selected independently from a uniform distribution between 0 and 1 inclusive.static FMatrixRMaj
RandomMatrices_FDRM.rectangleGaussian
(int numRow, int numCol, float mean, float stdev, Random rand) Sets each element in the matrix to a value drawn from an Gaussian distribution with the specified mean and standard deviationstatic FMatrixRMaj[]
CommonOps_FDRM.rowsToVector
(FMatrixRMaj A, @Nullable FMatrixRMaj[] v) Converts the rows in a matrix into a set of vectors.static FMatrixRMaj
CommonOps_FDRM.rref
(FMatrixRMaj A, int numUnknowns, @Nullable FMatrixRMaj reduced) Puts the augmented system matrix into reduced row echelon form (RREF) using Gauss-Jordan elimination with row (partial) pivots.static FMatrixRMaj
Creates a random matrix which will have the provided singular values.static FMatrixRMaj[]
Creates a randomly generated set of orthonormal vectors.static FMatrixRMaj[]
SpecializedOps_FDRM.splitIntoVectors
(FMatrix1Row A, boolean column) Takes a matrix and splits it into a set of row or column vectors.static FMatrixRMaj
CommonOps_FDRM.sumCols
(FMatrixRMaj input, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_FDRM.sumRows
(FMatrixRMaj input, @Nullable FMatrixRMaj 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 FMatrixRMaj
Creates a random symmetric matrix whose values are selected from an uniform distribution from min to max, inclusive.static FMatrixRMaj
RandomMatrices_FDRM.symmetricPosDef
(int width, Random rand) Creates a random symmetric positive definite matrix.static FMatrixRMaj
RandomMatrices_FDRM.symmetricWithEigenvalues
(int num, Random rand, float... eigenvalues) Creates a new random symmetric matrix that will have the specified real eigenvalues.static FMatrixRMaj
CommonOps_FDRM.transpose
(FMatrixRMaj A, @Nullable FMatrixRMaj A_tran) Transposes matrix 'a' and stores the results in 'b':
bij = aji
where 'b' is the transpose of 'a'.static FMatrixRMaj
CommonOps_MT_FDRM.transpose
(FMatrixRMaj A, @Nullable FMatrixRMaj A_tran) Transposes matrix 'a' and stores the results in 'b':
bij = aji
where 'b' is the transpose of 'a'.static FMatrixRMaj
RandomMatrices_FDRM.triangularLower
(int dimen, int hessenberg, float min, float max, Random rand) Creates a lower triangular matrix whose values are selected from a uniform distribution.static FMatrixRMaj
RandomMatrices_FDRM.triangularUpper
(int dimen, int hessenberg, float min, float max, Random rand) Creates an upper triangular matrix whose values are selected from a uniform distribution.Modifier and TypeMethodDescriptionstatic void
RandomMatrices_FDRM.addUniform
(FMatrixRMaj A, float min, float max, Random rand) Adds random values to each element in the matrix from an uniform distribution.
aij = aij + U(min,max)static FMatrixRMaj
CommonOps_FDRM.apply
(FMatrixRMaj input, FOperatorUnary func) static FMatrixRMaj
CommonOps_FDRM.apply
(FMatrixRMaj input, FOperatorUnary func, @Nullable FMatrixRMaj output) This applies a given unary function on every value stored in the matrixstatic float[]
EigenOps_FDRM.boundLargestEigenValue
(FMatrixRMaj A, @org.jetbrains.annotations.Nullable float[] bound) Generates a bound for the largest eigen value of the provided matrix using Perron-Frobenius theorem.static void
SingularOps_FDRM.checkSvdMatrixSize
(@Nullable FMatrixRMaj U, boolean tranU, FMatrixRMaj W, @Nullable FMatrixRMaj V, boolean tranV) Checks to see if all the provided matrices are the expected size for an SVD.static FMatrixRMaj[]
CommonOps_FDRM.columnsToVector
(FMatrixRMaj A, @Nullable FMatrixRMaj[] v) Converts the columns in a matrix into a set of vectors.static float
EigenOps_FDRM.computeEigenValue
(FMatrixRMaj A, FMatrixRMaj eigenVector) Given matrix A and an eigen vector of A, compute the corresponding eigen value.static @Nullable FEigenpair
EigenOps_FDRM.computeEigenVector
(FMatrixRMaj A, float 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 FMatrixRMaj
CommonOps_FDRM.concatColumns
(FMatrixRMaj a, FMatrixRMaj b, @Nullable FMatrixRMaj output) output = [a , b]static FMatrixRMaj
CommonOps_FDRM.concatColumnsMulti
(FMatrixRMaj... m) Concatenates all the matrices together along their columns.static void
CommonOps_FDRM.concatRows
(FMatrixRMaj a, FMatrixRMaj b, FMatrixRMaj output) output = [a ; b]static FMatrixRMaj
CommonOps_FDRM.concatRowsMulti
(FMatrixRMaj... m) Concatenates all the matrices together along their columns.static float
NormOps_FDRM.conditionP
(FMatrixRMaj A, float p) The condition number of a matrix is used to measure the sensitivity of the linear system Ax=b.static float
NormOps_FDRM.conditionP2
(FMatrixRMaj A) The condition p = 2 number of a matrix is used to measure the sensitivity of the linear system Ax=b.static FMatrixRMaj
SpecializedOps_FDRM.copyChangeRow
(int[] order, FMatrixRMaj src, @Nullable FMatrixRMaj dst) Creates a copy of a matrix but swaps the rows as specified by the order array.static FMatrixRMaj
SpecializedOps_FDRM.copyTriangle
(FMatrixRMaj src, @Nullable FMatrixRMaj dst, boolean upper) Copies just the upper or lower triangular portion of a matrix.static int
MatrixFeatures_FDRM.countNonZero
(FMatrixRMaj A) Counts the number of elements in A which are not zero.static FMatrixRMaj
SpecializedOps_FDRM.createReflector
(FMatrixRMaj u, float gamma) Creates a reflector from the provided vector and gamma.
Q = I - γ u uTstatic void
SingularOps_FDRM.descendingOrder
(@Nullable FMatrixRMaj U, boolean tranU, float[] singularValues, int singularLength, @Nullable FMatrixRMaj V, boolean tranV) Similar toSingularOps_FDRM.descendingOrder(FMatrixRMaj, boolean, FMatrixRMaj, FMatrixRMaj, boolean)
but takes in an array of singular values instead.static void
SingularOps_FDRM.descendingOrder
(FMatrixRMaj U, boolean tranU, FMatrixRMaj W, FMatrixRMaj V, boolean tranV) Adjusts the matrices so that the singular values are in descending order.static float
CommonOps_FDRM.det
(FMatrixRMaj mat) Returns the determinant of the matrix.static FMatrixRMaj
CommonOps_FDRM.diag
(@Nullable FMatrixRMaj ret, int width, float... diagEl) static void
CommonOps_FDRM.divideCols
(FMatrixRMaj A, float[] values) Divides every element in column i by value[i].static void
CommonOps_FDRM.divideRows
(float[] values, FMatrixRMaj A) Divides every element in row i by value[i].static void
CommonOps_FDRM.divideRowsCols
(float[] diagA, int offsetA, FMatrixRMaj B, float[] diagC, int offsetC) Equivalent to multiplying a matrix B by the inverse of two diagonal matrices.static @Nullable FEigenpair
EigenOps_FDRM.dominantEigenpair
(FMatrixRMaj A) Computes the dominant eigen vector for a matrix.static BMatrixRMaj
CommonOps_FDRM.elementBoolean
(FMatrixRMaj input, DElementCoorBoolean func, @Nullable BMatrixRMaj output) Applies a binary operator to even element in the input matrix.static BMatrixRMaj
CommonOps_FDRM.elementLessThan
(FMatrixRMaj A, float value, @Nullable BMatrixRMaj output) Applies the > operator to each element in A.static BMatrixRMaj
CommonOps_FDRM.elementLessThan
(FMatrixRMaj A, FMatrixRMaj B, @Nullable BMatrixRMaj output) Applies the < operator to each element in A.static BMatrixRMaj
CommonOps_FDRM.elementLessThanOrEqual
(FMatrixRMaj A, float value, @Nullable BMatrixRMaj output) Applies the ≥ operator to each element in A.static BMatrixRMaj
CommonOps_FDRM.elementLessThanOrEqual
(FMatrixRMaj A, FMatrixRMaj B, @Nullable BMatrixRMaj output) Applies the A ≤ B operator to each element.static BMatrixRMaj
CommonOps_FDRM.elementMoreThan
(FMatrixRMaj A, float value, @Nullable BMatrixRMaj output) Applies the > operator to each element in A.static BMatrixRMaj
CommonOps_FDRM.elementMoreThanOrEqual
(FMatrixRMaj A, float value, @Nullable BMatrixRMaj output) Applies the ≥ operator to each element in A.static FMatrixRMaj
CommonOps_FDRM.elements
(FMatrixRMaj A, BMatrixRMaj marked, @Nullable FMatrixRMaj output) Returns a row matrix which contains all the elements in A which are flagged as true in 'marked'static FMatrixRMaj
CommonOps_FDRM.extract
(FMatrixRMaj src, int[] rows, int rowsSize, int[] cols, int colsSize, @Nullable FMatrixRMaj dst) Extracts out a matrix from source given a sub matrix with arbitrary rows and columns specified in two array listsstatic FMatrixRMaj
CommonOps_FDRM.extract
(FMatrixRMaj src, int[] indexes, int length, @Nullable FMatrixRMaj dst) Extracts the elements from the source matrix by their 1D index.static FMatrixRMaj
CommonOps_FDRM.extract
(FMatrixRMaj src, int srcY0, int srcY1, int srcX0, int srcX1) Creates a new matrix which is the specified submatrix of 'src'static FMatrixRMaj
CommonOps_FDRM.extractColumn
(FMatrixRMaj a, int column, @Nullable FMatrixRMaj out) Extracts the column from a matrix.static FMatrixRMaj
CommonOps_FDRM.extractDiag
(FMatrixRMaj src, @Nullable FMatrixRMaj dst) Extracts the diagonal elements 'src' write it to the 'dst' vector.static FMatrixRMaj
CommonOps_FDRM.extractRow
(FMatrixRMaj a, int row, @Nullable FMatrixRMaj out) Extracts the row from a matrix.static float
NormOps_FDRM.fastNormP
(FMatrixRMaj A, float p) An unsafe but faster version ofNormOps_FDRM.normP(org.ejml.data.FMatrixRMaj, float)
that calls routines which are faster but more prone to overflow/underflow problems.static float
NormOps_FDRM.fastNormP2
(FMatrixRMaj A) Computes the p=2 norm.static void
RandomMatrices_FDRM.fillUniform
(FMatrixRMaj mat, Random rand) Sets each element in the matrix to a value drawn from an uniform distribution from 0 to 1 inclusive.static FMatrixRMaj
CommonOps_CDRM.imaginary
(CMatrixD1 input, @Nullable FMatrixRMaj output) Places the imaginary component of the input matrix into the output matrix.static float
NormOps_FDRM.inducedP1
(FMatrixRMaj A) Computes the induced p = 1 matrix norm.
||A||1= max(j=1 to n; sum(i=1 to m; |aij|))static float
NormOps_FDRM.inducedP2
(FMatrixRMaj A) Computes the induced p = 2 matrix norm, which is the largest singular value.static float
NormOps_FDRM.inducedPInf
(FMatrixRMaj A) Induced matrix p = infinity norm.
||A||∞ = max(i=1 to m; sum(j=1 to n; |aij|))static void
CommonOps_FDRM.insert
(FMatrixRMaj src, FMatrixRMaj dst, int[] rows, int rowsSize, int[] cols, int colsSize) Inserts into the specified elements of dst the source matrix.static FMatrixRMaj
RandomMatrices_FDRM.insideSpan
(FMatrixRMaj[] span, float min, float max, Random rand) Creates a random vector that is inside the specified span.static boolean
CommonOps_FDRM.invert
(FMatrixRMaj mat) Performs a matrix inversion operation on the specified matrix and stores the results in the same matrix.
a = a-1static boolean
CommonOps_FDRM.invert
(FMatrixRMaj mat, FMatrixRMaj result) Performs a matrix inversion operation that does not modify the original and stores the results in another matrix.static boolean
CovarianceOps_FDRM.invert
(FMatrixRMaj cov) Performs a matrix inversion operations that takes advantage of the special properties of a covariance matrix.static boolean
CovarianceOps_FDRM.invert
(FMatrixRMaj cov, FMatrixRMaj cov_inv) Performs a matrix inversion operations that takes advantage of the special properties of a covariance matrix.static boolean
CommonOps_FDRM.invertSPD
(FMatrixRMaj mat, FMatrixRMaj result) Matrix inverse for symmetric positive definite matrices.static boolean
MatrixFeatures_FDRM.isConstantVal
(FMatrixRMaj mat, float val, float tol) Checks to see if every value in the matrix is the specified value.static boolean
MatrixFeatures_FDRM.isDiagonalNotNegative
(FMatrixRMaj a) Checks to see if diagonal element are all not negative, i.e.static boolean
MatrixFeatures_FDRM.isDiagonalPositive
(FMatrixRMaj a) Checks to see if all the diagonal elements in the matrix are positive.static boolean
MatrixFeatures_FDRM.isFullRank
(FMatrixRMaj a) static boolean
MatrixFeatures_FDRM.isIdentity
(FMatrixRMaj mat, float tol) Checks to see if the provided matrix is within tolerance to an identity matrix.static boolean
MatrixFeatures_FDRM.isInverse
(FMatrixRMaj a, FMatrixRMaj b, float tol) Checks to see if the two matrices are inverses of each other.static boolean
MatrixFeatures_FDRM.isLowerTriangle
(FMatrixRMaj A, int hessenberg, float tol) Checks to see if a matrix is lower triangular or Hessenberg.static boolean
MatrixFeatures_FDRM.isOrthogonal
(FMatrixRMaj Q, float tol) Checks to see if a matrix is orthogonal or isometric.static boolean
MatrixFeatures_FDRM.isPositiveDefinite
(FMatrixRMaj A) Checks to see if the matrix is positive definite.static boolean
MatrixFeatures_FDRM.isPositiveSemidefinite
(FMatrixRMaj A) Checks to see if the matrix is positive semidefinite:static boolean
MatrixFeatures_FDRM.isRowsLinearIndependent
(FMatrixRMaj A) Checks to see if the rows of the provided matrix are linearly independent.static boolean
MatrixFeatures_FDRM.isSkewSymmetric
(FMatrixRMaj A, float tol) Checks to see if a matrix is skew symmetric with in tolerance:
-A = AT
or
|aij + aji| ≤ tolstatic boolean
MatrixFeatures_FDRM.isSymmetric
(FMatrixRMaj m) Returns true if the matrix is perfectly symmetric.static boolean
MatrixFeatures_FDRM.isSymmetric
(FMatrixRMaj m, float tol) Returns true if the matrix is symmetric within the tolerance.static boolean
MatrixFeatures_FDRM.isUpperTriangle
(FMatrixRMaj A, int hessenberg, float tol) Checks to see if a matrix is upper triangular or Hessenberg.static int
CovarianceOps_FDRM.isValid
(FMatrixRMaj 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_FDRM.isValidFast
(FMatrixRMaj cov) This is a fairly light weight check to see of a covariance matrix is valid.static FMatrixRMaj
CommonOps_FDRM.kron
(FMatrixRMaj A, FMatrixRMaj B, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_CDRM.magnitude
(CMatrixD1 input, @Nullable FMatrixRMaj output) Computes the magnitude of the complex number in the input matrix and stores the results in the output matrix.static FMatrixRMaj
CommonOps_FDRM.maxCols
(FMatrixRMaj input, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_FDRM.maxRows
(FMatrixRMaj input, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_FDRM.minCols
(FMatrixRMaj input, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_FDRM.minRows
(FMatrixRMaj input, @Nullable FMatrixRMaj 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_FDRM.multCols
(FMatrixRMaj A, float[] values) Multiplies every element in column i by value[i].static void
SpecializedOps_FDRM.multLowerTranA
(FMatrixRMaj mat) Performs L = LT*Lstatic void
SpecializedOps_FDRM.multLowerTranB
(FMatrixRMaj mat) Performs L = L*LTstatic void
CommonOps_FDRM.multRows
(float[] values, FMatrixRMaj A) Multiplies every element in row i by value[i].void
CovarianceRandomDraw_FDRM.next
(FMatrixRMaj x) Makes a draw on the distribution.static void
NormOps_FDRM.normalizeF
(FMatrixRMaj A) Normalizes the matrix such that the Frobenius norm is equal to one.static float
NormOps_FDRM.normP
(FMatrixRMaj A, float p) Computes either the vector p-norm or the induced matrix p-norm depending on A being a vector or a matrix respectively.static float
NormOps_FDRM.normP1
(FMatrixRMaj A) Computes the p=1 norm.static float
NormOps_FDRM.normP2
(FMatrixRMaj A) Computes the p=2 norm.static float
NormOps_FDRM.normPInf
(FMatrixRMaj A) Computes the p=∞ norm.static int
MatrixFeatures_FDRM.nullity
(FMatrixRMaj A) Computes the nullity of a matrix using the default tolerance.static int
MatrixFeatures_FDRM.nullity
(FMatrixRMaj A, float threshold) Computes the nullity of a matrix using the specified tolerance.static int
SingularOps_FDRM.nullity
(FMatrixRMaj A, float threshold) Returns the matrix's nullitystatic FMatrixRMaj
SingularOps_FDRM.nullSpace
(SingularValueDecomposition_F32<FMatrixRMaj> svd, @Nullable FMatrixRMaj nullSpace, float tol) Returns the null-space from the singular value decomposition.static FMatrixRMaj
SingularOps_FDRM.nullspaceQR
(FMatrixRMaj A, int totalSingular) Computes the null space using QR decomposition.static FMatrixRMaj
SingularOps_FDRM.nullspaceQRP
(FMatrixRMaj A, int totalSingular) Computes the null space using QRP decomposition.static FMatrixRMaj
SingularOps_FDRM.nullspaceSVD
(FMatrixRMaj A, int totalSingular) Computes the null space using SVD.static FMatrixRMaj
SingularOps_FDRM.nullVector
(SingularValueDecomposition_F32<FMatrixRMaj> svd, boolean isRight, @Nullable FMatrixRMaj nullVector) The vector associated will the smallest singular value is returned as the null space of the decomposed system.static FMatrixRMaj
CommonOps_FDRM.permuteRowInv
(int[] pinv, FMatrixRMaj input, FMatrixRMaj output) Applies the row permutation specified by the vector to the input matrix and save the results in the output matrix.static void
CommonOps_FDRM.pinv
(FMatrixRMaj A, FMatrixRMaj invA) Computes the Moore-Penrose pseudo-inverse:
pinv(A) = (ATA)-1 AT
or
pinv(A) = AT(AAT)-1static FMatrixRMaj
SpecializedOps_FDRM.pivotMatrix
(@Nullable FMatrixRMaj ret, int[] pivots, int numPivots, boolean transposed) Creates a pivot matrix that exchanges the rows in a matrix:
A' = P*Astatic void
CovarianceOps_FDRM.randomVector
(FMatrixRMaj cov, FMatrixRMaj vector, Random rand) Sets vector to a random value based upon a zero-mean multivariate Gaussian distribution with covariance 'cov'.static int
MatrixFeatures_FDRM.rank
(FMatrixRMaj A) Computes the rank of a matrix using a default tolerance.static int
MatrixFeatures_FDRM.rank
(FMatrixRMaj A, float threshold) Computes the rank of a matrix using the specified tolerance.static int
SingularOps_FDRM.rank
(FMatrixRMaj A) Returns the matrix's rank.static int
SingularOps_FDRM.rank
(FMatrixRMaj A, float threshold) Returns the matrix's rankstatic FMatrixRMaj
CommonOps_CDRM.real
(CMatrixD1 input, @Nullable FMatrixRMaj output) Places the real component of the input matrix into the output matrix.static void
CommonOps_FDRM.removeColumns
(FMatrixRMaj A, int col0, int col1) Removes columns from the matrix.static FMatrixRMaj[]
CommonOps_FDRM.rowsToVector
(FMatrixRMaj A, @Nullable FMatrixRMaj[] v) Converts the rows in a matrix into a set of vectors.static FMatrixRMaj
CommonOps_FDRM.rref
(FMatrixRMaj A, int numUnknowns, @Nullable FMatrixRMaj reduced) Puts the augmented system matrix into reduced row echelon form (RREF) using Gauss-Jordan elimination with row (partial) pivots.static void
CommonOps_FDRM.scaleCol
(float alpha, FMatrixRMaj A, int col) In-place scaling of a column in Astatic void
CommonOps_FDRM.scaleRow
(float alpha, FMatrixRMaj A, int row) In-place scaling of a row in Astatic float[]
SingularOps_FDRM.singularValues
(FMatrixRMaj A) Returns an array of all the singular values in A sorted in ascending orderstatic boolean
CommonOps_FDRM.solve
(FMatrixRMaj a, FMatrixRMaj b, FMatrixRMaj x) Solves for x in the following equation:
A*x = bstatic boolean
CommonOps_FDRM.solveSPD
(FMatrixRMaj A, FMatrixRMaj b, FMatrixRMaj x) Linear solver for systems which are symmetric positive definite.
A*x = bstatic FMatrixRMaj
CommonOps_FDRM.sumCols
(FMatrixRMaj input, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_FDRM.sumRows
(FMatrixRMaj input, @Nullable FMatrixRMaj 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_FDRM.svd
(FMatrixRMaj A, @Nullable FMatrixRMaj U, FGrowArray sv, @Nullable FMatrixRMaj Vt) Computes the SVD and sorts singular values in descending order.static void
RandomMatrices_FDRM.symmetric
(FMatrixRMaj A, float min, float 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_FDRM.symmLowerToFull
(FMatrixRMaj A) Given a symmetric matrix which is represented by a lower triangular matrix convert it back into a full symmetric matrix.static void
CommonOps_FDRM.symmUpperToFull
(FMatrixRMaj A) Given a symmetric matrix which is represented by a lower triangular matrix convert it back into a full symmetric matrix.static void
CommonOps_FDRM.transpose
(FMatrixRMaj mat) Performs an "in-place" transpose.static FMatrixRMaj
CommonOps_FDRM.transpose
(FMatrixRMaj A, @Nullable FMatrixRMaj A_tran) Transposes matrix 'a' and stores the results in 'b':
bij = aji
where 'b' is the transpose of 'a'.static void
CommonOps_MT_FDRM.transpose
(FMatrixRMaj mat) Performs an "in-place" transpose.static FMatrixRMaj
CommonOps_MT_FDRM.transpose
(FMatrixRMaj A, @Nullable FMatrixRMaj A_tran) Transposes matrix 'a' and stores the results in 'b':
bij = aji
where 'b' is the transpose of 'a'.Modifier and TypeMethodDescriptionstatic FMatrixRMaj
EigenOps_FDRM.createMatrixV
(EigenDecomposition_F32<FMatrixRMaj> eig) Puts all the real eigenvectors into the columns of a matrix.static FMatrixRMaj
SingularOps_FDRM.nullSpace
(SingularValueDecomposition_F32<FMatrixRMaj> svd, @Nullable FMatrixRMaj nullSpace, float tol) Returns the null-space from the singular value decomposition.static FMatrixRMaj
SingularOps_FDRM.nullVector
(SingularValueDecomposition_F32<FMatrixRMaj> svd, boolean isRight, @Nullable FMatrixRMaj nullVector) The vector associated will the smallest singular value is returned as the null space of the decomposed system.ModifierConstructorDescriptionCovarianceRandomDraw_FDRM
(Random rand, FMatrixRMaj cov) Creates a random distribution with the specified mean and covariance. -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition
Modifier and TypeMethodDescriptionstatic FMatrixRMaj
UtilDecompositons_FDRM.checkZerosLT
(@Nullable FMatrixRMaj A, int numRows, int numCols) Creates a zeros matrix only if A does not already exist.static FMatrixRMaj
UtilDecompositons_FDRM.checkZerosUT
(@Nullable FMatrixRMaj A, int numRows, int numCols) Creates a zeros matrix only if A does not already exist.static FMatrixRMaj
UtilDecompositons_FDRM.ensureIdentity
(@Nullable FMatrixRMaj A, int numRows, int numCols) static FMatrixRMaj
UtilDecompositons_FDRM.ensureZeros
(@Nullable FMatrixRMaj A, int numRows, int numCols) Modifier and TypeMethodDescriptionstatic FMatrixRMaj
UtilDecompositons_FDRM.checkZerosLT
(@Nullable FMatrixRMaj A, int numRows, int numCols) Creates a zeros matrix only if A does not already exist.static FMatrixRMaj
UtilDecompositons_FDRM.checkZerosUT
(@Nullable FMatrixRMaj A, int numRows, int numCols) Creates a zeros matrix only if A does not already exist.boolean
BaseDecomposition_FDRB_to_FDRM.decompose
(FMatrixRMaj A) static FMatrixRMaj
UtilDecompositons_FDRM.ensureIdentity
(@Nullable FMatrixRMaj A, int numRows, int numCols) static FMatrixRMaj
UtilDecompositons_FDRM.ensureZeros
(@Nullable FMatrixRMaj A, int numRows, int numCols) -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition.bidiagonal
Modifier and TypeMethodDescriptionBidiagonalDecompositionRow_FDRM.getB
(@Nullable FMatrixRMaj B, boolean compact) Returns the bidiagonal matrix.BidiagonalDecompositionTall_FDRM.getB
(@Nullable FMatrixRMaj B, boolean compact) BidiagonalDecompositionTall_MT_FDRM.getB
(@Nullable FMatrixRMaj B, boolean compact) BidiagonalDecompositionRow_FDRM.getU
(@Nullable FMatrixRMaj U, boolean transpose, boolean compact) Returns the orthogonal U matrix.BidiagonalDecompositionTall_FDRM.getU
(@Nullable FMatrixRMaj U, boolean transpose, boolean compact) BidiagonalDecompositionTall_MT_FDRM.getU
(@Nullable FMatrixRMaj U, boolean transpose, boolean compact) BidiagonalDecompositionRow_FDRM.getUBV()
The raw UBV matrix that is stored internally.BidiagonalDecompositionRow_FDRM.getV
(@Nullable FMatrixRMaj V, boolean transpose, boolean compact) Returns the orthogonal V matrix.BidiagonalDecompositionTall_FDRM.getV
(@Nullable FMatrixRMaj V, boolean transpose, boolean compact) BidiagonalDecompositionTall_MT_FDRM.getV
(@Nullable FMatrixRMaj V, boolean transpose, boolean compact) static FMatrixRMaj
BidiagonalDecompositionRow_FDRM.handleB
(@Nullable FMatrixRMaj B, boolean compact, int m, int n, int min) static FMatrixRMaj
BidiagonalDecompositionRow_FDRM.handleU
(@Nullable FMatrixRMaj U, boolean transpose, boolean compact, int m, int n, int min) static FMatrixRMaj
BidiagonalDecompositionRow_FDRM.handleV
(@Nullable FMatrixRMaj V, boolean transpose, boolean compact, int m, int n, int min) Modifier and TypeMethodDescriptionboolean
BidiagonalDecompositionRow_FDRM.decompose
(FMatrixRMaj A) Computes the decomposition of the provided matrix.boolean
BidiagonalDecompositionTall_FDRM.decompose
(FMatrixRMaj orig) boolean
BidiagonalDecompositionTall_MT_FDRM.decompose
(FMatrixRMaj orig) BidiagonalDecompositionRow_FDRM.getB
(@Nullable FMatrixRMaj B, boolean compact) Returns the bidiagonal matrix.BidiagonalDecompositionTall_FDRM.getB
(@Nullable FMatrixRMaj B, boolean compact) BidiagonalDecompositionTall_MT_FDRM.getB
(@Nullable FMatrixRMaj B, boolean compact) BidiagonalDecompositionRow_FDRM.getU
(@Nullable FMatrixRMaj U, boolean transpose, boolean compact) Returns the orthogonal U matrix.BidiagonalDecompositionTall_FDRM.getU
(@Nullable FMatrixRMaj U, boolean transpose, boolean compact) BidiagonalDecompositionTall_MT_FDRM.getU
(@Nullable FMatrixRMaj U, boolean transpose, boolean compact) BidiagonalDecompositionRow_FDRM.getV
(@Nullable FMatrixRMaj V, boolean transpose, boolean compact) Returns the orthogonal V matrix.BidiagonalDecompositionTall_FDRM.getV
(@Nullable FMatrixRMaj V, boolean transpose, boolean compact) BidiagonalDecompositionTall_MT_FDRM.getV
(@Nullable FMatrixRMaj V, boolean transpose, boolean compact) static FMatrixRMaj
BidiagonalDecompositionRow_FDRM.handleB
(@Nullable FMatrixRMaj B, boolean compact, int m, int n, int min) static FMatrixRMaj
BidiagonalDecompositionRow_FDRM.handleU
(@Nullable FMatrixRMaj U, boolean transpose, boolean compact, int m, int n, int min) static FMatrixRMaj
BidiagonalDecompositionRow_FDRM.handleV
(@Nullable FMatrixRMaj V, boolean transpose, boolean compact, int m, int n, int min) protected void
BidiagonalDecompositionRow_FDRM.init
(FMatrixRMaj A) Sets up internal data structures and creates a copy of the input matrix.protected void
BidiagonalDecompositionRow_FDRM.rank1UpdateMultL
(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected void
BidiagonalDecompositionRow_MT_FDRM.rank1UpdateMultL
(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected void
BidiagonalDecompositionRow_FDRM.rank1UpdateMultR
(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected void
BidiagonalDecompositionRow_MT_FDRM.rank1UpdateMultR
(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition.chol
Modifier and TypeMethodDescriptionCholeskyDecompositionLDL_FDRM.getD
(@Nullable FMatrixRMaj D) CholeskyDecompositionLDL_FDRM.getL()
Returns L matrix from the decomposition.
L*D*LT=ACholeskyDecompositionLDL_FDRM.getL
(@Nullable FMatrixRMaj L) CholeskyDecomposition_FDRB_to_FDRM.getT
(@Nullable FMatrixRMaj T) CholeskyDecompositionCommon_FDRM.getT()
Returns the triangular matrix from the decomposition.CholeskyDecompositionCommon_FDRM.getT
(@Nullable FMatrixRMaj T) Modifier and TypeMethodDescriptionboolean
CholeskyDecompositionCommon_FDRM.decompose
(FMatrixRMaj mat) Performs Choleksy decomposition on the provided matrix.boolean
CholeskyDecompositionLDL_FDRM.decompose
(FMatrixRMaj mat) Performs Choleksy decomposition on the provided matrix.CholeskyDecompositionLDL_FDRM.getD
(@Nullable FMatrixRMaj D) CholeskyDecompositionLDL_FDRM.getL
(@Nullable FMatrixRMaj L) CholeskyDecomposition_FDRB_to_FDRM.getT
(@Nullable FMatrixRMaj T) CholeskyDecompositionCommon_FDRM.getT
(@Nullable FMatrixRMaj T) void
CholeskyDecompositionBlock_FDRM.solveL_special
(float[] L, FMatrixRMaj b_src, int indexSrc, int indexDst, FMatrixRMaj B) This is a variation on theTriangularSolver_FDRM.solveL(float[], float[], int)
function.void
CholeskyDecompositionBlock_MT_FDRM.solveL_special
(float[] L, FMatrixRMaj b_src, int indexSrc, int indexDst, FMatrixRMaj B) void
CholeskyDecompositionBlock_FDRM.symmRankTranA_sub
(FMatrixRMaj a, FMatrixRMaj c, int startIndexC) Performs this operation:
c = c - aTa
where c is a submatrix.void
CholeskyDecompositionBlock_MT_FDRM.symmRankTranA_sub
(FMatrixRMaj a, FMatrixRMaj c, int startIndexC) -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition.eig
Modifier and TypeMethodDescriptionEigenPowerMethod_FDRM.getEigenVector()
SwitchingEigenDecomposition_FDRM.getEigenVector
(int index) SymmetricQRAlgorithmDecomposition_FDRM.getEigenVector
(int index) WatchedDoubleStepQRDecomposition_FDRM.getEigenVector
(int index) Modifier and TypeMethodDescriptionboolean
EigenPowerMethod_FDRM.computeDirect
(FMatrixRMaj A) This method computes the eigen vector with the largest eigen value by using the direct power method.boolean
EigenPowerMethod_FDRM.computeShiftDirect
(FMatrixRMaj A, float alpha) Computes the most dominant eigen vector of A using a shifted matrix.boolean
EigenPowerMethod_FDRM.computeShiftInvert
(FMatrixRMaj A, float alpha) Computes the most dominant eigen vector of A using an inverted shifted matrix.boolean
SwitchingEigenDecomposition_FDRM.decompose
(FMatrixRMaj orig) boolean
SymmetricQRAlgorithmDecomposition_FDRM.decompose
(FMatrixRMaj orig) Decomposes the matrix using the QR algorithm.boolean
WatchedDoubleStepQRDecomposition_FDRM.decompose
(FMatrixRMaj A) boolean
EigenvalueExtractor_FDRM.process
(FMatrixRMaj A) void
EigenPowerMethod_FDRM.setSeed
(FMatrixRMaj seed) Sets the value of the vector to use in the start of the iterations.ModifierConstructorDescriptionSwitchingEigenDecomposition_FDRM
(EigenDecomposition_F32<FMatrixRMaj> symmetricAlg, EigenDecomposition_F32<FMatrixRMaj> generalAlg, float tol) SymmetricQRAlgorithmDecomposition_FDRM
(TridiagonalSimilarDecomposition_F32<FMatrixRMaj> decomp, boolean computeVectors) -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition.eig.symm
Modifier and TypeMethodDescriptionvoid
SymmetricQrAlgorithm_FDRM.setQ
(@Nullable FMatrixRMaj q) void
SymmetricQREigenHelper_FDRM.setQ
(FMatrixRMaj q) -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition.eig.watched
Modifier and TypeFieldDescriptionprotected FMatrixRMaj
WatchedDoubleStepQREigen_FDRM._temp
@Nullable FMatrixRMaj
WatchedDoubleStepQREigen_FDRM.Q
protected FMatrixRMaj
WatchedDoubleStepQREigen_FDRM.u
Modifier and TypeMethodDescriptionWatchedDoubleStepQREigenvector_FDRM.getEigenvectors()
WatchedDoubleStepQREigenvector_FDRM.getQ()
Modifier and TypeMethodDescriptionboolean
WatchedDoubleStepQREigenvector_FDRM.extractVectors
(FMatrixRMaj Q_h) boolean
WatchedDoubleStepQREigenvalue_FDRM.process
(FMatrixRMaj origA) boolean
WatchedDoubleStepQREigenvector_FDRM.process
(WatchedDoubleStepQREigen_FDRM implicit, FMatrixRMaj A, FMatrixRMaj Q_h) protected void
WatchedDoubleStepQREigen_FDRM.rank1UpdateMultL
(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected void
WatchedDoubleStepQREigen_MT_FDRM.rank1UpdateMultL
(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected void
WatchedDoubleStepQREigen_FDRM.rank1UpdateMultR
(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected void
WatchedDoubleStepQREigen_MT_FDRM.rank1UpdateMultR
(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) void
WatchedDoubleStepQREigen_FDRM.setQ
(@Nullable FMatrixRMaj Q) void
WatchedDoubleStepQREigen_FDRM.setup
(FMatrixRMaj A) void
WatchedDoubleStepQREigenvalue_FDRM.setup
(FMatrixRMaj A) -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition.hessenberg
Modifier and TypeFieldDescriptionprotected FMatrixRMaj
TridiagonalDecompositionHouseholder_FDRM.QT
Only the upper right triangle is used.Modifier and TypeMethodDescriptionHessenbergSimilarDecomposition_FDRM.getH
(@Nullable FMatrixRMaj H) An upper Hessenberg matrix from the decomposition.HessenbergSimilarDecomposition_FDRM.getQ
(@Nullable FMatrixRMaj Q) An orthogonal matrix that has the following property: H = QTAQTridiagonalDecomposition_FDRB_to_FDRM.getQ
(@Nullable FMatrixRMaj Q, boolean transposed) TridiagonalDecompositionHouseholder_FDRM.getQ
(@Nullable FMatrixRMaj Q, boolean transposed) An orthogonal matrix that has the following property: T = QTAQTridiagonalDecompositionHouseholderOrig_FDRM.getQ
(@Nullable FMatrixRMaj Q) An orthogonal matrix that has the following property: T = QTAQHessenbergSimilarDecomposition_FDRM.getQH()
The raw QH matrix that is stored internally.TridiagonalDecompositionHouseholder_FDRM.getQT()
Returns the internal matrix where the decomposed results are stored.TridiagonalDecompositionHouseholderOrig_FDRM.getQT()
Returns the interal matrix where the decomposed results are stored.TridiagonalDecomposition_FDRB_to_FDRM.getT
(@Nullable FMatrixRMaj T) TridiagonalDecompositionHouseholder_FDRM.getT
(@Nullable FMatrixRMaj T) Extracts the tridiagonal matrix found in the decomposition.TridiagonalDecompositionHouseholderOrig_FDRM.getT
(@Nullable FMatrixRMaj T) Extracts the tridiagonal matrix found in the decomposition.Modifier and TypeMethodDescriptionboolean
HessenbergSimilarDecomposition_FDRM.decompose
(FMatrixRMaj A) Computes the decomposition of the provided matrix.boolean
TridiagonalDecompositionHouseholder_FDRM.decompose
(FMatrixRMaj A) Decomposes the provided symmetric matrix.void
TridiagonalDecompositionHouseholderOrig_FDRM.decompose
(FMatrixRMaj A) Decomposes the provided symmetric matrix.HessenbergSimilarDecomposition_FDRM.getH
(@Nullable FMatrixRMaj H) An upper Hessenberg matrix from the decomposition.HessenbergSimilarDecomposition_FDRM.getQ
(@Nullable FMatrixRMaj Q) An orthogonal matrix that has the following property: H = QTAQTridiagonalDecomposition_FDRB_to_FDRM.getQ
(@Nullable FMatrixRMaj Q, boolean transposed) TridiagonalDecompositionHouseholder_FDRM.getQ
(@Nullable FMatrixRMaj Q, boolean transposed) An orthogonal matrix that has the following property: T = QTAQTridiagonalDecompositionHouseholderOrig_FDRM.getQ
(@Nullable FMatrixRMaj Q) An orthogonal matrix that has the following property: T = QTAQTridiagonalDecomposition_FDRB_to_FDRM.getT
(@Nullable FMatrixRMaj T) TridiagonalDecompositionHouseholder_FDRM.getT
(@Nullable FMatrixRMaj T) Extracts the tridiagonal matrix found in the decomposition.TridiagonalDecompositionHouseholderOrig_FDRM.getT
(@Nullable FMatrixRMaj T) Extracts the tridiagonal matrix found in the decomposition.void
TridiagonalDecompositionHouseholder_FDRM.init
(FMatrixRMaj A) If needed declares and sets up internal data structures.void
TridiagonalDecompositionHouseholderOrig_FDRM.init
(FMatrixRMaj A) If needed declares and sets up internal data structures.protected void
HessenbergSimilarDecomposition_FDRM.rank1UpdateMultL
(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected void
HessenbergSimilarDecomposition_MT_FDRM.rank1UpdateMultL
(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected void
TridiagonalDecompositionHouseholder_FDRM.rank1UpdateMultL
(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected void
TridiagonalDecompositionHouseholder_MT_FDRM.rank1UpdateMultL
(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected void
HessenbergSimilarDecomposition_FDRM.rank1UpdateMultR
(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected void
HessenbergSimilarDecomposition_MT_FDRM.rank1UpdateMultR
(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected void
TridiagonalDecompositionHouseholder_FDRM.rank1UpdateMultR
(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected void
TridiagonalDecompositionHouseholder_MT_FDRM.rank1UpdateMultR
(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition.lu
Modifier and TypeMethodDescriptionLUDecompositionBase_FDRM.getLower
(@Nullable FMatrixRMaj lower) Writes the lower triangular matrix into the specified matrix.LUDecompositionBase_FDRM.getLU()
LUDecompositionBase_FDRM.getRowPivot
(@Nullable FMatrixRMaj pivot) LUDecompositionBase_FDRM.getUpper
(@Nullable FMatrixRMaj upper) Writes the upper triangular matrix into the specified matrix.Modifier and TypeMethodDescriptionboolean
LUDecompositionAlt_FDRM.decompose
(FMatrixRMaj a) This is a modified version of what was found in the JAMA package.protected void
LUDecompositionBase_FDRM.decomposeCommonInit
(FMatrixRMaj a) LUDecompositionBase_FDRM.getLower
(@Nullable FMatrixRMaj lower) Writes the lower triangular matrix into the specified matrix.LUDecompositionBase_FDRM.getRowPivot
(@Nullable FMatrixRMaj pivot) LUDecompositionBase_FDRM.getUpper
(@Nullable FMatrixRMaj upper) Writes the upper triangular matrix into the specified matrix. -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition.qr
Modifier and TypeFieldDescriptionprotected FMatrixRMaj
QRDecompositionHouseholder_FDRM.QR
Where the Q and R matrices are stored.protected FMatrixRMaj
QRDecompositionHouseholderTran_FDRM.QR
Where the Q and R matrices are stored.Modifier and TypeMethodDescriptionQRColPivDecompositionHouseholderColumn_FDRM.getColPivotMatrix
(@Nullable FMatrixRMaj P) QRColPivDecompositionHouseholderColumn_FDRM.getQ
(@Nullable FMatrixRMaj Q, boolean compact) Computes the Q matrix from the information stored in the QR matrix.QRDecomposition_FDRB_to_FDRM.getQ
(@Nullable FMatrixRMaj Q, boolean compact) QRDecompositionHouseholder_FDRM.getQ
(@Nullable FMatrixRMaj Q, boolean compact) Computes the Q matrix from the imformation stored in the QR matrix.QRDecompositionHouseholderColumn_FDRM.getQ
(@Nullable FMatrixRMaj Q, boolean compact) Computes the Q matrix from the imformation stored in the QR matrix.QRDecompositionHouseholderColumn_MT_FDRM.getQ
(@Nullable FMatrixRMaj Q, boolean compact) QRDecompositionHouseholderTran_FDRM.getQ
(@Nullable FMatrixRMaj Q, boolean compact) Computes the Q matrix from the information stored in the QR matrix.QRDecompositionHouseholder_FDRM.getQR()
Returns a single matrix which contains the combined values of Q and R.QRDecompositionHouseholderTran_FDRM.getQR()
Inner matrix that stores the decompositionQRDecomposition_FDRB_to_FDRM.getR
(@Nullable FMatrixRMaj R, boolean compact) QRDecompositionHouseholder_FDRM.getR
(@Nullable FMatrixRMaj R, boolean compact) Returns an upper triangular matrix which is the R in the QR decomposition.QRDecompositionHouseholderColumn_FDRM.getR
(@Nullable FMatrixRMaj R, boolean compact) Returns an upper triangular matrix which is the R in the QR decomposition.QRDecompositionHouseholderTran_FDRM.getR
(@Nullable FMatrixRMaj R, boolean compact) Returns an upper triangular matrix which is the R in the QR decomposition.QrUpdate_FDRM.getU_tran()
Modifier and TypeMethodDescriptionvoid
QrUpdate_FDRM.addRow
(FMatrixRMaj Q, FMatrixRMaj R, float[] 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_FDRM.applyQ
(FMatrixRMaj A) A = Q*Avoid
QRDecompositionHouseholderTran_FDRM.applyTranQ
(FMatrixRMaj A) A = QT*Aprotected void
QRDecompositionHouseholder_FDRM.commonSetup
(FMatrixRMaj A) This function performs sanity check on the input for decompose and sets up the QR matrix.protected void
QRDecompositionHouseholderColumn_FDRM.convertToColumnMajor
(FMatrixRMaj A) Converts the standard row-major matrix into a column-major vector that is advantageous for this problem.boolean
QRColPivDecompositionHouseholderColumn_FDRM.decompose
(FMatrixRMaj A) To decompose the matrix 'A' it must have full rank.boolean
QRDecompositionHouseholder_FDRM.decompose
(FMatrixRMaj A) In order to decompose the matrix 'A' it must have full rank.boolean
QRDecompositionHouseholderColumn_FDRM.decompose
(FMatrixRMaj A) To decompose the matrix 'A' it must have full rank.boolean
QRDecompositionHouseholderTran_FDRM.decompose
(FMatrixRMaj A) To decompose the matrix 'A' it must have full rank.void
QrUpdate_FDRM.deleteRow
(FMatrixRMaj Q, FMatrixRMaj 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_FDRM.getColPivotMatrix
(@Nullable FMatrixRMaj P) QRColPivDecompositionHouseholderColumn_FDRM.getQ
(@Nullable FMatrixRMaj Q, boolean compact) Computes the Q matrix from the information stored in the QR matrix.QRDecomposition_FDRB_to_FDRM.getQ
(@Nullable FMatrixRMaj Q, boolean compact) QRDecompositionHouseholder_FDRM.getQ
(@Nullable FMatrixRMaj Q, boolean compact) Computes the Q matrix from the imformation stored in the QR matrix.QRDecompositionHouseholderColumn_FDRM.getQ
(@Nullable FMatrixRMaj Q, boolean compact) Computes the Q matrix from the imformation stored in the QR matrix.QRDecompositionHouseholderColumn_MT_FDRM.getQ
(@Nullable FMatrixRMaj Q, boolean compact) QRDecompositionHouseholderTran_FDRM.getQ
(@Nullable FMatrixRMaj Q, boolean compact) Computes the Q matrix from the information stored in the QR matrix.QRDecomposition_FDRB_to_FDRM.getR
(@Nullable FMatrixRMaj R, boolean compact) QRDecompositionHouseholder_FDRM.getR
(@Nullable FMatrixRMaj R, boolean compact) Returns an upper triangular matrix which is the R in the QR decomposition.QRDecompositionHouseholderColumn_FDRM.getR
(@Nullable FMatrixRMaj R, boolean compact) Returns an upper triangular matrix which is the R in the QR decomposition.QRDecompositionHouseholderTran_FDRM.getR
(@Nullable FMatrixRMaj R, boolean compact) Returns an upper triangular matrix which is the R in the QR decomposition.static void
QrHelperFunctions_FDRM.rank1UpdateMultL
(FMatrixRMaj A, float[] u, float 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_FDRM.rank1UpdateMultL
(FMatrixRMaj A, float[] u, float 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_FDRM.rank1UpdateMultR
(FMatrixRMaj A, float[] u, float gamma, int colA0, int w0, int w1, float[] _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_FDRM.rank1UpdateMultR
(FMatrixRMaj A, float[] u, int offsetU, float gamma, int colA0, int w0, int w1, float[] _temp) static void
QrHelperFunctions_MT_FDRM.rank1UpdateMultR
(FMatrixRMaj A, float[] u, float gamma, int colA0, int w0, int w1, float[] _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_FDRM.rank1UpdateMultR
(FMatrixRMaj A, float[] u, int offsetU, float gamma, int colA0, int w0, int w1, float[] _temp) static void
QrHelperFunctions_FDRM.rank1UpdateMultR_u0
(FMatrixRMaj A, float[] u, float u_0, float gamma, int colA0, int w0, int w1, float[] _temp) static void
QrHelperFunctions_MT_FDRM.rank1UpdateMultR_u0
(FMatrixRMaj A, float[] u, float u_0, float gamma, int colA0, int w0, int w1, float[] _temp) -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition.svd
Modifier and TypeFieldDescriptionprotected BidiagonalDecomposition_F32<FMatrixRMaj>
SvdImplicitQrDecompose_FDRM.bidiag
Modifier and TypeMethodDescriptionSafeSvd_FDRM.getU
(@Nullable FMatrixRMaj U, boolean transposed) SvdImplicitQrDecompose_FDRM.getU
(@Nullable FMatrixRMaj U, boolean transpose) SafeSvd_FDRM.getV
(@Nullable FMatrixRMaj V, boolean transposed) SvdImplicitQrDecompose_FDRM.getV
(@Nullable FMatrixRMaj V, boolean transpose) SafeSvd_FDRM.getW
(@Nullable FMatrixRMaj W) SvdImplicitQrDecompose_FDRM.getW
(@Nullable FMatrixRMaj W) Modifier and TypeMethodDescriptionboolean
SafeSvd_FDRM.decompose
(FMatrixRMaj orig) boolean
SvdImplicitQrDecompose_FDRM.decompose
(FMatrixRMaj orig) SafeSvd_FDRM.getU
(@Nullable FMatrixRMaj U, boolean transposed) SvdImplicitQrDecompose_FDRM.getU
(@Nullable FMatrixRMaj U, boolean transpose) SafeSvd_FDRM.getV
(@Nullable FMatrixRMaj V, boolean transposed) SvdImplicitQrDecompose_FDRM.getV
(@Nullable FMatrixRMaj V, boolean transpose) SafeSvd_FDRM.getW
(@Nullable FMatrixRMaj W) SvdImplicitQrDecompose_FDRM.getW
(@Nullable FMatrixRMaj W) protected void
SvdImplicitQrDecompose_FDRM.transpose
(@NotNull FMatrixRMaj V, FMatrixRMaj Vt) protected void
SvdImplicitQrDecompose_MT_FDRM.transpose
(@NotNull FMatrixRMaj V, FMatrixRMaj Vt) -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition.svd.implicitqr
Modifier and TypeFieldDescriptionprotected @Nullable FMatrixRMaj
SvdImplicitQrAlgorithm_FDRM.Ut
protected @Nullable FMatrixRMaj
SvdImplicitQrAlgorithm_FDRM.Vt
Modifier and TypeMethodDescription@Nullable FMatrixRMaj
SvdImplicitQrAlgorithm_FDRM.getUt()
@Nullable FMatrixRMaj
SvdImplicitQrAlgorithm_FDRM.getVt()
Modifier and TypeMethodDescriptionvoid
SvdImplicitQrAlgorithm_FDRM.setUt
(@Nullable FMatrixRMaj ut) void
SvdImplicitQrAlgorithm_FDRM.setVt
(@Nullable FMatrixRMaj vt) protected void
SvdImplicitQrAlgorithm_FDRM.updateRotator
(FMatrixRMaj Q, int m, int n, float c, float s) Multiplied a transpose orthogonal matrix Q by the specified rotator. -
Uses of FMatrixRMaj in org.ejml.dense.row.factory
Modifier and TypeMethodDescriptionstatic CholeskyDecomposition_F32<FMatrixRMaj>
DecompositionFactory_FDRM.chol
(boolean lower) Returns aCholeskyDecomposition_F32
that isn't specialized for any specific matrix size.static CholeskyDecomposition_F32<FMatrixRMaj>
DecompositionFactory_FDRM.chol
(int matrixSize, boolean lower) Returns aCholeskyDecomposition_F32
that has been optimized for the specified matrix size.static CholeskyDecomposition_F32<FMatrixRMaj>
DecompositionFactory_MT_FDRM.chol
(boolean lower) Returns aCholeskyDecomposition_F32
that isn't specialized for any specific matrix size.static CholeskyDecomposition_F32<FMatrixRMaj>
DecompositionFactory_MT_FDRM.chol
(int matrixSize, boolean lower) Returns aCholeskyDecomposition_F32
that has been optimized for the specified matrix size.static LinearSolverDense<FMatrixRMaj>
LinearSolverFactory_FDRM.chol
(int numRows) Creates a linear solver using Cholesky decompositionstatic LinearSolverDense<FMatrixRMaj>
LinearSolverFactory_MT_FDRM.chol
(int numRows) Creates a linear solver using Cholesky decompositionDecompositionFactory_FDRM.cholLDL()
DecompositionFactory_FDRM.cholLDL
(int matrixSize) Returns aCholeskyDecompositionLDL_FDRM
that has been optimized for the specified matrix size.static EigenDecomposition_F32<FMatrixRMaj>
DecompositionFactory_FDRM.eig
(boolean needVectors) static EigenDecomposition_F32<FMatrixRMaj>
DecompositionFactory_FDRM.eig
(boolean computeVectors, boolean isSymmetric) static EigenDecomposition_F32<FMatrixRMaj>
DecompositionFactory_FDRM.eig
(int matrixSize, boolean needVectors) Returns anEigenDecomposition
that has been optimized for the specified matrix size.static EigenDecomposition_F32<FMatrixRMaj>
DecompositionFactory_FDRM.eig
(int matrixSize, boolean computeVectors, boolean isSymmetric) Returns anEigenDecomposition
which is specialized for symmetric matrices or the general problem.static EigenDecomposition_F32<FMatrixRMaj>
DecompositionFactory_MT_FDRM.eig
(boolean needVectors) static EigenDecomposition_F32<FMatrixRMaj>
DecompositionFactory_MT_FDRM.eig
(boolean computeVectors, boolean isSymmetric) static EigenDecomposition_F32<FMatrixRMaj>
DecompositionFactory_MT_FDRM.eig
(int matrixSize, boolean needVectors) Returns anEigenDecomposition
that has been optimized for the specified matrix size.static EigenDecomposition_F32<FMatrixRMaj>
DecompositionFactory_MT_FDRM.eig
(int matrixSize, boolean computeVectors, boolean isSymmetric) Returns anEigenDecomposition
which is specialized for symmetric matrices or the general problem.static LinearSolverDense<FMatrixRMaj>
LinearSolverFactory_FDRM.general
(int numRows, int numCols) Creates a general purpose solver.static LinearSolverDense<FMatrixRMaj>
LinearSolverFactory_FDRM.leastSquares
(int numRows, int numCols) Creates a good general purpose solver for over determined systems and returns the optimal least-squares solution.static LinearSolverDense<FMatrixRMaj>
LinearSolverFactory_MT_FDRM.leastSquares
(int numRows, int numCols) Creates a good general purpose solver for over determined systems and returns the optimal least-squares solution.static LinearSolverDense<FMatrixRMaj>
LinearSolverFactory_FDRM.leastSquaresQrPivot
(boolean computeNorm2, boolean computeQ) Linear solver which uses QR pivot decomposition.static LinearSolverDense<FMatrixRMaj>
LinearSolverFactory_FDRM.linear
(int matrixSize) Creates a solver for linear systems.static LUDecomposition_F32<FMatrixRMaj>
DecompositionFactory_FDRM.lu()
static LUDecomposition_F32<FMatrixRMaj>
DecompositionFactory_FDRM.lu
(int numRows, int numCol) Returns aLUDecomposition
that has been optimized for the specified matrix size.static LinearSolverDense<FMatrixRMaj>
LinearSolverFactory_FDRM.lu
(int numRows) Creates a linear solver using LU decompositionstatic LinearSolverDense<FMatrixRMaj>
LinearSolverFactory_FDRM.pseudoInverse
(boolean useSVD) Returns a solver which uses the pseudo inverse.static QRDecomposition<FMatrixRMaj>
DecompositionFactory_FDRM.qr()
static QRDecomposition<FMatrixRMaj>
DecompositionFactory_FDRM.qr
(int numRows, int numCols) Returns aQRDecomposition
that has been optimized for the specified matrix size.static QRDecomposition<FMatrixRMaj>
DecompositionFactory_MT_FDRM.qr()
static QRDecomposition<FMatrixRMaj>
DecompositionFactory_MT_FDRM.qr
(int numRows, int numCols) Returns aQRDecomposition
that has been optimized for the specified matrix size.static LinearSolverDense<FMatrixRMaj>
LinearSolverFactory_FDRM.qr
(int numRows, int numCols) Creates a linear solver using QR decompositionstatic LinearSolverDense<FMatrixRMaj>
LinearSolverFactory_MT_FDRM.qr
(int numRows, int numCols) Creates a linear solver using QR decompositionstatic QRPDecomposition_F32<FMatrixRMaj>
DecompositionFactory_FDRM.qrp()
static QRPDecomposition_F32<FMatrixRMaj>
DecompositionFactory_FDRM.qrp
(int numRows, int numCols) Returns aQRPDecomposition_F32
that has been optimized for the specified matrix size.static LinearSolverDense<FMatrixRMaj>
LinearSolverFactory_FDRM.qrp
(boolean computeNorm2, boolean computeQ) Creates a linear solver using QRP decompositionDecompositionFactory_FDRM.svd
(boolean needU, boolean needV, boolean compact) Returns aSingularValueDecomposition
that is NOT optimized for any specified matrix size.DecompositionFactory_FDRM.svd
(int numRows, int numCols, boolean needU, boolean needV, boolean compact) Returns aSingularValueDecomposition
that has been optimized for the specified matrix size.DecompositionFactory_MT_FDRM.svd
(boolean needU, boolean needV, boolean compact) Returns aSingularValueDecomposition
that is NOT optimized for any specified matrix size.DecompositionFactory_MT_FDRM.svd
(int numRows, int numCols, boolean needU, boolean needV, boolean compact) Returns aSingularValueDecomposition
that has been optimized for the specified matrix size.static LinearSolverDense<FMatrixRMaj>
LinearSolverFactory_FDRM.symmPosDef
(int matrixWidth) Creates a solver for symmetric positive definite matrices.static LinearSolverDense<FMatrixRMaj>
LinearSolverFactory_MT_FDRM.symmPosDef
(int matrixWidth) Creates a solver for symmetric positive definite matrices.DecompositionFactory_FDRM.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_FDRM.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 float
DecompositionFactory_FDRM.quality
(FMatrixRMaj orig, FMatrixRMaj U, FMatrixRMaj W, FMatrixRMaj Vt) static float
DecompositionFactory_FDRM.quality
(FMatrixRMaj orig, EigenDecomposition_F32<FMatrixRMaj> eig) Computes a metric which measures the the quality of an eigen value decomposition.static float
DecompositionFactory_FDRM.quality
(FMatrixRMaj orig, SingularValueDecomposition<FMatrixRMaj> svd) Computes a metric which measures the the quality of a singular value decomposition.Modifier and TypeMethodDescriptionstatic float
DecompositionFactory_FDRM.quality
(FMatrixRMaj orig, EigenDecomposition_F32<FMatrixRMaj> eig) Computes a metric which measures the the quality of an eigen value decomposition.static float
DecompositionFactory_FDRM.quality
(FMatrixRMaj orig, SingularValueDecomposition<FMatrixRMaj> svd) Computes a metric which measures the the quality of a singular value decomposition. -
Uses of FMatrixRMaj in org.ejml.dense.row.linsol
Modifier and TypeMethodDescriptionprotected void
LinearSolverAbstract_FDRM._setA
(FMatrixRMaj A) static void
InvertUsingSolve_FDRM.invert
(LinearSolverDense<FMatrixRMaj> solver, FMatrix1Row A, FMatrixRMaj A_inv) static void
InvertUsingSolve_FDRM.invert
(LinearSolverDense<FMatrixRMaj> solver, FMatrix1Row A, FMatrixRMaj A_inv, FMatrixRMaj storage) void
LinearSolver_FDRB_to_FDRM.invert
(FMatrixRMaj 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_FDRM.invert
(FMatrixRMaj A_inv) void
LinearSolverUnrolled_FDRM.invert
(FMatrixRMaj A_inv) boolean
LinearSolver_FDRB_to_FDRM.setA
(FMatrixRMaj A) Converts 'A' into a block matrix and call setA() on the block matrix solver.boolean
LinearSolverUnrolled_FDRM.setA
(FMatrixRMaj A) void
LinearSolver_FDRB_to_FDRM.solve
(FMatrixRMaj B, FMatrixRMaj X) Converts B and X into block matrices and calls the block matrix solve routine.void
LinearSolverUnrolled_FDRM.solve
(FMatrixRMaj B, FMatrixRMaj X) Modifier and TypeMethodDescriptionstatic void
InvertUsingSolve_FDRM.invert
(LinearSolverDense<FMatrixRMaj> solver, FMatrix1Row A, FMatrixRMaj A_inv) static void
InvertUsingSolve_FDRM.invert
(LinearSolverDense<FMatrixRMaj> solver, FMatrix1Row A, FMatrixRMaj A_inv, FMatrixRMaj storage) -
Uses of FMatrixRMaj in org.ejml.dense.row.linsol.chol
Modifier and TypeMethodDescriptionLinearSolverChol_FDRM.getDecomposition()
LinearSolverCholLDL_FDRM.getDecomposition()
Modifier and TypeMethodDescriptionvoid
LinearSolverChol_FDRM.invert
(FMatrixRMaj inv) Sets the matrix 'inv' equal to the inverse of the matrix that was decomposed.void
LinearSolverCholLDL_FDRM.invert
(FMatrixRMaj inv) Sets the matrix 'inv' equal to the inverse of the matrix that was decomposed.boolean
LinearSolverChol_FDRM.setA
(FMatrixRMaj A) boolean
LinearSolverCholLDL_FDRM.setA
(FMatrixRMaj A) void
LinearSolverChol_FDRB.solve
(FMatrixRMaj B, FMatrixRMaj X) Only converts the B matrix and passes that onto solve.void
LinearSolverChol_FDRM.solve
(FMatrixRMaj B, FMatrixRMaj 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_FDRM.solve
(FMatrixRMaj B, FMatrixRMaj 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_FDRM.solveLower
(FMatrixRMaj L, FMatrixRMaj B, FMatrixRMaj X, float[] vv) -
Uses of FMatrixRMaj in org.ejml.dense.row.linsol.lu
Modifier and TypeMethodDescriptionvoid
LinearSolverLuBase_FDRM.improveSol
(FMatrixRMaj b, FMatrixRMaj x) This attempts to improve upon the solution generated by account for numerical imprecisions.void
LinearSolverLuBase_FDRM.invert
(FMatrixRMaj A_inv) boolean
LinearSolverLuBase_FDRM.setA
(FMatrixRMaj A) boolean
LinearSolverLuKJI_FDRM.setA
(FMatrixRMaj A) void
LinearSolverLu_FDRM.solve
(FMatrixRMaj B, FMatrixRMaj X) void
LinearSolverLuKJI_FDRM.solve
(FMatrixRMaj B, FMatrixRMaj X) An other implementation of solve() that processes the matrices in a different order. -
Uses of FMatrixRMaj in org.ejml.dense.row.linsol.qr
Modifier and TypeFieldDescriptionprotected final FMatrixRMaj
LinearSolverQrHouseCol_FDRM.a
protected FMatrixRMaj
BaseLinearSolverQrp_FDRM.I
protected FMatrixRMaj
LinearSolverQr_FDRM.Q
protected FMatrixRMaj
BaseLinearSolverQrp_FDRM.R
protected FMatrixRMaj
LinearSolverQr_FDRM.R
protected final FMatrixRMaj
LinearSolverQrHouseCol_FDRM.R
protected FMatrixRMaj
BaseLinearSolverQrp_FDRM.R11
protected final FMatrixRMaj
LinearSolverQrHouseCol_FDRM.temp
protected FMatrixRMaj
BaseLinearSolverQrp_FDRM.Y
Modifier and TypeFieldDescriptionprotected LinearSolverDense<FMatrixRMaj>
BaseLinearSolverQrp_FDRM.internalSolver
Modifier and TypeMethodDescriptionAdjLinearSolverQr_FDRM.getA()
Compute the A matrix from the Q and R matrices.LinearSolverQr_FDRM.getQ()
SolveNullSpaceQR_FDRM.getQ()
SolveNullSpaceQRP_FDRM.getQ()
LinearSolverQr_FDRM.getR()
Modifier and TypeMethodDescriptionLinearSolverQr_FDRM.getDecomposer()
BaseLinearSolverQrp_FDRM.getDecomposition()
LinearSolverQr_FDRM.getDecomposition()
LinearSolverQrHouse_FDRM.getDecomposition()
LinearSolverQrHouseCol_FDRM.getDecomposition()
LinearSolverQrHouseTran_FDRM.getDecomposition()
Modifier and TypeMethodDescriptionvoid
BaseLinearSolverQrp_FDRM.invert
(FMatrixRMaj A_inv) boolean
SolveNullSpaceQR_FDRM.process
(FMatrixRMaj A, int numSingularValues, FMatrixRMaj nullspace) Finds the null space of Aboolean
SolveNullSpaceQRP_FDRM.process
(FMatrixRMaj A, int numSingularValues, FMatrixRMaj nullspace) Finds the null space of Aboolean
BaseLinearSolverQrp_FDRM.setA
(FMatrixRMaj A) boolean
LinearSolverQr_FDRM.setA
(FMatrixRMaj A) Performs QR decomposition on Aboolean
LinearSolverQrHouse_FDRM.setA
(FMatrixRMaj A) Performs QR decomposition on Aboolean
LinearSolverQrHouseCol_FDRM.setA
(FMatrixRMaj A) Performs QR decomposition on Aboolean
LinearSolverQrHouseTran_FDRM.setA
(FMatrixRMaj A) Performs QR decomposition on Aboolean
SolvePseudoInverseQrp_FDRM.setA
(FMatrixRMaj A) void
LinearSolverQr_FDRM.solve
(FMatrixRMaj B, FMatrixRMaj X) Solves for X using the QR decomposition.void
LinearSolverQrHouse_FDRM.solve
(FMatrixRMaj B, FMatrixRMaj X) Solves for X using the QR decomposition.void
LinearSolverQrHouseCol_FDRM.solve
(FMatrixRMaj B, FMatrixRMaj X) Solves for X using the QR decomposition.void
LinearSolverQrHouseCol_MT_FDRM.solve
(FMatrixRMaj B, FMatrixRMaj X) Solves for X using the QR decomposition.void
LinearSolverQrHouseTran_FDRM.solve
(FMatrixRMaj B, FMatrixRMaj X) Solves for X using the QR decomposition.void
LinearSolverQrpHouseCol_FDRM.solve
(FMatrixRMaj B, FMatrixRMaj X) void
SolvePseudoInverseQrp_FDRM.solve
(FMatrixRMaj B, FMatrixRMaj X) protected void
BaseLinearSolverQrp_FDRM.upgradeSolution
(FMatrixRMaj X) Upgrades the basic solution to the optimal 2-norm solution.ModifierConstructorDescriptionprotected
BaseLinearSolverQrp_FDRM
(QRPDecomposition_F32<FMatrixRMaj> decomposition, boolean norm2Solution) Configures internal parameters.LinearSolverQr_FDRM
(QRDecomposition<FMatrixRMaj> decomposer) Creates a linear solver that uses QR decomposition.SolvePseudoInverseQrp_FDRM
(QRPDecomposition_F32<FMatrixRMaj> decomposition, boolean norm2Solution) Configure and provide decomposition -
Uses of FMatrixRMaj in org.ejml.dense.row.linsol.svd
Modifier and TypeMethodDescriptionSolvePseudoInverseSvd_FDRM.getDecomposer()
SolvePseudoInverseSvd_FDRM.getDecomposition()
SolveNullSpaceSvd_FDRM.getSvd()
Modifier and TypeMethodDescriptionvoid
SolvePseudoInverseSvd_FDRM.invert
(FMatrixRMaj A_inv) boolean
SolveNullSpaceSvd_FDRM.process
(FMatrixRMaj input, int numberOfSingular, FMatrixRMaj nullspace) boolean
SolvePseudoInverseSvd_FDRM.setA
(FMatrixRMaj A) void
SolvePseudoInverseSvd_FDRM.solve
(FMatrixRMaj b, FMatrixRMaj x) -
Uses of FMatrixRMaj in org.ejml.dense.row.misc
Modifier and TypeMethodDescriptionstatic void
ImplCommonOps_FDRM.extract
(FMatrixRMaj src, int srcY0, int srcX0, FMatrixRMaj dst, int dstY0, int dstX0, int numRows, int numCols) static void
UnrolledInverseFromMinor_FDRM.inv
(FMatrixRMaj mat, FMatrixRMaj inv) static void
UnrolledInverseFromMinor_FDRM.inv2
(FMatrixRMaj mat, FMatrixRMaj inv, float scale) static void
UnrolledInverseFromMinor_FDRM.inv3
(FMatrixRMaj mat, FMatrixRMaj inv, float scale) static void
UnrolledInverseFromMinor_FDRM.inv4
(FMatrixRMaj mat, FMatrixRMaj inv, float scale) static void
UnrolledInverseFromMinor_FDRM.inv5
(FMatrixRMaj mat, FMatrixRMaj inv, float scale) void
RrefGaussJordanRowPivot_FDRM.reduce
(FMatrixRMaj A, int coefficientColumns) protected static void
RrefGaussJordanRowPivot_FDRM.swapRows
(FMatrixRMaj A, int rowA, int rowB) -
Uses of FMatrixRMaj in org.ejml.dense.row.mult
Modifier and TypeMethodDescriptionstatic void
VectorVectorMult_FDRM.rank1Update
(float gamma, FMatrixRMaj A, FMatrixRMaj u, FMatrixRMaj w) Performs a rank one update on matrix A using vectors u and w.static void
VectorVectorMult_FDRM.rank1Update
(float gamma, FMatrixRMaj A, FMatrixRMaj u, FMatrixRMaj w, FMatrixRMaj B) Performs a rank one update on matrix A using vectors u and w. -
Uses of FMatrixRMaj in org.ejml.equation
-
Uses of FMatrixRMaj in org.ejml.ops
Modifier and TypeMethodDescriptionstatic FMatrixRMaj
FConvertArrays.convert
(float[][] src, @Nullable FMatrixRMaj dst) static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix2 input, @Nullable FMatrixRMaj output) ConvertsFMatrix2
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix2x2 input, @Nullable FMatrixRMaj output) ConvertsFMatrix2x2
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix3 input, @Nullable FMatrixRMaj output) ConvertsFMatrix3
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix3x3 input, @Nullable FMatrixRMaj output) ConvertsFMatrix3x3
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix4 input, @Nullable FMatrixRMaj output) ConvertsFMatrix4
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix4x4 input, @Nullable FMatrixRMaj output) ConvertsFMatrix4x4
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix5 input, @Nullable FMatrixRMaj output) ConvertsFMatrix5
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix5x5 input, @Nullable FMatrixRMaj output) ConvertsFMatrix5x5
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix6 input, @Nullable FMatrixRMaj output) ConvertsFMatrix6
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix6x6 input, @Nullable FMatrixRMaj output) ConvertsFMatrix6x6
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrixRBlock src, @Nullable FMatrixRMaj dst) ConvertsFMatrixRBlock
intoFMatrixRMaj
static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrixSparseCSC src, @Nullable FMatrixRMaj dst) static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrixSparseTriplet src, @Nullable FMatrixRMaj dst) static FMatrixRMaj
MatrixIO.loadMatrixMarketFDRM
(Reader reader) Reads a stream in Matrix Market Coordinate formatstatic FMatrixRMaj
MatrixIO.matlabToFDRM
(String text) Converts a text string in matlab format into a DDRM matrixReadMatrixCsv.readFDRM
(int numRows, int numCols) Reads in aFMatrixRMaj
from the IO stream where the user specifies the matrix dimensions.Modifier and TypeMethodDescriptionstatic void
ConvertMatrixData.convert
(DMatrixRMaj src, FMatrixRMaj dst) static void
ConvertMatrixData.convert
(FMatrixRMaj src, CMatrixRMaj dst) static void
ConvertMatrixData.convert
(FMatrixRMaj src, DMatrixRMaj dst) static void
ConvertMatrixData.convert
(FMatrixRMaj src, ZMatrixRMaj dst) static FMatrixRMaj
FConvertArrays.convert
(float[][] src, @Nullable FMatrixRMaj dst) static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix2 input, @Nullable FMatrixRMaj output) ConvertsFMatrix2
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix2x2 input, @Nullable FMatrixRMaj output) ConvertsFMatrix2x2
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix3 input, @Nullable FMatrixRMaj output) ConvertsFMatrix3
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix3x3 input, @Nullable FMatrixRMaj output) ConvertsFMatrix3x3
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix4 input, @Nullable FMatrixRMaj output) ConvertsFMatrix4
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix4x4 input, @Nullable FMatrixRMaj output) ConvertsFMatrix4x4
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix5 input, @Nullable FMatrixRMaj output) ConvertsFMatrix5
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix5x5 input, @Nullable FMatrixRMaj output) ConvertsFMatrix5x5
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix6 input, @Nullable FMatrixRMaj output) ConvertsFMatrix6
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrix6x6 input, @Nullable FMatrixRMaj output) ConvertsFMatrix6x6
intoFMatrixRMaj
.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrixRBlock src, @Nullable FMatrixRMaj dst) ConvertsFMatrixRBlock
intoFMatrixRMaj
static FMatrix2
FConvertMatrixStruct.convert
(FMatrixRMaj input, @Nullable FMatrix2 output) ConvertsFMatrixRMaj
intoFMatrix2
static FMatrix2x2
FConvertMatrixStruct.convert
(FMatrixRMaj input, @Nullable FMatrix2x2 output) ConvertsFMatrixRMaj
intoFMatrix2x2
static FMatrix3
FConvertMatrixStruct.convert
(FMatrixRMaj input, @Nullable FMatrix3 output) ConvertsFMatrixRMaj
intoFMatrix3
static FMatrix3x3
FConvertMatrixStruct.convert
(FMatrixRMaj input, @Nullable FMatrix3x3 output) ConvertsFMatrixRMaj
intoFMatrix3x3
static FMatrix4
FConvertMatrixStruct.convert
(FMatrixRMaj input, @Nullable FMatrix4 output) ConvertsFMatrixRMaj
intoFMatrix4
static FMatrix4x4
FConvertMatrixStruct.convert
(FMatrixRMaj input, @Nullable FMatrix4x4 output) ConvertsFMatrixRMaj
intoFMatrix4x4
static FMatrix5
FConvertMatrixStruct.convert
(FMatrixRMaj input, @Nullable FMatrix5 output) ConvertsFMatrixRMaj
intoFMatrix5
static FMatrix5x5
FConvertMatrixStruct.convert
(FMatrixRMaj input, @Nullable FMatrix5x5 output) ConvertsFMatrixRMaj
intoFMatrix5x5
static FMatrix6
FConvertMatrixStruct.convert
(FMatrixRMaj input, @Nullable FMatrix6 output) ConvertsFMatrixRMaj
intoFMatrix6
static FMatrix6x6
FConvertMatrixStruct.convert
(FMatrixRMaj input, @Nullable FMatrix6x6 output) ConvertsFMatrixRMaj
intoFMatrix6x6
static FMatrixSparseCSC
FConvertMatrixStruct.convert
(FMatrixRMaj src, @Nullable FMatrixSparseCSC dst, float tol) Converts FMatrixRMaj into a FMatrixSparseCSCstatic FMatrixSparseTriplet
FConvertMatrixStruct.convert
(FMatrixRMaj src, @Nullable FMatrixSparseTriplet dst, float tol) static void
FConvertMatrixStruct.convert
(FMatrixRMaj src, FMatrixRBlock dst) ConvertsFMatrixRMaj
intoFMatrixRBlock
Can't handle null output matrix since block size needs to be specified.static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrixSparseCSC src, @Nullable FMatrixRMaj dst) static FMatrixRMaj
FConvertMatrixStruct.convert
(FMatrixSparseTriplet src, @Nullable FMatrixRMaj dst) static void
MatrixIO.saveMatrixMarket
(FMatrixRMaj matrix, String floatFormat, Writer writer) Writes a stream using the Matrix Market Coordinate format. -
Uses of FMatrixRMaj in org.ejml.simple
-
Uses of FMatrixRMaj in org.ejml.simple.ops
Modifier and TypeMethodDescriptionvoid
SimpleOperations_FDRM.changeSign
(FMatrixRMaj a) double
SimpleOperations_FDRM.conditionP2
(FMatrixRMaj A) double
SimpleOperations_FDRM.determinant
(FMatrixRMaj A) SimpleOperations_FDRM.diag
(FMatrixRMaj A) void
SimpleOperations_FDRM.divide
(FMatrixRMaj A, double val, FMatrixRMaj output) double
SimpleOperations_FDRM.dot
(FMatrixRMaj A, FMatrixRMaj v) void
SimpleOperations_FDRM.elementDiv
(FMatrixRMaj A, FMatrixRMaj B, FMatrixRMaj output) void
SimpleOperations_FDRM.elementExp
(FMatrixRMaj A, FMatrixRMaj output) void
SimpleOperations_FDRM.elementLog
(FMatrixRMaj A, FMatrixRMaj output) double
SimpleOperations_FDRM.elementMax
(FMatrixRMaj A) double
SimpleOperations_FDRM.elementMaxAbs
(FMatrixRMaj A) double
SimpleOperations_FDRM.elementMin
(FMatrixRMaj A) double
SimpleOperations_FDRM.elementMinAbs
(FMatrixRMaj A) void
SimpleOperations_FDRM.elementMult
(FMatrixRMaj A, FMatrixRMaj B, FMatrixRMaj output) void
SimpleOperations_FDRM.elementOp
(FMatrixRMaj A, SimpleOperations.ElementOpComplex op, FMatrixRMaj output) void
SimpleOperations_FDRM.elementOp
(FMatrixRMaj A, SimpleOperations.ElementOpReal op, FMatrixRMaj output) void
SimpleOperations_FDRM.elementPower
(FMatrixRMaj A, double b, FMatrixRMaj output) void
SimpleOperations_FDRM.elementPower
(FMatrixRMaj A, FMatrixRMaj B, FMatrixRMaj output) double
SimpleOperations_FDRM.elementSum
(FMatrixRMaj A) void
SimpleOperations_FDRM.extract
(FMatrixRMaj src, int srcY0, int srcY1, int srcX0, int srcX1, FMatrixRMaj dst, int dstY0, int dstX0) void
SimpleOperations_FSCC.extractDiag
(FMatrixSparseCSC input, FMatrixRMaj output) void
SimpleOperations_FDRM.fill
(FMatrixRMaj A, double value) double
SimpleOperations_FDRM.get
(FMatrixRMaj A, int row, int column) void
SimpleOperations_FDRM.get
(FMatrixRMaj A, int row, int column, Complex_F64 value) double[]
SimpleOperations_FDRM.getColumn
(FMatrixRMaj A, int col, int row0, int row1) double
SimpleOperations_FDRM.getImaginary
(FMatrixRMaj A, int row, int column) double
SimpleOperations_FDRM.getReal
(FMatrixRMaj A, int row, int column) double[]
SimpleOperations_FDRM.getRow
(FMatrixRMaj A, int row, int idx0, int idx1) boolean
SimpleOperations_FDRM.hasUncountable
(FMatrixRMaj M) boolean
SimpleOperations_FDRM.invert
(FMatrixRMaj A, FMatrixRMaj output) boolean
SimpleOperations_FDRM.isIdentical
(FMatrixRMaj A, FMatrixRMaj B, double tol) void
SimpleOperations_FDRM.kron
(FMatrixRMaj A, FMatrixRMaj B, FMatrixRMaj output) void
SimpleOperations_FDRM.minus
(FMatrixRMaj A, double b, FMatrixRMaj output) void
SimpleOperations_FDRM.minus
(FMatrixRMaj A, FMatrixRMaj B, FMatrixRMaj output) void
SimpleOperations_FDRM.mult
(FMatrixRMaj A, FMatrixRMaj B, FMatrixRMaj output) void
SimpleOperations_FSCC.mult
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj output) void
SimpleOperations_FDRM.multTransA
(FMatrixRMaj A, FMatrixRMaj B, FMatrixRMaj output) void
SimpleOperations_FSCC.multTransA
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj output) double
SimpleOperations_FDRM.normF
(FMatrixRMaj A) void
SimpleOperations_FDRM.plus
(double alpha, FMatrixRMaj A, double beta, FMatrixRMaj b, FMatrixRMaj output) void
SimpleOperations_FDRM.plus
(FMatrixRMaj A, double b, FMatrixRMaj output) void
SimpleOperations_FDRM.plus
(FMatrixRMaj A, double beta, FMatrixRMaj b, FMatrixRMaj output) void
SimpleOperations_FDRM.plus
(FMatrixRMaj A, FMatrixRMaj B, FMatrixRMaj output) void
SimpleOperations_FDRM.pseudoInverse
(FMatrixRMaj A, FMatrixRMaj output) void
SimpleOperations_FDRM.scale
(FMatrixRMaj A, double val, FMatrixRMaj output) void
SimpleOperations_FDRM.set
(FMatrixRMaj A, int row, int column, double value) void
SimpleOperations_FDRM.set
(FMatrixRMaj A, int row, int column, double real, double imaginary) void
SimpleOperations_FDRM.setColumn
(FMatrixRMaj A, int column, int startRow, double... values) void
SimpleOperations_FDRM.setIdentity
(FMatrixRMaj A) void
SimpleOperations_FDRM.setRow
(FMatrixRMaj A, int row, int startColumn, double... values) boolean
SimpleOperations_FDRM.solve
(FMatrixRMaj A, FMatrixRMaj X, FMatrixRMaj B) boolean
SimpleOperations_FSCC.solve
(FMatrixSparseCSC A, FMatrixRMaj X, FMatrixRMaj B) double
SimpleOperations_FDRM.trace
(FMatrixRMaj A) void
SimpleOperations_FDRM.transpose
(FMatrixRMaj input, FMatrixRMaj output) void
SimpleOperations_FDRM.zero
(FMatrixRMaj A) -
Uses of FMatrixRMaj in org.ejml.sparse.csc
Modifier and TypeMethodDescriptionstatic FMatrixRMaj
CommonOps_FSCC.maxCols
(FMatrixSparseCSC input, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_FSCC.maxRows
(FMatrixSparseCSC input, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_FSCC.minCols
(FMatrixSparseCSC input, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_FSCC.minRows
(FMatrixSparseCSC input, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_FSCC.mult
(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC) Performs matrix multiplication.static FMatrixRMaj
CommonOps_MT_FSCC.mult
(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable GrowArray<FGrowArray> workspace) Performs matrix multiplication.static FMatrixRMaj
CommonOpsWithSemiRing_FSCC.mult
(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj output, FSemiRing semiRing) Performs matrix multiplication.static FMatrixRMaj
CommonOps_FSCC.multTransA
(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable FGrowArray work) Performs matrix multiplication.static FMatrixRMaj
CommonOps_MT_FSCC.multTransA
(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable GrowArray<FGrowArray> workspace) Performs matrix multiplication.static FMatrixRMaj
CommonOpsWithSemiRing_FSCC.multTransA
(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj output, FSemiRing semiRing) Performs matrix multiplication.static FMatrixRMaj
CommonOps_FSCC.multTransAB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC) Performs matrix multiplication.static FMatrixRMaj
CommonOps_MT_FSCC.multTransAB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC) Performs matrix multiplication.static FMatrixRMaj
CommonOpsWithSemiRing_FSCC.multTransAB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj output, FSemiRing semiRing) Performs matrix multiplication.static FMatrixRMaj
CommonOps_FSCC.multTransB
(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable FGrowArray work) Performs matrix multiplication.static FMatrixRMaj
CommonOps_MT_FSCC.multTransB
(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable GrowArray<FGrowArray> workspace) Performs matrix multiplication.static FMatrixRMaj
CommonOpsWithSemiRing_FSCC.multTransB
(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj output, FSemiRing semiRing) Performs matrix multiplication.static FMatrixRMaj
CommonOps_FSCC.reduceColumnWise
(FMatrixSparseCSC input, float initValue, FOperatorBinary func, @Nullable FMatrixRMaj output, @Nullable Mask mask) This accumulates the values per column to a scalar valuestatic FMatrixRMaj
CommonOps_FSCC.reduceRowWise
(FMatrixSparseCSC input, float initValue, FOperatorBinary func, @Nullable FMatrixRMaj output) This accumulates the values per row to a scalar valuestatic FMatrixRMaj
CommonOps_FSCC.sumCols
(FMatrixSparseCSC input, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_FSCC.sumRows
(FMatrixSparseCSC input, @Nullable FMatrixRMaj 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_FSCC.extractDiag
(FMatrixSparseCSC A, FMatrixRMaj outputB) Extracts the diagonal elements 'src' write it to the 'dst' vector.static boolean
CommonOps_FSCC.invert
(FMatrixSparseCSC A, FMatrixRMaj inverse) Performs a matrix inversion operation that does not modify the original and stores the results in another matrix.static void
CommonOps_FSCC.maxAbsCols
(FMatrixSparseCSC A, @Nullable FMatrixRMaj outputB) Finds the maximum abs in each column of A and stores it into valuesstatic FMatrixRMaj
CommonOps_FSCC.maxCols
(FMatrixSparseCSC input, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_FSCC.maxRows
(FMatrixSparseCSC input, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_FSCC.minCols
(FMatrixSparseCSC input, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_FSCC.minRows
(FMatrixSparseCSC input, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_FSCC.mult
(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC) Performs matrix multiplication.static FMatrixRMaj
CommonOps_MT_FSCC.mult
(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable GrowArray<FGrowArray> workspace) Performs matrix multiplication.static FMatrixRMaj
CommonOpsWithSemiRing_FSCC.mult
(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj output, FSemiRing semiRing) Performs matrix multiplication.static void
CommonOps_FSCC.multAdd
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC) C = C + A*Bstatic void
CommonOps_MT_FSCC.multAdd
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC, @Nullable GrowArray<FGrowArray> workspace) C = C + AT*Bstatic void
CommonOpsWithSemiRing_FSCC.multAdd
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj output, FSemiRing semiRing) output = output + A*Bstatic void
CommonOps_FSCC.multAddTransA
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC, @Nullable FGrowArray work) C = C + AT*Bstatic void
CommonOps_MT_FSCC.multAddTransA
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC, @Nullable GrowArray<FGrowArray> workspace) C = C + AT*Bstatic void
CommonOpsWithSemiRing_FSCC.multAddTransA
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj output, FSemiRing semiRing) output = output + AT*Bstatic void
CommonOps_FSCC.multAddTransAB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC) C = C + AT*BTstatic void
CommonOps_MT_FSCC.multAddTransAB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC) C = C + AT*BTstatic void
CommonOpsWithSemiRing_FSCC.multAddTransAB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FSemiRing semiRing) C = C + AT*BTstatic void
CommonOps_FSCC.multAddTransB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC, @Nullable FGrowArray work) C = C + A*BTstatic void
CommonOps_MT_FSCC.multAddTransB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC, @Nullable GrowArray<FGrowArray> workspace) C = C + A*BTstatic void
CommonOpsWithSemiRing_FSCC.multAddTransB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj output, FSemiRing semiRing) output = output + A*BTstatic FMatrixRMaj
CommonOps_FSCC.multTransA
(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable FGrowArray work) Performs matrix multiplication.static FMatrixRMaj
CommonOps_MT_FSCC.multTransA
(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable GrowArray<FGrowArray> workspace) Performs matrix multiplication.static FMatrixRMaj
CommonOpsWithSemiRing_FSCC.multTransA
(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj output, FSemiRing semiRing) Performs matrix multiplication.static FMatrixRMaj
CommonOps_FSCC.multTransAB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC) Performs matrix multiplication.static FMatrixRMaj
CommonOps_MT_FSCC.multTransAB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC) Performs matrix multiplication.static FMatrixRMaj
CommonOpsWithSemiRing_FSCC.multTransAB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj output, FSemiRing semiRing) Performs matrix multiplication.static FMatrixRMaj
CommonOps_FSCC.multTransB
(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable FGrowArray work) Performs matrix multiplication.static FMatrixRMaj
CommonOps_MT_FSCC.multTransB
(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable GrowArray<FGrowArray> workspace) Performs matrix multiplication.static FMatrixRMaj
CommonOpsWithSemiRing_FSCC.multTransB
(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj output, FSemiRing semiRing) Performs matrix multiplication.static FMatrixRMaj
CommonOps_FSCC.reduceColumnWise
(FMatrixSparseCSC input, float initValue, FOperatorBinary func, @Nullable FMatrixRMaj output, @Nullable Mask mask) This accumulates the values per column to a scalar valuestatic FMatrixRMaj
CommonOps_FSCC.reduceRowWise
(FMatrixSparseCSC input, float initValue, FOperatorBinary func, @Nullable FMatrixRMaj output) This accumulates the values per row to a scalar valuestatic boolean
CommonOps_FSCC.solve
(FMatrixSparseCSC a, FMatrixRMaj b, FMatrixRMaj x) Solves for x in the following equation:
A*x = bstatic FMatrixRMaj
CommonOps_FSCC.sumCols
(FMatrixSparseCSC input, @Nullable FMatrixRMaj 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 FMatrixRMaj
CommonOps_FSCC.sumRows
(FMatrixSparseCSC input, @Nullable FMatrixRMaj 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 FMatrixRMaj in org.ejml.sparse.csc.factory
Modifier and TypeMethodDescriptionLinearSolverFactory_FSCC.cholesky
(FillReducing permutation) LinearSolverFactory_FSCC.lu
(FillReducing permutation) LinearSolverFactory_FSCC.qr
(FillReducing permutation) -
Uses of FMatrixRMaj in org.ejml.sparse.csc.linsol.chol
Modifier and TypeMethodDescriptionvoid
LinearSolverCholesky_FSCC.solve
(FMatrixRMaj B, FMatrixRMaj X) -
Uses of FMatrixRMaj in org.ejml.sparse.csc.linsol.lu
-
Uses of FMatrixRMaj in org.ejml.sparse.csc.linsol.qr
Modifier and TypeMethodDescriptionvoid
LinearSolverQrLeftLooking_FSCC.solve
(FMatrixRMaj B, FMatrixRMaj X) -
Uses of FMatrixRMaj in org.ejml.sparse.csc.mult
Modifier and TypeMethodDescriptionstatic float
MatrixVectorMult_FSCC.innerProduct
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixSparseCSC C) scalar = AT*B*Cstatic float
MatrixVectorMult_FSCC.innerProductSelfSymmetrical
(FMatrixSparseCSC A, FMatrixRMaj B) scalar = AT*B*Astatic void
ImplMultiplication_FSCC.mult
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C) Invoke throughCommonOps_FSCC
static void
ImplMultiplication_MT_FSCC.mult
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, boolean add, GrowArray<FGrowArray> listWork) Invoke throughCommonOps_MT_FSCC
as it will manage the input contractstatic void
ImplMultiplication_MT_FSCC.mult
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, GrowArray<FGrowArray> listWork) Invoke throughCommonOps_MT_FSCC
as it will manage the input contractstatic void
ImplMultiplicationWithSemiRing_FSCC.mult
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FSemiRing semiRing) static void
ImplMultiplication_FSCC.multAdd
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C) Invoke throughCommonOps_FSCC
static void
ImplMultiplication_MT_FSCC.multAdd
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, GrowArray<FGrowArray> listWork) Invoke throughCommonOps_MT_FSCC
as it will manage the input contractstatic void
ImplMultiplicationWithSemiRing_FSCC.multAdd
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FSemiRing semiRing) static void
ImplMultiplication_FSCC.multAddTransA
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FGrowArray workArray) Invoke throughCommonOps_FSCC
static void
ImplMultiplication_MT_FSCC.multAddTransA
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, GrowArray<FGrowArray> listWork) Invoke throughCommonOps_MT_FSCC
as it will manage the input contractstatic void
ImplMultiplicationWithSemiRing_FSCC.multAddTransA
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FSemiRing semiRing) static void
ImplMultiplication_FSCC.multAddTransAB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C) Invoke throughCommonOps_FSCC
static void
ImplMultiplication_MT_FSCC.multAddTransAB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C) Invoke throughCommonOps_MT_FSCC
as it will manage the input contractstatic void
ImplMultiplicationWithSemiRing_FSCC.multAddTransAB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FSemiRing semiRing) static void
ImplMultiplication_FSCC.multAddTransB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FGrowArray workArray) Invoke throughCommonOps_FSCC
static void
ImplMultiplication_MT_FSCC.multAddTransB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, GrowArray<FGrowArray> listWork) Invoke throughCommonOps_MT_FSCC
as it will manage the input contractstatic void
ImplMultiplicationWithSemiRing_FSCC.multAddTransB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FSemiRing semiRing) static void
ImplMultiplication_FSCC.multTransA
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FGrowArray workArray) Invoke throughCommonOps_FSCC
static void
ImplMultiplication_FSCC.multTransA
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FGrowArray workArray, FOperatorBinary op) Invoke throughCommonOps_FSCC
static void
ImplMultiplication_MT_FSCC.multTransA
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, GrowArray<FGrowArray> listWork) Invoke throughCommonOps_MT_FSCC
as it will manage the input contractstatic void
ImplMultiplicationWithSemiRing_FSCC.multTransA
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FSemiRing semiRing) static void
ImplMultiplication_FSCC.multTransAB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C) Invoke throughCommonOps_FSCC
static void
ImplMultiplication_MT_FSCC.multTransAB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C) Invoke throughCommonOps_MT_FSCC
as it will manage the input contractstatic void
ImplMultiplicationWithSemiRing_FSCC.multTransAB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FSemiRing semiRing) static void
ImplMultiplication_FSCC.multTransB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FGrowArray workArray) Invoke throughCommonOps_FSCC
static void
ImplMultiplication_MT_FSCC.multTransB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, boolean add, GrowArray<FGrowArray> listWork) Invoke throughCommonOps_MT_FSCC
as it will manage the input contractstatic void
ImplMultiplication_MT_FSCC.multTransB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, GrowArray<FGrowArray> listWork) Invoke throughCommonOps_MT_FSCC
as it will manage the input contractstatic void
ImplMultiplicationWithSemiRing_FSCC.multTransB
(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FSemiRing semiRing)