Uses of Class
org.ejml.data.FMatrixRMaj
Packages that use FMatrixRMaj
Package
Description
-
Uses of FMatrixRMaj in org.ejml
Methods in org.ejml that return FMatrixRMajModifier and TypeMethodDescriptionstatic FMatrixRMajUtilEjml.parse_FDRM(String s, int numColumns) Give a string of numbers it returns a DenseMatrixstatic FMatrixRMajUtilEjml.reshapeOrDeclare(@Nullable FMatrixRMaj a, int rows, int cols) If the input matrix is null a new matrix is created and returned.Methods in org.ejml with parameters of type FMatrixRMajModifier and TypeMethodDescriptionstatic FMatrixRMajUtilEjml.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
Fields in org.ejml.data declared as FMatrixRMajMethods in org.ejml.data that return FMatrixRMajModifier 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 FMatrixRMajFMatrixRMaj.wrap(int numRows, int numCols, float[] data) Creates a new FMatrixRMaj around the provided data.Constructors in org.ejml.data with parameters of type FMatrixRMajModifierConstructorDescriptionFEigenpair(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
Methods in org.ejml.dense.block that return FMatrixRMajModifier and TypeMethodDescriptionstatic FMatrixRMajMatrixOps_FDRB.convert(FMatrixRBlock src, FMatrixRMaj dst) Converts a row major block matrix into a row major matrix.static FMatrixRMajMatrixOps_FDRB.convertInplace(FMatrixRBlock src, @Nullable FMatrixRMaj dst, @Nullable FGrowArray workspace) Converts a row major block matrix into a row major matrix.Methods in org.ejml.dense.block with parameters of type FMatrixRMajModifier and TypeMethodDescriptionstatic FMatrixRMajMatrixOps_FDRB.convert(FMatrixRBlock src, FMatrixRMaj dst) Converts a row major block matrix into a row major matrix.static FMatrixRBlockMatrixOps_FDRB.convert(FMatrixRMaj A) static FMatrixRBlockMatrixOps_FDRB.convert(FMatrixRMaj A, int blockLength) static voidMatrixOps_FDRB.convert(FMatrixRMaj src, FMatrixRBlock dst) Converts a row major matrix into a row major block matrix.static FMatrixRMajMatrixOps_FDRB.convertInplace(FMatrixRBlock src, @Nullable FMatrixRMaj dst, @Nullable FGrowArray workspace) Converts a row major block matrix into a row major matrix.static FMatrixRBlockMatrixOps_FDRB.convertInplace(FMatrixRMaj src, @Nullable FMatrixRBlock dst, @Nullable FGrowArray workspace) Converts a row major matrix into a row major block matrix.static voidMatrixOps_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
Fields in org.ejml.dense.block.decomposition.hessenberg declared as FMatrixRMajModifier and TypeFieldDescriptionprotected FMatrixRMajTridiagonalDecompositionHouseholder_FDRB.zerosMprotected FMatrixRMajTridiagonalDecompositionHouseholder_MT_FDRB.zerosM -
Uses of FMatrixRMaj in org.ejml.dense.row
Methods in org.ejml.dense.row that return FMatrixRMajModifier and TypeMethodDescriptionstatic FMatrixRMajCommonOps_FDRM.apply(FMatrixRMaj input, FOperatorUnary func) static FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_FDRM.concatColumns(FMatrixRMaj a, FMatrixRMaj b, @Nullable FMatrixRMaj output) output = [a , b]static FMatrixRMajCommonOps_FDRM.concatColumnsMulti(FMatrixRMaj... m) Concatenates all the matrices together along their columns.static FMatrixRMajCommonOps_FDRM.concatRowsMulti(FMatrixRMaj... m) Concatenates all the matrices together along their columns.static FMatrixRMajSpecializedOps_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 FMatrixRMajSpecializedOps_FDRM.copyTriangle(FMatrixRMaj src, @Nullable FMatrixRMaj dst, boolean upper) Copies just the upper or lower triangular portion of a matrix.static FMatrixRMajEigenOps_FDRM.createMatrixD(EigenDecomposition_F32<?> eig) A diagonal matrix where real diagonal element contains a real eigenvalue.static FMatrixRMajEigenOps_FDRM.createMatrixV(EigenDecomposition_F32<FMatrixRMaj> eig) Puts all the real eigenvectors into the columns of a matrix.static FMatrixRMajSpecializedOps_FDRM.createReflector(FMatrix1Row u) Creates a reflector from the provided vector.
Q = I - γ u uT
γ = 2/||u||2static FMatrixRMajSpecializedOps_FDRM.createReflector(FMatrixRMaj u, float gamma) Creates a reflector from the provided vector and gamma.
Q = I - γ u uTstatic FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_FDRM.diag(@Nullable FMatrixRMaj ret, int width, float... diagEl) static FMatrixRMajCreates a random diagonal matrix where the diagonal elements are selected from a uniform distribution that goes from min to max.static FMatrixRMajCreates a random matrix where all elements are zero but diagonal elements.static FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_FDRM.extract(FMatrixRMaj src, int[] indexes, int length, @Nullable FMatrixRMaj dst) Extracts the elements from the source matrix by their 1D index.static FMatrixRMajCommonOps_FDRM.extract(FMatrixRMaj src, int srcY0, int srcY1, int srcX0, int srcX1) Creates a new matrix which is the specified submatrix of 'src'static FMatrixRMajCommonOps_FDRM.extractColumn(FMatrixRMaj a, int column, @Nullable FMatrixRMaj out) Extracts the column from a matrix.static FMatrixRMajCommonOps_FDRM.extractDiag(FMatrixRMaj src, @Nullable FMatrixRMaj dst) Extracts the diagonal elements 'src' write it to the 'dst' vector.static FMatrixRMajCommonOps_FDRM.extractRow(FMatrixRMaj a, int row, @Nullable FMatrixRMaj out) Extracts the row from a matrix.static FMatrixRMajCommonOps_FDRM.identity(int width) Creates an identity matrix of the specified size.
aij = 0 if i ≠ j
aij = 1 if i = jstatic FMatrixRMajCommonOps_FDRM.identity(int numRows, int numCols) Creates a rectangular matrix which is zero except along the diagonals.static FMatrixRMajCommonOps_CDRM.imaginary(CMatrixD1 input, @Nullable FMatrixRMaj output) Places the imaginary component of the input matrix into the output matrix.static FMatrixRMajRandomMatrices_FDRM.insideSpan(FMatrixRMaj[] span, float min, float max, Random rand) Creates a random vector that is inside the specified span.static FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajSingularOps_FDRM.nullSpace(SingularValueDecomposition_F32<FMatrixRMaj> svd, @Nullable FMatrixRMaj nullSpace, float tol) Returns the null-space from the singular value decomposition.static FMatrixRMajSingularOps_FDRM.nullspaceQR(FMatrixRMaj A, int totalSingular) Computes the null space using QR decomposition.static FMatrixRMajSingularOps_FDRM.nullspaceQRP(FMatrixRMaj A, int totalSingular) Computes the null space using QRP decomposition.static FMatrixRMajSingularOps_FDRM.nullspaceSVD(FMatrixRMaj A, int totalSingular) Computes the null space using SVD.static FMatrixRMajSingularOps_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 FMatrixRMajRandomMatrices_FDRM.orthogonal(int numRows, int numCols, Random rand) Creates a random orthogonal or isometric matrix, depending on the number of rows and columns.static FMatrixRMajCommonOps_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 FMatrixRMajSpecializedOps_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 FMatrixRMajCommonOps_CDRM.real(CMatrixD1 input, @Nullable FMatrixRMaj output) Places the real component of the input matrix into the output matrix.static FMatrixRMajReturns a matrix where all the elements are selected independently from a uniform distribution between 'min' and 'max' inclusive.static FMatrixRMajReturns a matrix where all the elements are selected independently from a uniform distribution between 0 and 1 inclusive.static FMatrixRMajRandomMatrices_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 FMatrixRMajCommonOps_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 FMatrixRMajCreates 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 FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajCreates a random symmetric matrix whose values are selected from an uniform distribution from min to max, inclusive.static FMatrixRMajRandomMatrices_FDRM.symmetricPosDef(int width, Random rand) Creates a random symmetric positive definite matrix.static FMatrixRMajRandomMatrices_FDRM.symmetricWithEigenvalues(int num, Random rand, float... eigenvalues) Creates a new random symmetric matrix that will have the specified real eigenvalues.static FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajRandomMatrices_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 FMatrixRMajRandomMatrices_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.Methods in org.ejml.dense.row with parameters of type FMatrixRMajModifier and TypeMethodDescriptionstatic voidRandomMatrices_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 FMatrixRMajCommonOps_FDRM.apply(FMatrixRMaj input, FOperatorUnary func) static FMatrixRMajCommonOps_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 voidSingularOps_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 floatEigenOps_FDRM.computeEigenValue(FMatrixRMaj A, FMatrixRMaj eigenVector) Given matrix A and an eigen vector of A, compute the corresponding eigen value.static @Nullable FEigenpairEigenOps_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 FMatrixRMajCommonOps_FDRM.concatColumns(FMatrixRMaj a, FMatrixRMaj b, @Nullable FMatrixRMaj output) output = [a , b]static FMatrixRMajCommonOps_FDRM.concatColumnsMulti(FMatrixRMaj... m) Concatenates all the matrices together along their columns.static voidCommonOps_FDRM.concatRows(FMatrixRMaj a, FMatrixRMaj b, FMatrixRMaj output) output = [a ; b]static FMatrixRMajCommonOps_FDRM.concatRowsMulti(FMatrixRMaj... m) Concatenates all the matrices together along their columns.static floatNormOps_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 floatNormOps_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 FMatrixRMajSpecializedOps_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 FMatrixRMajSpecializedOps_FDRM.copyTriangle(FMatrixRMaj src, @Nullable FMatrixRMaj dst, boolean upper) Copies just the upper or lower triangular portion of a matrix.static intMatrixFeatures_FDRM.countNonZero(FMatrixRMaj A) Counts the number of elements in A which are not zero.static FMatrixRMajSpecializedOps_FDRM.createReflector(FMatrixRMaj u, float gamma) Creates a reflector from the provided vector and gamma.
Q = I - γ u uTstatic voidSingularOps_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 voidSingularOps_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 floatCommonOps_FDRM.det(FMatrixRMaj mat) Returns the determinant of the matrix.static FMatrixRMajCommonOps_FDRM.diag(@Nullable FMatrixRMaj ret, int width, float... diagEl) static voidCommonOps_FDRM.divideCols(FMatrixRMaj A, float[] values) Divides every element in column i by value[i].static voidCommonOps_FDRM.divideRows(float[] values, FMatrixRMaj A) Divides every element in row i by value[i].static voidCommonOps_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 FEigenpairEigenOps_FDRM.dominantEigenpair(FMatrixRMaj A) Computes the dominant eigen vector for a matrix.static BMatrixRMajCommonOps_FDRM.elementBoolean(FMatrixRMaj input, DElementCoorBoolean func, @Nullable BMatrixRMaj output) Applies a binary operator to even element in the input matrix.static BMatrixRMajCommonOps_FDRM.elementLessThan(FMatrixRMaj A, float value, @Nullable BMatrixRMaj output) Applies the > operator to each element in A.static BMatrixRMajCommonOps_FDRM.elementLessThan(FMatrixRMaj A, FMatrixRMaj B, @Nullable BMatrixRMaj output) Applies the < operator to each element in A.static BMatrixRMajCommonOps_FDRM.elementLessThanOrEqual(FMatrixRMaj A, float value, @Nullable BMatrixRMaj output) Applies the ≥ operator to each element in A.static BMatrixRMajCommonOps_FDRM.elementLessThanOrEqual(FMatrixRMaj A, FMatrixRMaj B, @Nullable BMatrixRMaj output) Applies the A ≤ B operator to each element.static BMatrixRMajCommonOps_FDRM.elementMoreThan(FMatrixRMaj A, float value, @Nullable BMatrixRMaj output) Applies the > operator to each element in A.static BMatrixRMajCommonOps_FDRM.elementMoreThanOrEqual(FMatrixRMaj A, float value, @Nullable BMatrixRMaj output) Applies the ≥ operator to each element in A.static FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_FDRM.extract(FMatrixRMaj src, int[] indexes, int length, @Nullable FMatrixRMaj dst) Extracts the elements from the source matrix by their 1D index.static FMatrixRMajCommonOps_FDRM.extract(FMatrixRMaj src, int srcY0, int srcY1, int srcX0, int srcX1) Creates a new matrix which is the specified submatrix of 'src'static FMatrixRMajCommonOps_FDRM.extractColumn(FMatrixRMaj a, int column, @Nullable FMatrixRMaj out) Extracts the column from a matrix.static FMatrixRMajCommonOps_FDRM.extractDiag(FMatrixRMaj src, @Nullable FMatrixRMaj dst) Extracts the diagonal elements 'src' write it to the 'dst' vector.static FMatrixRMajCommonOps_FDRM.extractRow(FMatrixRMaj a, int row, @Nullable FMatrixRMaj out) Extracts the row from a matrix.static floatNormOps_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 floatNormOps_FDRM.fastNormP2(FMatrixRMaj A) Computes the p=2 norm.static voidRandomMatrices_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 FMatrixRMajCommonOps_CDRM.imaginary(CMatrixD1 input, @Nullable FMatrixRMaj output) Places the imaginary component of the input matrix into the output matrix.static floatNormOps_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 floatNormOps_FDRM.inducedP2(FMatrixRMaj A) Computes the induced p = 2 matrix norm, which is the largest singular value.static floatNormOps_FDRM.inducedPInf(FMatrixRMaj A) Induced matrix p = infinity norm.
||A||∞ = max(i=1 to m; sum(j=1 to n; |aij|))static voidCommonOps_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 FMatrixRMajRandomMatrices_FDRM.insideSpan(FMatrixRMaj[] span, float min, float max, Random rand) Creates a random vector that is inside the specified span.static booleanCommonOps_FDRM.invert(FMatrixRMaj mat) Performs a matrix inversion operation on the specified matrix and stores the results in the same matrix.
a = a-1static booleanCommonOps_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 booleanCovarianceOps_FDRM.invert(FMatrixRMaj cov) Performs a matrix inversion operations that takes advantage of the special properties of a covariance matrix.static booleanCovarianceOps_FDRM.invert(FMatrixRMaj cov, FMatrixRMaj cov_inv) Performs a matrix inversion operations that takes advantage of the special properties of a covariance matrix.static booleanCommonOps_FDRM.invertSPD(FMatrixRMaj mat, FMatrixRMaj result) Matrix inverse for symmetric positive definite matrices.static booleanMatrixFeatures_FDRM.isConstantVal(FMatrixRMaj mat, float val, float tol) Checks to see if every value in the matrix is the specified value.static booleanMatrixFeatures_FDRM.isDiagonalNotNegative(FMatrixRMaj a) Checks to see if diagonal element are all not negative, i.e.static booleanMatrixFeatures_FDRM.isDiagonalPositive(FMatrixRMaj a) Checks to see if all the diagonal elements in the matrix are positive.static booleanMatrixFeatures_FDRM.isIdentity(FMatrixRMaj mat, float tol) Checks to see if the provided matrix is within tolerance to an identity matrix.static booleanMatrixFeatures_FDRM.isInverse(FMatrixRMaj a, FMatrixRMaj b, float tol) Checks to see if the two matrices are inverses of each other.static booleanMatrixFeatures_FDRM.isLowerTriangle(FMatrixRMaj A, int hessenberg, float tol) Checks to see if a matrix is lower triangular or Hessenberg.static booleanMatrixFeatures_FDRM.isOrthogonal(FMatrixRMaj Q, float tol) Checks to see if a matrix is orthogonal or isometric.static booleanMatrixFeatures_FDRM.isPositiveDefinite(FMatrixRMaj A) Checks to see if the matrix is positive definite.static booleanMatrixFeatures_FDRM.isPositiveSemidefinite(FMatrixRMaj A) Checks to see if the matrix is positive semidefinite:static booleanMatrixFeatures_FDRM.isRowsLinearIndependent(FMatrixRMaj A) Checks to see if the rows of the provided matrix are linearly independent.static booleanMatrixFeatures_FDRM.isSkewSymmetric(FMatrixRMaj A, float tol) Checks to see if a matrix is skew symmetric with in tolerance:
-A = AT
or
|aij + aji| ≤ tolstatic booleanMatrixFeatures_FDRM.isSymmetric(FMatrixRMaj m) Returns true if the matrix is perfectly symmetric.static booleanMatrixFeatures_FDRM.isSymmetric(FMatrixRMaj m, float tol) Returns true if the matrix is symmetric within the tolerance.static booleanMatrixFeatures_FDRM.isUpperTriangle(FMatrixRMaj A, int hessenberg, float tol) Checks to see if a matrix is upper triangular or Hessenberg.static intCovarianceOps_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 booleanCovarianceOps_FDRM.isValidFast(FMatrixRMaj cov) This is a fairly light weight check to see of a covariance matrix is valid.static FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 voidCommonOps_FDRM.multCols(FMatrixRMaj A, float[] values) Multiplies every element in column i by value[i].static voidSpecializedOps_FDRM.multLowerTranA(FMatrixRMaj mat) Performs L = LT*Lstatic voidSpecializedOps_FDRM.multLowerTranB(FMatrixRMaj mat) Performs L = L*LTstatic voidCommonOps_FDRM.multRows(float[] values, FMatrixRMaj A) Multiplies every element in row i by value[i].voidCovarianceRandomDraw_FDRM.next(FMatrixRMaj x) Makes a draw on the distribution.static voidNormOps_FDRM.normalizeF(FMatrixRMaj A) Normalizes the matrix such that the Frobenius norm is equal to one.static floatNormOps_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 floatNormOps_FDRM.normP1(FMatrixRMaj A) Computes the p=1 norm.static floatNormOps_FDRM.normP2(FMatrixRMaj A) Computes the p=2 norm.static floatNormOps_FDRM.normPInf(FMatrixRMaj A) Computes the p=∞ norm.static intMatrixFeatures_FDRM.nullity(FMatrixRMaj A) Computes the nullity of a matrix using the default tolerance.static intMatrixFeatures_FDRM.nullity(FMatrixRMaj A, float threshold) Computes the nullity of a matrix using the specified tolerance.static intSingularOps_FDRM.nullity(FMatrixRMaj A, float threshold) Returns the matrix's nullitystatic FMatrixRMajSingularOps_FDRM.nullSpace(SingularValueDecomposition_F32<FMatrixRMaj> svd, @Nullable FMatrixRMaj nullSpace, float tol) Returns the null-space from the singular value decomposition.static FMatrixRMajSingularOps_FDRM.nullspaceQR(FMatrixRMaj A, int totalSingular) Computes the null space using QR decomposition.static FMatrixRMajSingularOps_FDRM.nullspaceQRP(FMatrixRMaj A, int totalSingular) Computes the null space using QRP decomposition.static FMatrixRMajSingularOps_FDRM.nullspaceSVD(FMatrixRMaj A, int totalSingular) Computes the null space using SVD.static FMatrixRMajSingularOps_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 FMatrixRMajCommonOps_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 voidCommonOps_FDRM.pinv(FMatrixRMaj A, FMatrixRMaj invA) Computes the Moore-Penrose pseudo-inverse:
pinv(A) = (ATA)-1 AT
or
pinv(A) = AT(AAT)-1static FMatrixRMajSpecializedOps_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 voidCovarianceOps_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 intMatrixFeatures_FDRM.rank(FMatrixRMaj A) Computes the rank of a matrix using a default tolerance.static intMatrixFeatures_FDRM.rank(FMatrixRMaj A, float threshold) Computes the rank of a matrix using the specified tolerance.static intSingularOps_FDRM.rank(FMatrixRMaj A) Returns the matrix's rank.static intSingularOps_FDRM.rank(FMatrixRMaj A, float threshold) Returns the matrix's rankstatic FMatrixRMajCommonOps_CDRM.real(CMatrixD1 input, @Nullable FMatrixRMaj output) Places the real component of the input matrix into the output matrix.static voidCommonOps_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 FMatrixRMajCommonOps_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 voidCommonOps_FDRM.scaleCol(float alpha, FMatrixRMaj A, int col) In-place scaling of a column in Astatic voidCommonOps_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 booleanCommonOps_FDRM.solve(FMatrixRMaj a, FMatrixRMaj b, FMatrixRMaj x) Solves for x in the following equation:
A*x = bstatic booleanCommonOps_FDRM.solveSPD(FMatrixRMaj A, FMatrixRMaj b, FMatrixRMaj x) Linear solver for systems which are symmetric positive definite.
A*x = bstatic FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 booleanSingularOps_FDRM.svd(FMatrixRMaj A, @Nullable FMatrixRMaj U, FGrowArray sv, @Nullable FMatrixRMaj Vt) Computes the SVD and sorts singular values in descending order.static voidRandomMatrices_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 voidCommonOps_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 voidCommonOps_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 voidCommonOps_FDRM.transpose(FMatrixRMaj mat) Performs an "in-place" transpose.static FMatrixRMajCommonOps_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 voidCommonOps_MT_FDRM.transpose(FMatrixRMaj mat) Performs an "in-place" transpose.static FMatrixRMajCommonOps_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'.Method parameters in org.ejml.dense.row with type arguments of type FMatrixRMajModifier and TypeMethodDescriptionstatic FMatrixRMajEigenOps_FDRM.createMatrixV(EigenDecomposition_F32<FMatrixRMaj> eig) Puts all the real eigenvectors into the columns of a matrix.static FMatrixRMajSingularOps_FDRM.nullSpace(SingularValueDecomposition_F32<FMatrixRMaj> svd, @Nullable FMatrixRMaj nullSpace, float tol) Returns the null-space from the singular value decomposition.static FMatrixRMajSingularOps_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.Constructors in org.ejml.dense.row with parameters of type FMatrixRMajModifierConstructorDescriptionCovarianceRandomDraw_FDRM(Random rand, FMatrixRMaj cov) Creates a random distribution with the specified mean and covariance. -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition
Methods in org.ejml.dense.row.decomposition that return FMatrixRMajModifier and TypeMethodDescriptionstatic FMatrixRMajUtilDecompositons_FDRM.checkZerosLT(@Nullable FMatrixRMaj A, int numRows, int numCols) Creates a zeros matrix only if A does not already exist.static FMatrixRMajUtilDecompositons_FDRM.checkZerosUT(@Nullable FMatrixRMaj A, int numRows, int numCols) Creates a zeros matrix only if A does not already exist.static FMatrixRMajUtilDecompositons_FDRM.ensureIdentity(@Nullable FMatrixRMaj A, int numRows, int numCols) static FMatrixRMajUtilDecompositons_FDRM.ensureZeros(@Nullable FMatrixRMaj A, int numRows, int numCols) Methods in org.ejml.dense.row.decomposition with parameters of type FMatrixRMajModifier and TypeMethodDescriptionstatic FMatrixRMajUtilDecompositons_FDRM.checkZerosLT(@Nullable FMatrixRMaj A, int numRows, int numCols) Creates a zeros matrix only if A does not already exist.static FMatrixRMajUtilDecompositons_FDRM.checkZerosUT(@Nullable FMatrixRMaj A, int numRows, int numCols) Creates a zeros matrix only if A does not already exist.booleanBaseDecomposition_FDRB_to_FDRM.decompose(FMatrixRMaj A) static FMatrixRMajUtilDecompositons_FDRM.ensureIdentity(@Nullable FMatrixRMaj A, int numRows, int numCols) static FMatrixRMajUtilDecompositons_FDRM.ensureZeros(@Nullable FMatrixRMaj A, int numRows, int numCols) -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition.bidiagonal
Methods in org.ejml.dense.row.decomposition.bidiagonal that return FMatrixRMajModifier 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 FMatrixRMajBidiagonalDecompositionRow_FDRM.handleB(@Nullable FMatrixRMaj B, boolean compact, int m, int n, int min) static FMatrixRMajBidiagonalDecompositionRow_FDRM.handleU(@Nullable FMatrixRMaj U, boolean transpose, boolean compact, int m, int n, int min) static FMatrixRMajBidiagonalDecompositionRow_FDRM.handleV(@Nullable FMatrixRMaj V, boolean transpose, boolean compact, int m, int n, int min) Methods in org.ejml.dense.row.decomposition.bidiagonal with parameters of type FMatrixRMajModifier and TypeMethodDescriptionbooleanBidiagonalDecompositionRow_FDRM.decompose(FMatrixRMaj A) Computes the decomposition of the provided matrix.booleanBidiagonalDecompositionTall_FDRM.decompose(FMatrixRMaj orig) booleanBidiagonalDecompositionTall_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 FMatrixRMajBidiagonalDecompositionRow_FDRM.handleB(@Nullable FMatrixRMaj B, boolean compact, int m, int n, int min) static FMatrixRMajBidiagonalDecompositionRow_FDRM.handleU(@Nullable FMatrixRMaj U, boolean transpose, boolean compact, int m, int n, int min) static FMatrixRMajBidiagonalDecompositionRow_FDRM.handleV(@Nullable FMatrixRMaj V, boolean transpose, boolean compact, int m, int n, int min) protected voidBidiagonalDecompositionRow_FDRM.init(FMatrixRMaj A) Sets up internal data structures and creates a copy of the input matrix.protected voidBidiagonalDecompositionRow_FDRM.rank1UpdateMultL(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected voidBidiagonalDecompositionRow_MT_FDRM.rank1UpdateMultL(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected voidBidiagonalDecompositionRow_FDRM.rank1UpdateMultR(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected voidBidiagonalDecompositionRow_MT_FDRM.rank1UpdateMultR(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition.chol
Fields in org.ejml.dense.row.decomposition.chol declared as FMatrixRMajMethods in org.ejml.dense.row.decomposition.chol that return FMatrixRMajModifier 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) Methods in org.ejml.dense.row.decomposition.chol with parameters of type FMatrixRMajModifier and TypeMethodDescriptionbooleanCholeskyDecompositionCommon_FDRM.decompose(FMatrixRMaj mat) Performs Choleksy decomposition on the provided matrix.booleanCholeskyDecompositionLDL_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) voidCholeskyDecompositionBlock_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.voidCholeskyDecompositionBlock_MT_FDRM.solveL_special(float[] L, FMatrixRMaj b_src, int indexSrc, int indexDst, FMatrixRMaj B) voidCholeskyDecompositionBlock_FDRM.symmRankTranA_sub(FMatrixRMaj a, FMatrixRMaj c, int startIndexC) Performs this operation:
c = c - aTa
where c is a submatrix.voidCholeskyDecompositionBlock_MT_FDRM.symmRankTranA_sub(FMatrixRMaj a, FMatrixRMaj c, int startIndexC) -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition.eig
Methods in org.ejml.dense.row.decomposition.eig that return FMatrixRMajModifier and TypeMethodDescriptionEigenPowerMethod_FDRM.getEigenVector()SwitchingEigenDecomposition_FDRM.getEigenVector(int index) SymmetricQRAlgorithmDecomposition_FDRM.getEigenVector(int index) WatchedDoubleStepQRDecomposition_FDRM.getEigenVector(int index) Methods in org.ejml.dense.row.decomposition.eig with parameters of type FMatrixRMajModifier and TypeMethodDescriptionbooleanEigenPowerMethod_FDRM.computeDirect(FMatrixRMaj A) This method computes the eigen vector with the largest eigen value by using the direct power method.booleanEigenPowerMethod_FDRM.computeShiftDirect(FMatrixRMaj A, float alpha) Computes the most dominant eigen vector of A using a shifted matrix.booleanEigenPowerMethod_FDRM.computeShiftInvert(FMatrixRMaj A, float alpha) Computes the most dominant eigen vector of A using an inverted shifted matrix.booleanSwitchingEigenDecomposition_FDRM.decompose(FMatrixRMaj orig) booleanSymmetricQRAlgorithmDecomposition_FDRM.decompose(FMatrixRMaj orig) Decomposes the matrix using the QR algorithm.booleanWatchedDoubleStepQRDecomposition_FDRM.decompose(FMatrixRMaj A) booleanEigenvalueExtractor_FDRM.process(FMatrixRMaj A) voidEigenPowerMethod_FDRM.setSeed(FMatrixRMaj seed) Sets the value of the vector to use in the start of the iterations.Constructor parameters in org.ejml.dense.row.decomposition.eig with type arguments of type FMatrixRMajModifierConstructorDescriptionSwitchingEigenDecomposition_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
Fields in org.ejml.dense.row.decomposition.eig.symm declared as FMatrixRMajMethods in org.ejml.dense.row.decomposition.eig.symm that return FMatrixRMajMethods in org.ejml.dense.row.decomposition.eig.symm with parameters of type FMatrixRMajModifier and TypeMethodDescriptionvoidSymmetricQrAlgorithm_FDRM.setQ(@Nullable FMatrixRMaj q) voidSymmetricQREigenHelper_FDRM.setQ(FMatrixRMaj q) -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition.eig.watched
Fields in org.ejml.dense.row.decomposition.eig.watched declared as FMatrixRMajModifier and TypeFieldDescriptionprotected FMatrixRMajWatchedDoubleStepQREigen_FDRM._temp@Nullable FMatrixRMajWatchedDoubleStepQREigen_FDRM.Qprotected FMatrixRMajWatchedDoubleStepQREigen_FDRM.uMethods in org.ejml.dense.row.decomposition.eig.watched that return FMatrixRMajModifier and TypeMethodDescriptionWatchedDoubleStepQREigenvector_FDRM.getEigenvectors()WatchedDoubleStepQREigenvector_FDRM.getQ()Methods in org.ejml.dense.row.decomposition.eig.watched with parameters of type FMatrixRMajModifier and TypeMethodDescriptionbooleanWatchedDoubleStepQREigenvector_FDRM.extractVectors(FMatrixRMaj Q_h) booleanWatchedDoubleStepQREigenvalue_FDRM.process(FMatrixRMaj origA) booleanWatchedDoubleStepQREigenvector_FDRM.process(WatchedDoubleStepQREigen_FDRM implicit, FMatrixRMaj A, FMatrixRMaj Q_h) protected voidWatchedDoubleStepQREigen_FDRM.rank1UpdateMultL(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected voidWatchedDoubleStepQREigen_MT_FDRM.rank1UpdateMultL(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected voidWatchedDoubleStepQREigen_FDRM.rank1UpdateMultR(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected voidWatchedDoubleStepQREigen_MT_FDRM.rank1UpdateMultR(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) voidWatchedDoubleStepQREigen_FDRM.setQ(@Nullable FMatrixRMaj Q) voidWatchedDoubleStepQREigen_FDRM.setup(FMatrixRMaj A) voidWatchedDoubleStepQREigenvalue_FDRM.setup(FMatrixRMaj A) -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition.hessenberg
Fields in org.ejml.dense.row.decomposition.hessenberg declared as FMatrixRMajModifier and TypeFieldDescriptionprotected FMatrixRMajTridiagonalDecompositionHouseholder_FDRM.QTOnly the upper right triangle is used.Methods in org.ejml.dense.row.decomposition.hessenberg that return FMatrixRMajModifier 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.Methods in org.ejml.dense.row.decomposition.hessenberg with parameters of type FMatrixRMajModifier and TypeMethodDescriptionbooleanHessenbergSimilarDecomposition_FDRM.decompose(FMatrixRMaj A) Computes the decomposition of the provided matrix.booleanTridiagonalDecompositionHouseholder_FDRM.decompose(FMatrixRMaj A) Decomposes the provided symmetric matrix.voidTridiagonalDecompositionHouseholderOrig_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.voidTridiagonalDecompositionHouseholder_FDRM.init(FMatrixRMaj A) If needed declares and sets up internal data structures.voidTridiagonalDecompositionHouseholderOrig_FDRM.init(FMatrixRMaj A) If needed declares and sets up internal data structures.protected voidHessenbergSimilarDecomposition_FDRM.rank1UpdateMultL(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected voidHessenbergSimilarDecomposition_MT_FDRM.rank1UpdateMultL(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected voidTridiagonalDecompositionHouseholder_FDRM.rank1UpdateMultL(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected voidTridiagonalDecompositionHouseholder_MT_FDRM.rank1UpdateMultL(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected voidHessenbergSimilarDecomposition_FDRM.rank1UpdateMultR(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected voidHessenbergSimilarDecomposition_MT_FDRM.rank1UpdateMultR(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected voidTridiagonalDecompositionHouseholder_FDRM.rank1UpdateMultR(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) protected voidTridiagonalDecompositionHouseholder_MT_FDRM.rank1UpdateMultR(FMatrixRMaj A, float gamma, int colA0, int w0, int w1) -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition.lu
Fields in org.ejml.dense.row.decomposition.lu declared as FMatrixRMajMethods in org.ejml.dense.row.decomposition.lu that return FMatrixRMajModifier 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.Methods in org.ejml.dense.row.decomposition.lu with parameters of type FMatrixRMajModifier and TypeMethodDescriptionbooleanLUDecompositionAlt_FDRM.decompose(FMatrixRMaj a) This is a modified version of what was found in the JAMA package.protected voidLUDecompositionBase_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
Fields in org.ejml.dense.row.decomposition.qr declared as FMatrixRMajModifier and TypeFieldDescriptionprotected FMatrixRMajQRDecompositionHouseholder_FDRM.QRWhere the Q and R matrices are stored.protected FMatrixRMajQRDecompositionHouseholderTran_FDRM.QRWhere the Q and R matrices are stored.Methods in org.ejml.dense.row.decomposition.qr that return FMatrixRMajModifier 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()Methods in org.ejml.dense.row.decomposition.qr with parameters of type FMatrixRMajModifier and TypeMethodDescriptionvoidQrUpdate_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.voidQRDecompositionHouseholderTran_FDRM.applyQ(FMatrixRMaj A) A = Q*AvoidQRDecompositionHouseholderTran_FDRM.applyTranQ(FMatrixRMaj A) A = QT*Aprotected voidQRDecompositionHouseholder_FDRM.commonSetup(FMatrixRMaj A) This function performs sanity check on the input for decompose and sets up the QR matrix.protected voidQRDecompositionHouseholderColumn_FDRM.convertToColumnMajor(FMatrixRMaj A) Converts the standard row-major matrix into a column-major vector that is advantageous for this problem.booleanQRColPivDecompositionHouseholderColumn_FDRM.decompose(FMatrixRMaj A) To decompose the matrix 'A' it must have full rank.booleanQRDecompositionHouseholder_FDRM.decompose(FMatrixRMaj A) In order to decompose the matrix 'A' it must have full rank.booleanQRDecompositionHouseholderColumn_FDRM.decompose(FMatrixRMaj A) To decompose the matrix 'A' it must have full rank.booleanQRDecompositionHouseholderTran_FDRM.decompose(FMatrixRMaj A) To decompose the matrix 'A' it must have full rank.voidQrUpdate_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 voidQrHelperFunctions_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 voidQrHelperFunctions_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 voidQrHelperFunctions_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 voidQrHelperFunctions_FDRM.rank1UpdateMultR(FMatrixRMaj A, float[] u, int offsetU, float gamma, int colA0, int w0, int w1, float[] _temp) static voidQrHelperFunctions_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 voidQrHelperFunctions_MT_FDRM.rank1UpdateMultR(FMatrixRMaj A, float[] u, int offsetU, float gamma, int colA0, int w0, int w1, float[] _temp) static voidQrHelperFunctions_FDRM.rank1UpdateMultR_u0(FMatrixRMaj A, float[] u, float u_0, float gamma, int colA0, int w0, int w1, float[] _temp) static voidQrHelperFunctions_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
Fields in org.ejml.dense.row.decomposition.svd with type parameters of type FMatrixRMajModifier and TypeFieldDescriptionprotected BidiagonalDecomposition_F32<FMatrixRMaj>SvdImplicitQrDecompose_FDRM.bidiagMethods in org.ejml.dense.row.decomposition.svd that return FMatrixRMajModifier 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) Methods in org.ejml.dense.row.decomposition.svd with parameters of type FMatrixRMajModifier and TypeMethodDescriptionbooleanSafeSvd_FDRM.decompose(FMatrixRMaj orig) booleanSvdImplicitQrDecompose_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 voidSvdImplicitQrDecompose_FDRM.transpose(@NotNull FMatrixRMaj V, FMatrixRMaj Vt) protected voidSvdImplicitQrDecompose_MT_FDRM.transpose(@NotNull FMatrixRMaj V, FMatrixRMaj Vt) Constructor parameters in org.ejml.dense.row.decomposition.svd with type arguments of type FMatrixRMaj -
Uses of FMatrixRMaj in org.ejml.dense.row.decomposition.svd.implicitqr
Fields in org.ejml.dense.row.decomposition.svd.implicitqr declared as FMatrixRMajModifier and TypeFieldDescriptionprotected @Nullable FMatrixRMajSvdImplicitQrAlgorithm_FDRM.Utprotected @Nullable FMatrixRMajSvdImplicitQrAlgorithm_FDRM.VtMethods in org.ejml.dense.row.decomposition.svd.implicitqr that return FMatrixRMajModifier and TypeMethodDescription@Nullable FMatrixRMajSvdImplicitQrAlgorithm_FDRM.getUt()@Nullable FMatrixRMajSvdImplicitQrAlgorithm_FDRM.getVt()Methods in org.ejml.dense.row.decomposition.svd.implicitqr with parameters of type FMatrixRMajModifier and TypeMethodDescriptionvoidSvdImplicitQrAlgorithm_FDRM.setUt(@Nullable FMatrixRMaj ut) voidSvdImplicitQrAlgorithm_FDRM.setVt(@Nullable FMatrixRMaj vt) protected voidSvdImplicitQrAlgorithm_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
Methods in org.ejml.dense.row.factory that return types with arguments of type FMatrixRMajModifier and TypeMethodDescriptionstatic CholeskyDecomposition_F32<FMatrixRMaj>DecompositionFactory_FDRM.chol(boolean lower) Returns aCholeskyDecomposition_F32that isn't specialized for any specific matrix size.static CholeskyDecomposition_F32<FMatrixRMaj>DecompositionFactory_FDRM.chol(int matrixSize, boolean lower) Returns aCholeskyDecomposition_F32that has been optimized for the specified matrix size.static CholeskyDecomposition_F32<FMatrixRMaj>DecompositionFactory_MT_FDRM.chol(boolean lower) Returns aCholeskyDecomposition_F32that isn't specialized for any specific matrix size.static CholeskyDecomposition_F32<FMatrixRMaj>DecompositionFactory_MT_FDRM.chol(int matrixSize, boolean lower) Returns aCholeskyDecomposition_F32that 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_FDRMthat 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 anEigenDecompositionthat has been optimized for the specified matrix size.static EigenDecomposition_F32<FMatrixRMaj>DecompositionFactory_FDRM.eig(int matrixSize, boolean computeVectors, boolean isSymmetric) Returns anEigenDecompositionwhich 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 anEigenDecompositionthat has been optimized for the specified matrix size.static EigenDecomposition_F32<FMatrixRMaj>DecompositionFactory_MT_FDRM.eig(int matrixSize, boolean computeVectors, boolean isSymmetric) Returns anEigenDecompositionwhich 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 aLUDecompositionthat 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 aQRDecompositionthat 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 aQRDecompositionthat 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_F32that 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 aSingularValueDecompositionthat is NOT optimized for any specified matrix size.DecompositionFactory_FDRM.svd(int numRows, int numCols, boolean needU, boolean needV, boolean compact) Returns aSingularValueDecompositionthat has been optimized for the specified matrix size.DecompositionFactory_MT_FDRM.svd(boolean needU, boolean needV, boolean compact) Returns aSingularValueDecompositionthat is NOT optimized for any specified matrix size.DecompositionFactory_MT_FDRM.svd(int numRows, int numCols, boolean needU, boolean needV, boolean compact) Returns aSingularValueDecompositionthat 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.Methods in org.ejml.dense.row.factory with parameters of type FMatrixRMajModifier and TypeMethodDescriptionstatic floatDecompositionFactory_FDRM.quality(FMatrixRMaj orig, FMatrixRMaj U, FMatrixRMaj W, FMatrixRMaj Vt) static floatDecompositionFactory_FDRM.quality(FMatrixRMaj orig, EigenDecomposition_F32<FMatrixRMaj> eig) Computes a metric which measures the the quality of an eigen value decomposition.static floatDecompositionFactory_FDRM.quality(FMatrixRMaj orig, SingularValueDecomposition<FMatrixRMaj> svd) Computes a metric which measures the the quality of a singular value decomposition.Method parameters in org.ejml.dense.row.factory with type arguments of type FMatrixRMajModifier and TypeMethodDescriptionstatic floatDecompositionFactory_FDRM.quality(FMatrixRMaj orig, EigenDecomposition_F32<FMatrixRMaj> eig) Computes a metric which measures the the quality of an eigen value decomposition.static floatDecompositionFactory_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
Fields in org.ejml.dense.row.linsol declared as FMatrixRMajMethods in org.ejml.dense.row.linsol that return FMatrixRMajMethods in org.ejml.dense.row.linsol with parameters of type FMatrixRMajModifier and TypeMethodDescriptionprotected voidLinearSolverAbstract_FDRM._setA(FMatrixRMaj A) static voidInvertUsingSolve_FDRM.invert(LinearSolverDense<FMatrixRMaj> solver, FMatrix1Row A, FMatrixRMaj A_inv) static voidInvertUsingSolve_FDRM.invert(LinearSolverDense<FMatrixRMaj> solver, FMatrix1Row A, FMatrixRMaj A_inv, FMatrixRMaj storage) voidLinearSolver_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.voidLinearSolverAbstract_FDRM.invert(FMatrixRMaj A_inv) voidLinearSolverUnrolled_FDRM.invert(FMatrixRMaj A_inv) booleanLinearSolver_FDRB_to_FDRM.setA(FMatrixRMaj A) Converts 'A' into a block matrix and call setA() on the block matrix solver.booleanLinearSolverUnrolled_FDRM.setA(FMatrixRMaj A) voidLinearSolver_FDRB_to_FDRM.solve(FMatrixRMaj B, FMatrixRMaj X) Converts B and X into block matrices and calls the block matrix solve routine.voidLinearSolverUnrolled_FDRM.solve(FMatrixRMaj B, FMatrixRMaj X) Method parameters in org.ejml.dense.row.linsol with type arguments of type FMatrixRMajModifier and TypeMethodDescriptionstatic voidInvertUsingSolve_FDRM.invert(LinearSolverDense<FMatrixRMaj> solver, FMatrix1Row A, FMatrixRMaj A_inv) static voidInvertUsingSolve_FDRM.invert(LinearSolverDense<FMatrixRMaj> solver, FMatrix1Row A, FMatrixRMaj A_inv, FMatrixRMaj storage) -
Uses of FMatrixRMaj in org.ejml.dense.row.linsol.chol
Methods in org.ejml.dense.row.linsol.chol that return types with arguments of type FMatrixRMajModifier and TypeMethodDescriptionLinearSolverChol_FDRM.getDecomposition()LinearSolverCholLDL_FDRM.getDecomposition()Methods in org.ejml.dense.row.linsol.chol with parameters of type FMatrixRMajModifier and TypeMethodDescriptionvoidLinearSolverChol_FDRM.invert(FMatrixRMaj inv) Sets the matrix 'inv' equal to the inverse of the matrix that was decomposed.voidLinearSolverCholLDL_FDRM.invert(FMatrixRMaj inv) Sets the matrix 'inv' equal to the inverse of the matrix that was decomposed.booleanLinearSolverChol_FDRM.setA(FMatrixRMaj A) booleanLinearSolverCholLDL_FDRM.setA(FMatrixRMaj A) voidLinearSolverChol_FDRB.solve(FMatrixRMaj B, FMatrixRMaj X) Only converts the B matrix and passes that onto solve.voidLinearSolverChol_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.voidLinearSolverCholLDL_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 voidLinearSolverChol_FDRM.solveLower(FMatrixRMaj L, FMatrixRMaj B, FMatrixRMaj X, float[] vv) -
Uses of FMatrixRMaj in org.ejml.dense.row.linsol.lu
Methods in org.ejml.dense.row.linsol.lu with parameters of type FMatrixRMajModifier and TypeMethodDescriptionvoidLinearSolverLuBase_FDRM.improveSol(FMatrixRMaj b, FMatrixRMaj x) This attempts to improve upon the solution generated by account for numerical imprecisions.voidLinearSolverLuBase_FDRM.invert(FMatrixRMaj A_inv) booleanLinearSolverLuBase_FDRM.setA(FMatrixRMaj A) booleanLinearSolverLuKJI_FDRM.setA(FMatrixRMaj A) voidLinearSolverLu_FDRM.solve(FMatrixRMaj B, FMatrixRMaj X) voidLinearSolverLuKJI_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
Fields in org.ejml.dense.row.linsol.qr declared as FMatrixRMajModifier and TypeFieldDescriptionprotected final FMatrixRMajLinearSolverQrHouseCol_FDRM.aprotected FMatrixRMajBaseLinearSolverQrp_FDRM.Iprotected FMatrixRMajLinearSolverQr_FDRM.Qprotected FMatrixRMajBaseLinearSolverQrp_FDRM.Rprotected FMatrixRMajLinearSolverQr_FDRM.Rprotected final FMatrixRMajLinearSolverQrHouseCol_FDRM.Rprotected FMatrixRMajBaseLinearSolverQrp_FDRM.R11protected final FMatrixRMajLinearSolverQrHouseCol_FDRM.tempprotected FMatrixRMajBaseLinearSolverQrp_FDRM.YFields in org.ejml.dense.row.linsol.qr with type parameters of type FMatrixRMajModifier and TypeFieldDescriptionprotected LinearSolverDense<FMatrixRMaj>BaseLinearSolverQrp_FDRM.internalSolverMethods in org.ejml.dense.row.linsol.qr that return FMatrixRMajModifier 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()Methods in org.ejml.dense.row.linsol.qr that return types with arguments of type FMatrixRMajModifier and TypeMethodDescriptionLinearSolverQr_FDRM.getDecomposer()BaseLinearSolverQrp_FDRM.getDecomposition()LinearSolverQr_FDRM.getDecomposition()LinearSolverQrHouse_FDRM.getDecomposition()LinearSolverQrHouseCol_FDRM.getDecomposition()LinearSolverQrHouseTran_FDRM.getDecomposition()Methods in org.ejml.dense.row.linsol.qr with parameters of type FMatrixRMajModifier and TypeMethodDescriptionvoidBaseLinearSolverQrp_FDRM.invert(FMatrixRMaj A_inv) booleanSolveNullSpaceQR_FDRM.process(FMatrixRMaj A, int numSingularValues, FMatrixRMaj nullspace) Finds the null space of AbooleanSolveNullSpaceQRP_FDRM.process(FMatrixRMaj A, int numSingularValues, FMatrixRMaj nullspace) Finds the null space of AbooleanBaseLinearSolverQrp_FDRM.setA(FMatrixRMaj A) booleanLinearSolverQr_FDRM.setA(FMatrixRMaj A) Performs QR decomposition on AbooleanLinearSolverQrHouse_FDRM.setA(FMatrixRMaj A) Performs QR decomposition on AbooleanLinearSolverQrHouseCol_FDRM.setA(FMatrixRMaj A) Performs QR decomposition on AbooleanLinearSolverQrHouseTran_FDRM.setA(FMatrixRMaj A) Performs QR decomposition on AbooleanSolvePseudoInverseQrp_FDRM.setA(FMatrixRMaj A) voidLinearSolverQr_FDRM.solve(FMatrixRMaj B, FMatrixRMaj X) Solves for X using the QR decomposition.voidLinearSolverQrHouse_FDRM.solve(FMatrixRMaj B, FMatrixRMaj X) Solves for X using the QR decomposition.voidLinearSolverQrHouseCol_FDRM.solve(FMatrixRMaj B, FMatrixRMaj X) Solves for X using the QR decomposition.voidLinearSolverQrHouseCol_MT_FDRM.solve(FMatrixRMaj B, FMatrixRMaj X) Solves for X using the QR decomposition.voidLinearSolverQrHouseTran_FDRM.solve(FMatrixRMaj B, FMatrixRMaj X) Solves for X using the QR decomposition.voidLinearSolverQrpHouseCol_FDRM.solve(FMatrixRMaj B, FMatrixRMaj X) voidSolvePseudoInverseQrp_FDRM.solve(FMatrixRMaj B, FMatrixRMaj X) protected voidBaseLinearSolverQrp_FDRM.upgradeSolution(FMatrixRMaj X) Upgrades the basic solution to the optimal 2-norm solution.Constructor parameters in org.ejml.dense.row.linsol.qr with type arguments of type FMatrixRMajModifierConstructorDescriptionprotectedBaseLinearSolverQrp_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
Methods in org.ejml.dense.row.linsol.svd that return types with arguments of type FMatrixRMajModifier and TypeMethodDescriptionSolvePseudoInverseSvd_FDRM.getDecomposer()SolvePseudoInverseSvd_FDRM.getDecomposition()SolveNullSpaceSvd_FDRM.getSvd()Methods in org.ejml.dense.row.linsol.svd with parameters of type FMatrixRMajModifier and TypeMethodDescriptionvoidSolvePseudoInverseSvd_FDRM.invert(FMatrixRMaj A_inv) booleanSolveNullSpaceSvd_FDRM.process(FMatrixRMaj input, int numberOfSingular, FMatrixRMaj nullspace) booleanSolvePseudoInverseSvd_FDRM.setA(FMatrixRMaj A) voidSolvePseudoInverseSvd_FDRM.solve(FMatrixRMaj b, FMatrixRMaj x) -
Uses of FMatrixRMaj in org.ejml.dense.row.misc
Methods in org.ejml.dense.row.misc with parameters of type FMatrixRMajModifier and TypeMethodDescriptionstatic voidImplCommonOps_FDRM.extract(FMatrixRMaj src, int srcY0, int srcX0, FMatrixRMaj dst, int dstY0, int dstX0, int numRows, int numCols) static voidUnrolledInverseFromMinor_FDRM.inv(FMatrixRMaj mat, FMatrixRMaj inv) static voidUnrolledInverseFromMinor_FDRM.inv2(FMatrixRMaj mat, FMatrixRMaj inv, float scale) static voidUnrolledInverseFromMinor_FDRM.inv3(FMatrixRMaj mat, FMatrixRMaj inv, float scale) static voidUnrolledInverseFromMinor_FDRM.inv4(FMatrixRMaj mat, FMatrixRMaj inv, float scale) static voidUnrolledInverseFromMinor_FDRM.inv5(FMatrixRMaj mat, FMatrixRMaj inv, float scale) voidRrefGaussJordanRowPivot_FDRM.reduce(FMatrixRMaj A, int coefficientColumns) protected static voidRrefGaussJordanRowPivot_FDRM.swapRows(FMatrixRMaj A, int rowA, int rowB) -
Uses of FMatrixRMaj in org.ejml.dense.row.mult
Methods in org.ejml.dense.row.mult with parameters of type FMatrixRMajModifier and TypeMethodDescriptionstatic voidVectorVectorMult_FDRM.rank1Update(float gamma, FMatrixRMaj A, FMatrixRMaj u, FMatrixRMaj w) Performs a rank one update on matrix A using vectors u and w.static voidVectorVectorMult_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
Methods in org.ejml.equation that return FMatrixRMajMethods in org.ejml.equation with parameters of type FMatrixRMaj -
Uses of FMatrixRMaj in org.ejml.ops
Methods in org.ejml.ops that return FMatrixRMajModifier and TypeMethodDescriptionstatic FMatrixRMajFConvertArrays.convert(float[][] src, @Nullable FMatrixRMaj dst) static FMatrixRMajFConvertMatrixStruct.convert(FMatrix2 input, @Nullable FMatrixRMaj output) ConvertsFMatrix2intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrix2x2 input, @Nullable FMatrixRMaj output) ConvertsFMatrix2x2intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrix3 input, @Nullable FMatrixRMaj output) ConvertsFMatrix3intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrix3x3 input, @Nullable FMatrixRMaj output) ConvertsFMatrix3x3intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrix4 input, @Nullable FMatrixRMaj output) ConvertsFMatrix4intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrix4x4 input, @Nullable FMatrixRMaj output) ConvertsFMatrix4x4intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrix5 input, @Nullable FMatrixRMaj output) ConvertsFMatrix5intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrix5x5 input, @Nullable FMatrixRMaj output) ConvertsFMatrix5x5intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrix6 input, @Nullable FMatrixRMaj output) ConvertsFMatrix6intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrix6x6 input, @Nullable FMatrixRMaj output) ConvertsFMatrix6x6intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrixRBlock src, @Nullable FMatrixRMaj dst) ConvertsFMatrixRBlockintoFMatrixRMajstatic FMatrixRMajFConvertMatrixStruct.convert(FMatrixSparseCSC src, @Nullable FMatrixRMaj dst) static FMatrixRMajFConvertMatrixStruct.convert(FMatrixSparseTriplet src, @Nullable FMatrixRMaj dst) static FMatrixRMajMatrixIO.loadMatrixMarketFDRM(Reader reader) Reads a stream in Matrix Market Coordinate formatstatic FMatrixRMajMatrixIO.matlabToFDRM(String text) Converts a text string in matlab format into a DDRM matrixReadMatrixCsv.readFDRM(int numRows, int numCols) Reads in aFMatrixRMajfrom the IO stream where the user specifies the matrix dimensions.Methods in org.ejml.ops with parameters of type FMatrixRMajModifier and TypeMethodDescriptionstatic voidConvertMatrixData.convert(DMatrixRMaj src, FMatrixRMaj dst) static voidConvertMatrixData.convert(FMatrixRMaj src, CMatrixRMaj dst) static voidConvertMatrixData.convert(FMatrixRMaj src, DMatrixRMaj dst) static voidConvertMatrixData.convert(FMatrixRMaj src, ZMatrixRMaj dst) static FMatrixRMajFConvertArrays.convert(float[][] src, @Nullable FMatrixRMaj dst) static float[][]FConvertArrays.convert(FMatrixRMaj src) Convert aFMatrixRMajto a two-dimensional array, given FMatrixRMaj can take a float[][] as input to constructorstatic FMatrixRMajFConvertMatrixStruct.convert(FMatrix2 input, @Nullable FMatrixRMaj output) ConvertsFMatrix2intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrix2x2 input, @Nullable FMatrixRMaj output) ConvertsFMatrix2x2intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrix3 input, @Nullable FMatrixRMaj output) ConvertsFMatrix3intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrix3x3 input, @Nullable FMatrixRMaj output) ConvertsFMatrix3x3intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrix4 input, @Nullable FMatrixRMaj output) ConvertsFMatrix4intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrix4x4 input, @Nullable FMatrixRMaj output) ConvertsFMatrix4x4intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrix5 input, @Nullable FMatrixRMaj output) ConvertsFMatrix5intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrix5x5 input, @Nullable FMatrixRMaj output) ConvertsFMatrix5x5intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrix6 input, @Nullable FMatrixRMaj output) ConvertsFMatrix6intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrix6x6 input, @Nullable FMatrixRMaj output) ConvertsFMatrix6x6intoFMatrixRMaj.static FMatrixRMajFConvertMatrixStruct.convert(FMatrixRBlock src, @Nullable FMatrixRMaj dst) ConvertsFMatrixRBlockintoFMatrixRMajstatic FMatrix2FConvertMatrixStruct.convert(FMatrixRMaj input, @Nullable FMatrix2 output) ConvertsFMatrixRMajintoFMatrix2static FMatrix2x2FConvertMatrixStruct.convert(FMatrixRMaj input, @Nullable FMatrix2x2 output) ConvertsFMatrixRMajintoFMatrix2x2static FMatrix3FConvertMatrixStruct.convert(FMatrixRMaj input, @Nullable FMatrix3 output) ConvertsFMatrixRMajintoFMatrix3static FMatrix3x3FConvertMatrixStruct.convert(FMatrixRMaj input, @Nullable FMatrix3x3 output) ConvertsFMatrixRMajintoFMatrix3x3static FMatrix4FConvertMatrixStruct.convert(FMatrixRMaj input, @Nullable FMatrix4 output) ConvertsFMatrixRMajintoFMatrix4static FMatrix4x4FConvertMatrixStruct.convert(FMatrixRMaj input, @Nullable FMatrix4x4 output) ConvertsFMatrixRMajintoFMatrix4x4static FMatrix5FConvertMatrixStruct.convert(FMatrixRMaj input, @Nullable FMatrix5 output) ConvertsFMatrixRMajintoFMatrix5static FMatrix5x5FConvertMatrixStruct.convert(FMatrixRMaj input, @Nullable FMatrix5x5 output) ConvertsFMatrixRMajintoFMatrix5x5static FMatrix6FConvertMatrixStruct.convert(FMatrixRMaj input, @Nullable FMatrix6 output) ConvertsFMatrixRMajintoFMatrix6static FMatrix6x6FConvertMatrixStruct.convert(FMatrixRMaj input, @Nullable FMatrix6x6 output) ConvertsFMatrixRMajintoFMatrix6x6static FMatrixSparseCSCFConvertMatrixStruct.convert(FMatrixRMaj src, @Nullable FMatrixSparseCSC dst, float tol) Converts FMatrixRMaj into a FMatrixSparseCSCstatic FMatrixSparseTripletFConvertMatrixStruct.convert(FMatrixRMaj src, @Nullable FMatrixSparseTriplet dst, float tol) static voidFConvertMatrixStruct.convert(FMatrixRMaj src, FMatrixRBlock dst) ConvertsFMatrixRMajintoFMatrixRBlockCan't handle null output matrix since block size needs to be specified.static FMatrixRMajFConvertMatrixStruct.convert(FMatrixSparseCSC src, @Nullable FMatrixRMaj dst) static FMatrixRMajFConvertMatrixStruct.convert(FMatrixSparseTriplet src, @Nullable FMatrixRMaj dst) static voidMatrixIO.saveMatrixMarket(FMatrixRMaj matrix, String floatFormat, Writer writer) Writes a stream using the Matrix Market Coordinate format. -
Uses of FMatrixRMaj in org.ejml.simple
Methods in org.ejml.simple that return FMatrixRMajModifier and TypeMethodDescriptionSimpleBase.getFDRM()Returns a reference to the matrix that it uses internally if this is aFMatrixRMaj. -
Uses of FMatrixRMaj in org.ejml.simple.ops
Methods in org.ejml.simple.ops that return FMatrixRMajMethods in org.ejml.simple.ops with parameters of type FMatrixRMajModifier and TypeMethodDescriptionvoidSimpleOperations_FDRM.changeSign(FMatrixRMaj a) doubleSimpleOperations_FDRM.conditionP2(FMatrixRMaj A) doubleSimpleOperations_FDRM.determinant(FMatrixRMaj A) SimpleOperations_FDRM.diag(FMatrixRMaj A) voidSimpleOperations_FDRM.divide(FMatrixRMaj A, double val, FMatrixRMaj output) doubleSimpleOperations_FDRM.dot(FMatrixRMaj A, FMatrixRMaj v) voidSimpleOperations_FDRM.elementDiv(FMatrixRMaj A, FMatrixRMaj B, FMatrixRMaj output) voidSimpleOperations_FDRM.elementExp(FMatrixRMaj A, FMatrixRMaj output) voidSimpleOperations_FDRM.elementLog(FMatrixRMaj A, FMatrixRMaj output) doubleSimpleOperations_FDRM.elementMax(FMatrixRMaj A) doubleSimpleOperations_FDRM.elementMaxAbs(FMatrixRMaj A) doubleSimpleOperations_FDRM.elementMin(FMatrixRMaj A) doubleSimpleOperations_FDRM.elementMinAbs(FMatrixRMaj A) voidSimpleOperations_FDRM.elementMult(FMatrixRMaj A, FMatrixRMaj B, FMatrixRMaj output) voidSimpleOperations_FDRM.elementOp(FMatrixRMaj A, SimpleOperations.ElementOpComplex op, FMatrixRMaj output) voidSimpleOperations_FDRM.elementOp(FMatrixRMaj A, SimpleOperations.ElementOpReal op, FMatrixRMaj output) voidSimpleOperations_FDRM.elementPower(FMatrixRMaj A, double b, FMatrixRMaj output) voidSimpleOperations_FDRM.elementPower(FMatrixRMaj A, FMatrixRMaj B, FMatrixRMaj output) doubleSimpleOperations_FDRM.elementSum(FMatrixRMaj A) voidSimpleOperations_FDRM.extract(FMatrixRMaj src, int srcY0, int srcY1, int srcX0, int srcX1, FMatrixRMaj dst, int dstY0, int dstX0) voidSimpleOperations_FSCC.extractDiag(FMatrixSparseCSC input, FMatrixRMaj output) voidSimpleOperations_FDRM.fill(FMatrixRMaj A, double value) doubleSimpleOperations_FDRM.get(FMatrixRMaj A, int row, int column) voidSimpleOperations_FDRM.get(FMatrixRMaj A, int row, int column, Complex_F64 value) double[]SimpleOperations_FDRM.getColumn(FMatrixRMaj A, int col, int row0, int row1) doubleSimpleOperations_FDRM.getImaginary(FMatrixRMaj A, int row, int column) doubleSimpleOperations_FDRM.getReal(FMatrixRMaj A, int row, int column) double[]SimpleOperations_FDRM.getRow(FMatrixRMaj A, int row, int idx0, int idx1) booleanSimpleOperations_FDRM.hasUncountable(FMatrixRMaj M) booleanSimpleOperations_FDRM.invert(FMatrixRMaj A, FMatrixRMaj output) booleanSimpleOperations_FDRM.isIdentical(FMatrixRMaj A, FMatrixRMaj B, double tol) voidSimpleOperations_FDRM.kron(FMatrixRMaj A, FMatrixRMaj B, FMatrixRMaj output) voidSimpleOperations_FDRM.minus(FMatrixRMaj A, double b, FMatrixRMaj output) voidSimpleOperations_FDRM.minus(FMatrixRMaj A, FMatrixRMaj B, FMatrixRMaj output) voidSimpleOperations_FDRM.mult(FMatrixRMaj A, FMatrixRMaj B, FMatrixRMaj output) voidSimpleOperations_FSCC.mult(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj output) voidSimpleOperations_FDRM.multTransA(FMatrixRMaj A, FMatrixRMaj B, FMatrixRMaj output) voidSimpleOperations_FSCC.multTransA(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj output) doubleSimpleOperations_FDRM.normF(FMatrixRMaj A) voidSimpleOperations_FDRM.plus(double alpha, FMatrixRMaj A, double beta, FMatrixRMaj b, FMatrixRMaj output) voidSimpleOperations_FDRM.plus(FMatrixRMaj A, double b, FMatrixRMaj output) voidSimpleOperations_FDRM.plus(FMatrixRMaj A, double beta, FMatrixRMaj b, FMatrixRMaj output) voidSimpleOperations_FDRM.plus(FMatrixRMaj A, FMatrixRMaj B, FMatrixRMaj output) voidSimpleOperations_FDRM.pseudoInverse(FMatrixRMaj A, FMatrixRMaj output) voidSimpleOperations_FDRM.scale(FMatrixRMaj A, double val, FMatrixRMaj output) voidSimpleOperations_FDRM.set(FMatrixRMaj A, int row, int column, double value) voidSimpleOperations_FDRM.set(FMatrixRMaj A, int row, int column, double real, double imaginary) voidSimpleOperations_FDRM.setColumn(FMatrixRMaj A, int column, int startRow, double... values) voidSimpleOperations_FDRM.setIdentity(FMatrixRMaj A) voidSimpleOperations_FDRM.setRow(FMatrixRMaj A, int row, int startColumn, double... values) booleanSimpleOperations_FDRM.solve(FMatrixRMaj A, FMatrixRMaj X, FMatrixRMaj B) booleanSimpleOperations_FSCC.solve(FMatrixSparseCSC A, FMatrixRMaj X, FMatrixRMaj B) doubleSimpleOperations_FDRM.trace(FMatrixRMaj A) voidSimpleOperations_FDRM.transpose(FMatrixRMaj input, FMatrixRMaj output) voidSimpleOperations_FDRM.zero(FMatrixRMaj A) -
Uses of FMatrixRMaj in org.ejml.sparse.csc
Methods in org.ejml.sparse.csc that return FMatrixRMajModifier and TypeMethodDescriptionstatic FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_FSCC.mult(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC) Performs matrix multiplication.static FMatrixRMajCommonOps_MT_FSCC.mult(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable GrowArray<FGrowArray> workspace) Performs matrix multiplication.static FMatrixRMajCommonOpsWithSemiRing_FSCC.mult(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj output, FSemiRing semiRing) Performs matrix multiplication.static FMatrixRMajCommonOps_FSCC.multTransA(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable FGrowArray work) Performs matrix multiplication.static FMatrixRMajCommonOps_MT_FSCC.multTransA(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable GrowArray<FGrowArray> workspace) Performs matrix multiplication.static FMatrixRMajCommonOpsWithSemiRing_FSCC.multTransA(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj output, FSemiRing semiRing) Performs matrix multiplication.static FMatrixRMajCommonOps_FSCC.multTransAB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC) Performs matrix multiplication.static FMatrixRMajCommonOps_MT_FSCC.multTransAB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC) Performs matrix multiplication.static FMatrixRMajCommonOpsWithSemiRing_FSCC.multTransAB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj output, FSemiRing semiRing) Performs matrix multiplication.static FMatrixRMajCommonOps_FSCC.multTransB(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable FGrowArray work) Performs matrix multiplication.static FMatrixRMajCommonOps_MT_FSCC.multTransB(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable GrowArray<FGrowArray> workspace) Performs matrix multiplication.static FMatrixRMajCommonOpsWithSemiRing_FSCC.multTransB(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj output, FSemiRing semiRing) Performs matrix multiplication.static FMatrixRMajCommonOps_FSCC.reduceColumnWise(FMatrixSparseCSC input, float initValue, FOperatorBinary func, @Nullable FMatrixRMaj output, @Nullable Mask mask) This accumulates the values per column to a scalar valuestatic FMatrixRMajCommonOps_FSCC.reduceRowWise(FMatrixSparseCSC input, float initValue, FOperatorBinary func, @Nullable FMatrixRMaj output) This accumulates the values per row to a scalar valuestatic FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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)Methods in org.ejml.sparse.csc with parameters of type FMatrixRMajModifier and TypeMethodDescriptionstatic voidCommonOps_FSCC.extractDiag(FMatrixSparseCSC A, FMatrixRMaj outputB) Extracts the diagonal elements 'src' write it to the 'dst' vector.static booleanCommonOps_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 voidCommonOps_FSCC.maxAbsCols(FMatrixSparseCSC A, @Nullable FMatrixRMaj outputB) Finds the maximum abs in each column of A and stores it into valuesstatic FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_FSCC.mult(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC) Performs matrix multiplication.static FMatrixRMajCommonOps_MT_FSCC.mult(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable GrowArray<FGrowArray> workspace) Performs matrix multiplication.static FMatrixRMajCommonOpsWithSemiRing_FSCC.mult(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj output, FSemiRing semiRing) Performs matrix multiplication.static voidCommonOps_FSCC.multAdd(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC) C = C + A*Bstatic voidCommonOps_MT_FSCC.multAdd(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC, @Nullable GrowArray<FGrowArray> workspace) C = C + AT*Bstatic voidCommonOpsWithSemiRing_FSCC.multAdd(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj output, FSemiRing semiRing) output = output + A*Bstatic voidCommonOps_FSCC.multAddTransA(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC, @Nullable FGrowArray work) C = C + AT*Bstatic voidCommonOps_MT_FSCC.multAddTransA(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC, @Nullable GrowArray<FGrowArray> workspace) C = C + AT*Bstatic voidCommonOpsWithSemiRing_FSCC.multAddTransA(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj output, FSemiRing semiRing) output = output + AT*Bstatic voidCommonOps_FSCC.multAddTransAB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC) C = C + AT*BTstatic voidCommonOps_MT_FSCC.multAddTransAB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC) C = C + AT*BTstatic voidCommonOpsWithSemiRing_FSCC.multAddTransAB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FSemiRing semiRing) C = C + AT*BTstatic voidCommonOps_FSCC.multAddTransB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC, @Nullable FGrowArray work) C = C + A*BTstatic voidCommonOps_MT_FSCC.multAddTransB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC, @Nullable GrowArray<FGrowArray> workspace) C = C + A*BTstatic voidCommonOpsWithSemiRing_FSCC.multAddTransB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj output, FSemiRing semiRing) output = output + A*BTstatic FMatrixRMajCommonOps_FSCC.multTransA(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable FGrowArray work) Performs matrix multiplication.static FMatrixRMajCommonOps_MT_FSCC.multTransA(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable GrowArray<FGrowArray> workspace) Performs matrix multiplication.static FMatrixRMajCommonOpsWithSemiRing_FSCC.multTransA(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj output, FSemiRing semiRing) Performs matrix multiplication.static FMatrixRMajCommonOps_FSCC.multTransAB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC) Performs matrix multiplication.static FMatrixRMajCommonOps_MT_FSCC.multTransAB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj outputC) Performs matrix multiplication.static FMatrixRMajCommonOpsWithSemiRing_FSCC.multTransAB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj output, FSemiRing semiRing) Performs matrix multiplication.static FMatrixRMajCommonOps_FSCC.multTransB(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable FGrowArray work) Performs matrix multiplication.static FMatrixRMajCommonOps_MT_FSCC.multTransB(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj outputC, @Nullable GrowArray<FGrowArray> workspace) Performs matrix multiplication.static FMatrixRMajCommonOpsWithSemiRing_FSCC.multTransB(FMatrixSparseCSC A, FMatrixRMaj B, @Nullable FMatrixRMaj output, FSemiRing semiRing) Performs matrix multiplication.static FMatrixRMajCommonOps_FSCC.reduceColumnWise(FMatrixSparseCSC input, float initValue, FOperatorBinary func, @Nullable FMatrixRMaj output, @Nullable Mask mask) This accumulates the values per column to a scalar valuestatic FMatrixRMajCommonOps_FSCC.reduceRowWise(FMatrixSparseCSC input, float initValue, FOperatorBinary func, @Nullable FMatrixRMaj output) This accumulates the values per row to a scalar valuestatic booleanCommonOps_FSCC.solve(FMatrixSparseCSC a, FMatrixRMaj b, FMatrixRMaj x) Solves for x in the following equation:
A*x = bstatic FMatrixRMajCommonOps_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 FMatrixRMajCommonOps_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
Methods in org.ejml.sparse.csc.factory that return types with arguments of type FMatrixRMajModifier 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
Methods in org.ejml.sparse.csc.linsol.chol with parameters of type FMatrixRMajModifier and TypeMethodDescriptionvoidLinearSolverCholesky_FSCC.solve(FMatrixRMaj B, FMatrixRMaj X) -
Uses of FMatrixRMaj in org.ejml.sparse.csc.linsol.lu
Methods in org.ejml.sparse.csc.linsol.lu with parameters of type FMatrixRMaj -
Uses of FMatrixRMaj in org.ejml.sparse.csc.linsol.qr
Methods in org.ejml.sparse.csc.linsol.qr with parameters of type FMatrixRMajModifier and TypeMethodDescriptionvoidLinearSolverQrLeftLooking_FSCC.solve(FMatrixRMaj B, FMatrixRMaj X) -
Uses of FMatrixRMaj in org.ejml.sparse.csc.mult
Methods in org.ejml.sparse.csc.mult with parameters of type FMatrixRMajModifier and TypeMethodDescriptionstatic floatMatrixVectorMult_FSCC.innerProduct(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixSparseCSC C) scalar = AT*B*Cstatic floatMatrixVectorMult_FSCC.innerProductSelfSymmetrical(FMatrixSparseCSC A, FMatrixRMaj B) scalar = AT*B*Astatic voidImplMultiplication_FSCC.mult(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C) Invoke throughCommonOps_FSCCstatic voidImplMultiplication_MT_FSCC.mult(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, boolean add, GrowArray<FGrowArray> listWork) Invoke throughCommonOps_MT_FSCCas it will manage the input contractstatic voidImplMultiplication_MT_FSCC.mult(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, GrowArray<FGrowArray> listWork) Invoke throughCommonOps_MT_FSCCas it will manage the input contractstatic voidImplMultiplicationWithSemiRing_FSCC.mult(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FSemiRing semiRing) static voidImplMultiplication_FSCC.multAdd(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C) Invoke throughCommonOps_FSCCstatic voidImplMultiplication_MT_FSCC.multAdd(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, GrowArray<FGrowArray> listWork) Invoke throughCommonOps_MT_FSCCas it will manage the input contractstatic voidImplMultiplicationWithSemiRing_FSCC.multAdd(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FSemiRing semiRing) static voidImplMultiplication_FSCC.multAddTransA(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FGrowArray workArray) Invoke throughCommonOps_FSCCstatic voidImplMultiplication_MT_FSCC.multAddTransA(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, GrowArray<FGrowArray> listWork) Invoke throughCommonOps_MT_FSCCas it will manage the input contractstatic voidImplMultiplicationWithSemiRing_FSCC.multAddTransA(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FSemiRing semiRing) static voidImplMultiplication_FSCC.multAddTransAB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C) Invoke throughCommonOps_FSCCstatic voidImplMultiplication_MT_FSCC.multAddTransAB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C) Invoke throughCommonOps_MT_FSCCas it will manage the input contractstatic voidImplMultiplicationWithSemiRing_FSCC.multAddTransAB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FSemiRing semiRing) static voidImplMultiplication_FSCC.multAddTransB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FGrowArray workArray) Invoke throughCommonOps_FSCCstatic voidImplMultiplication_MT_FSCC.multAddTransB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, GrowArray<FGrowArray> listWork) Invoke throughCommonOps_MT_FSCCas it will manage the input contractstatic voidImplMultiplicationWithSemiRing_FSCC.multAddTransB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FSemiRing semiRing) static voidImplMultiplication_FSCC.multTransA(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FGrowArray workArray) Invoke throughCommonOps_FSCCstatic voidImplMultiplication_FSCC.multTransA(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FGrowArray workArray, FOperatorBinary op) Invoke throughCommonOps_FSCCstatic voidImplMultiplication_MT_FSCC.multTransA(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, GrowArray<FGrowArray> listWork) Invoke throughCommonOps_MT_FSCCas it will manage the input contractstatic voidImplMultiplicationWithSemiRing_FSCC.multTransA(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FSemiRing semiRing) static voidImplMultiplication_FSCC.multTransAB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C) Invoke throughCommonOps_FSCCstatic voidImplMultiplication_MT_FSCC.multTransAB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C) Invoke throughCommonOps_MT_FSCCas it will manage the input contractstatic voidImplMultiplicationWithSemiRing_FSCC.multTransAB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FSemiRing semiRing) static voidImplMultiplication_FSCC.multTransB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FGrowArray workArray) Invoke throughCommonOps_FSCCstatic voidImplMultiplication_MT_FSCC.multTransB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, boolean add, GrowArray<FGrowArray> listWork) Invoke throughCommonOps_MT_FSCCas it will manage the input contractstatic voidImplMultiplication_MT_FSCC.multTransB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, GrowArray<FGrowArray> listWork) Invoke throughCommonOps_MT_FSCCas it will manage the input contractstatic voidImplMultiplicationWithSemiRing_FSCC.multTransB(FMatrixSparseCSC A, FMatrixRMaj B, FMatrixRMaj C, FSemiRing semiRing)