Uses of Class
org.ejml.data.DMatrixRMaj
Packages that use DMatrixRMaj
Package
Description
-
Uses of DMatrixRMaj in org.ejml
Methods in org.ejml that return DMatrixRMajModifier and TypeMethodDescriptionstatic DMatrixRMajUtilEjml.parse_DDRM(String s, int numColumns) Give a string of numbers it returns a DenseMatrixstatic DMatrixRMajUtilEjml.reshapeOrDeclare(@Nullable DMatrixRMaj 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 DMatrixRMajModifier and TypeMethodDescriptionstatic DMatrixRMajUtilEjml.reshapeOrDeclare(@Nullable DMatrixRMaj a, int rows, int cols) If the input matrix is null a new matrix is created and returned. -
Uses of DMatrixRMaj in org.ejml.data
Fields in org.ejml.data declared as DMatrixRMajMethods in org.ejml.data that return DMatrixRMajModifier and TypeMethodDescriptionDMatrixRMaj.copy()Creates and returns a matrix which is identical to this one.DMatrixRMaj.create(int numRows, int numCols) DMatrixRMaj.createLike()DSubmatrixD1.extract()static DMatrixRMajDMatrixRMaj.wrap(int numRows, int numCols, double[] data) Creates a new DMatrixRMaj around the provided data.Constructors in org.ejml.data with parameters of type DMatrixRMajModifierConstructorDescriptionDEigenpair(double value, DMatrixRMaj vector) DMatrixRMaj(DMatrixRMaj orig) Creates a new matrix which is equivalent to the provided matrix. -
Uses of DMatrixRMaj in org.ejml.dense.block
Methods in org.ejml.dense.block that return DMatrixRMajModifier and TypeMethodDescriptionstatic DMatrixRMajMatrixOps_DDRB.convert(DMatrixRBlock src, DMatrixRMaj dst) Converts a row major block matrix into a row major matrix.static DMatrixRMajMatrixOps_DDRB.convertInplace(DMatrixRBlock src, @Nullable DMatrixRMaj dst, @Nullable DGrowArray workspace) Converts a row major block matrix into a row major matrix.Methods in org.ejml.dense.block with parameters of type DMatrixRMajModifier and TypeMethodDescriptionstatic DMatrixRMajMatrixOps_DDRB.convert(DMatrixRBlock src, DMatrixRMaj dst) Converts a row major block matrix into a row major matrix.static DMatrixRBlockMatrixOps_DDRB.convert(DMatrixRMaj A) static DMatrixRBlockMatrixOps_DDRB.convert(DMatrixRMaj A, int blockLength) static voidMatrixOps_DDRB.convert(DMatrixRMaj src, DMatrixRBlock dst) Converts a row major matrix into a row major block matrix.static DMatrixRMajMatrixOps_DDRB.convertInplace(DMatrixRBlock src, @Nullable DMatrixRMaj dst, @Nullable DGrowArray workspace) Converts a row major block matrix into a row major matrix.static DMatrixRBlockMatrixOps_DDRB.convertInplace(DMatrixRMaj src, @Nullable DMatrixRBlock dst, @Nullable DGrowArray workspace) Converts a row major matrix into a row major block matrix.static voidMatrixOps_DDRB.convertTranSrc(DMatrixRMaj src, DMatrixRBlock dst) Converts the transpose of a row major matrix into a row major block matrix. -
Uses of DMatrixRMaj in org.ejml.dense.block.decomposition.hessenberg
Fields in org.ejml.dense.block.decomposition.hessenberg declared as DMatrixRMajModifier and TypeFieldDescriptionprotected DMatrixRMajTridiagonalDecompositionHouseholder_DDRB.zerosMprotected DMatrixRMajTridiagonalDecompositionHouseholder_MT_DDRB.zerosM -
Uses of DMatrixRMaj in org.ejml.dense.row
Methods in org.ejml.dense.row that return DMatrixRMajModifier and TypeMethodDescriptionstatic DMatrixRMajCommonOps_DDRM.apply(DMatrixRMaj input, DOperatorUnary func) static DMatrixRMajCommonOps_DDRM.apply(DMatrixRMaj input, DOperatorUnary func, @Nullable DMatrixRMaj output) This applies a given unary function on every value stored in the matrixstatic DMatrixRMaj[]CommonOps_DDRM.columnsToVector(DMatrixRMaj A, @Nullable DMatrixRMaj[] v) Converts the columns in a matrix into a set of vectors.static DMatrixRMajCommonOps_DDRM.concatColumns(DMatrixRMaj a, DMatrixRMaj b, @Nullable DMatrixRMaj output) output = [a , b]static DMatrixRMajCommonOps_DDRM.concatColumnsMulti(DMatrixRMaj... m) Concatenates all the matrices together along their columns.static DMatrixRMajCommonOps_DDRM.concatRowsMulti(DMatrixRMaj... m) Concatenates all the matrices together along their columns.static DMatrixRMajSpecializedOps_DDRM.copyChangeRow(int[] order, DMatrixRMaj src, @Nullable DMatrixRMaj dst) Creates a copy of a matrix but swaps the rows as specified by the order array.static DMatrixRMajSpecializedOps_DDRM.copyTriangle(DMatrixRMaj src, @Nullable DMatrixRMaj dst, boolean upper) Copies just the upper or lower triangular portion of a matrix.static DMatrixRMajEigenOps_DDRM.createMatrixD(EigenDecomposition_F64<?> eig) A diagonal matrix where real diagonal element contains a real eigenvalue.static DMatrixRMajEigenOps_DDRM.createMatrixV(EigenDecomposition_F64<DMatrixRMaj> eig) Puts all the real eigenvectors into the columns of a matrix.static DMatrixRMajSpecializedOps_DDRM.createReflector(DMatrix1Row u) Creates a reflector from the provided vector.
Q = I - γ u uT
γ = 2/||u||2static DMatrixRMajSpecializedOps_DDRM.createReflector(DMatrixRMaj u, double gamma) Creates a reflector from the provided vector and gamma.
Q = I - γ u uTstatic DMatrixRMajCommonOps_DDRM.diag(double... diagEl) Creates a new square matrix whose diagonal elements are specified by diagEl and all the other elements are zero.
aij = 0 if i ≤ j
aij = diag[i] if i = jstatic DMatrixRMajCommonOps_DDRM.diag(@Nullable DMatrixRMaj ret, int width, double... diagEl) static DMatrixRMajCreates a random diagonal matrix where the diagonal elements are selected from a uniform distribution that goes from min to max.static DMatrixRMajCreates a random matrix where all elements are zero but diagonal elements.static DMatrixRMajCommonOps_DDRM.diagR(int numRows, int numCols, double... diagEl) Creates a new rectangular matrix whose diagonal elements are specified by diagEl and all the other elements are zero.
aij = 0 if i ≤ j
aij = diag[i] if i = jstatic DMatrixRMajCommonOps_DDRM.elements(DMatrixRMaj A, BMatrixRMaj marked, @Nullable DMatrixRMaj output) Returns a row matrix which contains all the elements in A which are flagged as true in 'marked'static DMatrixRMajCommonOps_DDRM.extract(DMatrixRMaj src, int[] rows, int rowsSize, int[] cols, int colsSize, @Nullable DMatrixRMaj dst) Extracts out a matrix from source given a sub matrix with arbitrary rows and columns specified in two array listsstatic DMatrixRMajCommonOps_DDRM.extract(DMatrixRMaj src, int[] indexes, int length, @Nullable DMatrixRMaj dst) Extracts the elements from the source matrix by their 1D index.static DMatrixRMajCommonOps_DDRM.extract(DMatrixRMaj src, int srcY0, int srcY1, int srcX0, int srcX1) Creates a new matrix which is the specified submatrix of 'src'static DMatrixRMajCommonOps_DDRM.extractColumn(DMatrixRMaj a, int column, @Nullable DMatrixRMaj out) Extracts the column from a matrix.static DMatrixRMajCommonOps_DDRM.extractDiag(DMatrixRMaj src, @Nullable DMatrixRMaj dst) Extracts the diagonal elements 'src' write it to the 'dst' vector.static DMatrixRMajCommonOps_DDRM.extractRow(DMatrixRMaj a, int row, @Nullable DMatrixRMaj out) Extracts the row from a matrix.static DMatrixRMajCommonOps_DDRM.identity(int width) Creates an identity matrix of the specified size.
aij = 0 if i ≠ j
aij = 1 if i = jstatic DMatrixRMajCommonOps_DDRM.identity(int numRows, int numCols) Creates a rectangular matrix which is zero except along the diagonals.static DMatrixRMajCommonOps_ZDRM.imaginary(ZMatrixD1 input, @Nullable DMatrixRMaj output) Places the imaginary component of the input matrix into the output matrix.static DMatrixRMajRandomMatrices_DDRM.insideSpan(DMatrixRMaj[] span, double min, double max, Random rand) Creates a random vector that is inside the specified span.static DMatrixRMajCommonOps_DDRM.kron(DMatrixRMaj A, DMatrixRMaj B, @Nullable DMatrixRMaj C) The Kronecker product of two matrices is defined as:
Cij = aijB
where Cij is a sub matrix inside of C ∈ ℜ m*k × n*l, A ∈ ℜ m × n, and B ∈ ℜ k × l.static DMatrixRMajCommonOps_ZDRM.magnitude(ZMatrixD1 input, @Nullable DMatrixRMaj output) Computes the magnitude of the complex number in the input matrix and stores the results in the output matrix.static DMatrixRMajCommonOps_DDRM.maxCols(DMatrixRMaj input, @Nullable DMatrixRMaj output) Finds the element with the minimum value along column in the input matrix and returns the results in a vector:
bj = min(i=1:m ; aij)static DMatrixRMajCommonOps_DDRM.maxRows(DMatrixRMaj input, @Nullable DMatrixRMaj output) Finds the element with the maximum value along each row in the input matrix and returns the results in a vector:
bj = max(i=1:n ; aji)static DMatrixRMajCommonOps_DDRM.minCols(DMatrixRMaj input, @Nullable DMatrixRMaj output) Finds the element with the minimum value along column in the input matrix and returns the results in a vector:
bj = min(i=1:m ; aij)static DMatrixRMajCommonOps_DDRM.minRows(DMatrixRMaj input, @Nullable DMatrixRMaj output) Finds the element with the minimum value along each row in the input matrix and returns the results in a vector:
bj = min(i=1:n ; aji)static DMatrixRMajSingularOps_DDRM.nullSpace(SingularValueDecomposition_F64<DMatrixRMaj> svd, @Nullable DMatrixRMaj nullSpace, double tol) Returns the null-space from the singular value decomposition.static DMatrixRMajSingularOps_DDRM.nullspaceQR(DMatrixRMaj A, int totalSingular) Computes the null space using QR decomposition.static DMatrixRMajSingularOps_DDRM.nullspaceQRP(DMatrixRMaj A, int totalSingular) Computes the null space using QRP decomposition.static DMatrixRMajSingularOps_DDRM.nullspaceSVD(DMatrixRMaj A, int totalSingular) Computes the null space using SVD.static DMatrixRMajSingularOps_DDRM.nullVector(SingularValueDecomposition_F64<DMatrixRMaj> svd, boolean isRight, @Nullable DMatrixRMaj nullVector) The vector associated will the smallest singular value is returned as the null space of the decomposed system.static DMatrixRMajRandomMatrices_DDRM.orthogonal(int numRows, int numCols, Random rand) Creates a random orthogonal or isometric matrix, depending on the number of rows and columns.static DMatrixRMajCommonOps_DDRM.permuteRowInv(int[] pinv, DMatrixRMaj input, DMatrixRMaj output) Applies the row permutation specified by the vector to the input matrix and save the results in the output matrix.static DMatrixRMajSpecializedOps_DDRM.pivotMatrix(@Nullable DMatrixRMaj ret, int[] pivots, int numPivots, boolean transposed) Creates a pivot matrix that exchanges the rows in a matrix:
A' = P*Astatic DMatrixRMajCommonOps_ZDRM.real(ZMatrixD1 input, @Nullable DMatrixRMaj output) Places the real component of the input matrix into the output matrix.static DMatrixRMajReturns a matrix where all the elements are selected independently from a uniform distribution between 'min' and 'max' inclusive.static DMatrixRMajReturns a matrix where all the elements are selected independently from a uniform distribution between 0 and 1 inclusive.static DMatrixRMajRandomMatrices_DDRM.rectangleGaussian(int numRow, int numCol, double mean, double stdev, Random rand) Sets each element in the matrix to a value drawn from an Gaussian distribution with the specified mean and standard deviationstatic DMatrixRMaj[]CommonOps_DDRM.rowsToVector(DMatrixRMaj A, @Nullable DMatrixRMaj[] v) Converts the rows in a matrix into a set of vectors.static DMatrixRMajCommonOps_DDRM.rref(DMatrixRMaj A, int numUnknowns, @Nullable DMatrixRMaj reduced) Puts the augmented system matrix into reduced row echelon form (RREF) using Gauss-Jordan elimination with row (partial) pivots.static DMatrixRMajCreates a random matrix which will have the provided singular values.static DMatrixRMaj[]Creates a randomly generated set of orthonormal vectors.static DMatrixRMaj[]SpecializedOps_DDRM.splitIntoVectors(DMatrix1Row A, boolean column) Takes a matrix and splits it into a set of row or column vectors.static DMatrixRMajCommonOps_DDRM.sumCols(DMatrixRMaj input, @Nullable DMatrixRMaj output) Computes the sum of each column in the input matrix and returns the results in a vector:
bj = sum(i=1:m ; aij)static DMatrixRMajCommonOps_DDRM.sumRows(DMatrixRMaj input, @Nullable DMatrixRMaj output) Computes the sum of each row in the input matrix and returns the results in a vector:
bj = sum(i=1:n ; aji)static DMatrixRMajCreates a random symmetric matrix whose values are selected from an uniform distribution from min to max, inclusive.static DMatrixRMajRandomMatrices_DDRM.symmetricPosDef(int width, Random rand) Creates a random symmetric positive definite matrix.static DMatrixRMajRandomMatrices_DDRM.symmetricWithEigenvalues(int num, Random rand, double... eigenvalues) Creates a new random symmetric matrix that will have the specified real eigenvalues.static DMatrixRMajCommonOps_DDRM.transpose(DMatrixRMaj A, @Nullable DMatrixRMaj A_tran) Transposes matrix 'a' and stores the results in 'b':
bij = aji
where 'b' is the transpose of 'a'.static DMatrixRMajCommonOps_MT_DDRM.transpose(DMatrixRMaj A, @Nullable DMatrixRMaj A_tran) Transposes matrix 'a' and stores the results in 'b':
bij = aji
where 'b' is the transpose of 'a'.static DMatrixRMajRandomMatrices_DDRM.triangularLower(int dimen, int hessenberg, double min, double max, Random rand) Creates a lower triangular matrix whose values are selected from a uniform distribution.static DMatrixRMajRandomMatrices_DDRM.triangularUpper(int dimen, int hessenberg, double min, double max, Random rand) Creates an upper triangular matrix whose values are selected from a uniform distribution.Methods in org.ejml.dense.row with parameters of type DMatrixRMajModifier and TypeMethodDescriptionstatic voidRandomMatrices_DDRM.addUniform(DMatrixRMaj A, double min, double max, Random rand) Adds random values to each element in the matrix from an uniform distribution.
aij = aij + U(min,max)static DMatrixRMajCommonOps_DDRM.apply(DMatrixRMaj input, DOperatorUnary func) static DMatrixRMajCommonOps_DDRM.apply(DMatrixRMaj input, DOperatorUnary func, @Nullable DMatrixRMaj output) This applies a given unary function on every value stored in the matrixstatic double[]EigenOps_DDRM.boundLargestEigenValue(DMatrixRMaj A, @org.jetbrains.annotations.Nullable double[] bound) Generates a bound for the largest eigen value of the provided matrix using Perron-Frobenius theorem.static voidSingularOps_DDRM.checkSvdMatrixSize(@Nullable DMatrixRMaj U, boolean tranU, DMatrixRMaj W, @Nullable DMatrixRMaj V, boolean tranV) Checks to see if all the provided matrices are the expected size for an SVD.static DMatrixRMaj[]CommonOps_DDRM.columnsToVector(DMatrixRMaj A, @Nullable DMatrixRMaj[] v) Converts the columns in a matrix into a set of vectors.static doubleEigenOps_DDRM.computeEigenValue(DMatrixRMaj A, DMatrixRMaj eigenVector) Given matrix A and an eigen vector of A, compute the corresponding eigen value.static @Nullable DEigenpairEigenOps_DDRM.computeEigenVector(DMatrixRMaj A, double eigenvalue) Given an eigenvalue it computes an eigenvector using inverse iteration:
for i=1:MAX {
(A - μI)z(i) = q(i-1)
q(i) = z(i) / ||z(i)||
λ(i) = q(i)T A q(i)
}static DMatrixRMajCommonOps_DDRM.concatColumns(DMatrixRMaj a, DMatrixRMaj b, @Nullable DMatrixRMaj output) output = [a , b]static DMatrixRMajCommonOps_DDRM.concatColumnsMulti(DMatrixRMaj... m) Concatenates all the matrices together along their columns.static voidCommonOps_DDRM.concatRows(DMatrixRMaj a, DMatrixRMaj b, DMatrixRMaj output) output = [a ; b]static DMatrixRMajCommonOps_DDRM.concatRowsMulti(DMatrixRMaj... m) Concatenates all the matrices together along their columns.static doubleNormOps_DDRM.conditionP(DMatrixRMaj A, double p) The condition number of a matrix is used to measure the sensitivity of the linear system Ax=b.static doubleNormOps_DDRM.conditionP2(DMatrixRMaj A) The condition p = 2 number of a matrix is used to measure the sensitivity of the linear system Ax=b.static DMatrixRMajSpecializedOps_DDRM.copyChangeRow(int[] order, DMatrixRMaj src, @Nullable DMatrixRMaj dst) Creates a copy of a matrix but swaps the rows as specified by the order array.static DMatrixRMajSpecializedOps_DDRM.copyTriangle(DMatrixRMaj src, @Nullable DMatrixRMaj dst, boolean upper) Copies just the upper or lower triangular portion of a matrix.static intMatrixFeatures_DDRM.countNonZero(DMatrixRMaj A) Counts the number of elements in A which are not zero.static DMatrixRMajSpecializedOps_DDRM.createReflector(DMatrixRMaj u, double gamma) Creates a reflector from the provided vector and gamma.
Q = I - γ u uTstatic voidSingularOps_DDRM.descendingOrder(@Nullable DMatrixRMaj U, boolean tranU, double[] singularValues, int singularLength, @Nullable DMatrixRMaj V, boolean tranV) Similar toSingularOps_DDRM.descendingOrder(DMatrixRMaj, boolean, DMatrixRMaj, DMatrixRMaj, boolean)but takes in an array of singular values instead.static voidSingularOps_DDRM.descendingOrder(DMatrixRMaj U, boolean tranU, DMatrixRMaj W, DMatrixRMaj V, boolean tranV) Adjusts the matrices so that the singular values are in descending order.static doubleCommonOps_DDRM.det(DMatrixRMaj mat) Returns the determinant of the matrix.static DMatrixRMajCommonOps_DDRM.diag(@Nullable DMatrixRMaj ret, int width, double... diagEl) static voidCommonOps_DDRM.divideCols(DMatrixRMaj A, double[] values) Divides every element in column i by value[i].static voidCommonOps_DDRM.divideRows(double[] values, DMatrixRMaj A) Divides every element in row i by value[i].static voidCommonOps_DDRM.divideRowsCols(double[] diagA, int offsetA, DMatrixRMaj B, double[] diagC, int offsetC) Equivalent to multiplying a matrix B by the inverse of two diagonal matrices.static @Nullable DEigenpairEigenOps_DDRM.dominantEigenpair(DMatrixRMaj A) Computes the dominant eigen vector for a matrix.static BMatrixRMajCommonOps_DDRM.elementBoolean(DMatrixRMaj input, DElementCoorBoolean func, @Nullable BMatrixRMaj output) Applies a binary operator to even element in the input matrix.static BMatrixRMajCommonOps_DDRM.elementLessThan(DMatrixRMaj A, double value, @Nullable BMatrixRMaj output) Applies the > operator to each element in A.static BMatrixRMajCommonOps_DDRM.elementLessThan(DMatrixRMaj A, DMatrixRMaj B, @Nullable BMatrixRMaj output) Applies the < operator to each element in A.static BMatrixRMajCommonOps_DDRM.elementLessThanOrEqual(DMatrixRMaj A, double value, @Nullable BMatrixRMaj output) Applies the ≥ operator to each element in A.static BMatrixRMajCommonOps_DDRM.elementLessThanOrEqual(DMatrixRMaj A, DMatrixRMaj B, @Nullable BMatrixRMaj output) Applies the A ≤ B operator to each element.static BMatrixRMajCommonOps_DDRM.elementMoreThan(DMatrixRMaj A, double value, @Nullable BMatrixRMaj output) Applies the > operator to each element in A.static BMatrixRMajCommonOps_DDRM.elementMoreThanOrEqual(DMatrixRMaj A, double value, @Nullable BMatrixRMaj output) Applies the ≥ operator to each element in A.static DMatrixRMajCommonOps_DDRM.elements(DMatrixRMaj A, BMatrixRMaj marked, @Nullable DMatrixRMaj output) Returns a row matrix which contains all the elements in A which are flagged as true in 'marked'static DMatrixRMajCommonOps_DDRM.extract(DMatrixRMaj src, int[] rows, int rowsSize, int[] cols, int colsSize, @Nullable DMatrixRMaj dst) Extracts out a matrix from source given a sub matrix with arbitrary rows and columns specified in two array listsstatic DMatrixRMajCommonOps_DDRM.extract(DMatrixRMaj src, int[] indexes, int length, @Nullable DMatrixRMaj dst) Extracts the elements from the source matrix by their 1D index.static DMatrixRMajCommonOps_DDRM.extract(DMatrixRMaj src, int srcY0, int srcY1, int srcX0, int srcX1) Creates a new matrix which is the specified submatrix of 'src'static DMatrixRMajCommonOps_DDRM.extractColumn(DMatrixRMaj a, int column, @Nullable DMatrixRMaj out) Extracts the column from a matrix.static DMatrixRMajCommonOps_DDRM.extractDiag(DMatrixRMaj src, @Nullable DMatrixRMaj dst) Extracts the diagonal elements 'src' write it to the 'dst' vector.static DMatrixRMajCommonOps_DDRM.extractRow(DMatrixRMaj a, int row, @Nullable DMatrixRMaj out) Extracts the row from a matrix.static doubleNormOps_DDRM.fastNormP(DMatrixRMaj A, double p) An unsafe but faster version ofNormOps_DDRM.normP(org.ejml.data.DMatrixRMaj, double)that calls routines which are faster but more prone to overflow/underflow problems.static doubleNormOps_DDRM.fastNormP2(DMatrixRMaj A) Computes the p=2 norm.static voidRandomMatrices_DDRM.fillUniform(DMatrixRMaj mat, Random rand) Sets each element in the matrix to a value drawn from an uniform distribution from 0 to 1 inclusive.static DMatrixRMajCommonOps_ZDRM.imaginary(ZMatrixD1 input, @Nullable DMatrixRMaj output) Places the imaginary component of the input matrix into the output matrix.static doubleNormOps_DDRM.inducedP1(DMatrixRMaj A) Computes the induced p = 1 matrix norm.
||A||1= max(j=1 to n; sum(i=1 to m; |aij|))static doubleNormOps_DDRM.inducedP2(DMatrixRMaj A) Computes the induced p = 2 matrix norm, which is the largest singular value.static doubleNormOps_DDRM.inducedPInf(DMatrixRMaj A) Induced matrix p = infinity norm.
||A||∞ = max(i=1 to m; sum(j=1 to n; |aij|))static voidCommonOps_DDRM.insert(DMatrixRMaj src, DMatrixRMaj dst, int[] rows, int rowsSize, int[] cols, int colsSize) Inserts into the specified elements of dst the source matrix.static DMatrixRMajRandomMatrices_DDRM.insideSpan(DMatrixRMaj[] span, double min, double max, Random rand) Creates a random vector that is inside the specified span.static booleanCommonOps_DDRM.invert(DMatrixRMaj mat) Performs a matrix inversion operation on the specified matrix and stores the results in the same matrix.
a = a-1static booleanCommonOps_DDRM.invert(DMatrixRMaj mat, DMatrixRMaj result) Performs a matrix inversion operation that does not modify the original and stores the results in another matrix.static booleanCovarianceOps_DDRM.invert(DMatrixRMaj cov) Performs a matrix inversion operations that takes advantage of the special properties of a covariance matrix.static booleanCovarianceOps_DDRM.invert(DMatrixRMaj cov, DMatrixRMaj cov_inv) Performs a matrix inversion operations that takes advantage of the special properties of a covariance matrix.static booleanCommonOps_DDRM.invertSPD(DMatrixRMaj mat, DMatrixRMaj result) Matrix inverse for symmetric positive definite matrices.static booleanMatrixFeatures_DDRM.isConstantVal(DMatrixRMaj mat, double val, double tol) Checks to see if every value in the matrix is the specified value.static booleanMatrixFeatures_DDRM.isDiagonalNotNegative(DMatrixRMaj a) Checks to see if diagonal element are all not negative, i.e.static booleanMatrixFeatures_DDRM.isDiagonalPositive(DMatrixRMaj a) Checks to see if all the diagonal elements in the matrix are positive.static booleanMatrixFeatures_DDRM.isIdentity(DMatrixRMaj mat, double tol) Checks to see if the provided matrix is within tolerance to an identity matrix.static booleanMatrixFeatures_DDRM.isInverse(DMatrixRMaj a, DMatrixRMaj b, double tol) Checks to see if the two matrices are inverses of each other.static booleanMatrixFeatures_DDRM.isLowerTriangle(DMatrixRMaj A, int hessenberg, double tol) Checks to see if a matrix is lower triangular or Hessenberg.static booleanMatrixFeatures_DDRM.isOrthogonal(DMatrixRMaj Q, double tol) Checks to see if a matrix is orthogonal or isometric.static booleanMatrixFeatures_DDRM.isPositiveDefinite(DMatrixRMaj A) Checks to see if the matrix is positive definite.static booleanMatrixFeatures_DDRM.isPositiveSemidefinite(DMatrixRMaj A) Checks to see if the matrix is positive semidefinite:static booleanMatrixFeatures_DDRM.isRowsLinearIndependent(DMatrixRMaj A) Checks to see if the rows of the provided matrix are linearly independent.static booleanMatrixFeatures_DDRM.isSkewSymmetric(DMatrixRMaj A, double tol) Checks to see if a matrix is skew symmetric with in tolerance:
-A = AT
or
|aij + aji| ≤ tolstatic booleanMatrixFeatures_DDRM.isSymmetric(DMatrixRMaj m) Returns true if the matrix is perfectly symmetric.static booleanMatrixFeatures_DDRM.isSymmetric(DMatrixRMaj m, double tol) Returns true if the matrix is symmetric within the tolerance.static booleanMatrixFeatures_DDRM.isUpperTriangle(DMatrixRMaj A, int hessenberg, double tol) Checks to see if a matrix is upper triangular or Hessenberg.static intCovarianceOps_DDRM.isValid(DMatrixRMaj cov) Performs a variety of tests to see if the provided matrix is a valid covariance matrix, performing the fastest checks first.static booleanCovarianceOps_DDRM.isValidFast(DMatrixRMaj cov) This is a fairly light weight check to see of a covariance matrix is valid.static DMatrixRMajCommonOps_DDRM.kron(DMatrixRMaj A, DMatrixRMaj B, @Nullable DMatrixRMaj C) The Kronecker product of two matrices is defined as:
Cij = aijB
where Cij is a sub matrix inside of C ∈ ℜ m*k × n*l, A ∈ ℜ m × n, and B ∈ ℜ k × l.static DMatrixRMajCommonOps_ZDRM.magnitude(ZMatrixD1 input, @Nullable DMatrixRMaj output) Computes the magnitude of the complex number in the input matrix and stores the results in the output matrix.static DMatrixRMajCommonOps_DDRM.maxCols(DMatrixRMaj input, @Nullable DMatrixRMaj output) Finds the element with the minimum value along column in the input matrix and returns the results in a vector:
bj = min(i=1:m ; aij)static DMatrixRMajCommonOps_DDRM.maxRows(DMatrixRMaj input, @Nullable DMatrixRMaj output) Finds the element with the maximum value along each row in the input matrix and returns the results in a vector:
bj = max(i=1:n ; aji)static DMatrixRMajCommonOps_DDRM.minCols(DMatrixRMaj input, @Nullable DMatrixRMaj output) Finds the element with the minimum value along column in the input matrix and returns the results in a vector:
bj = min(i=1:m ; aij)static DMatrixRMajCommonOps_DDRM.minRows(DMatrixRMaj input, @Nullable DMatrixRMaj output) Finds the element with the minimum value along each row in the input matrix and returns the results in a vector:
bj = min(i=1:n ; aji)static voidCommonOps_DDRM.multCols(DMatrixRMaj A, double[] values) Multiplies every element in column i by value[i].static voidSpecializedOps_DDRM.multLowerTranA(DMatrixRMaj mat) Performs L = LT*Lstatic voidSpecializedOps_DDRM.multLowerTranB(DMatrixRMaj mat) Performs L = L*LTstatic voidCommonOps_DDRM.multRows(double[] values, DMatrixRMaj A) Multiplies every element in row i by value[i].voidCovarianceRandomDraw_DDRM.next(DMatrixRMaj x) Makes a draw on the distribution.static voidNormOps_DDRM.normalizeF(DMatrixRMaj A) Normalizes the matrix such that the Frobenius norm is equal to one.static doubleNormOps_DDRM.normP(DMatrixRMaj A, double p) Computes either the vector p-norm or the induced matrix p-norm depending on A being a vector or a matrix respectively.static doubleNormOps_DDRM.normP1(DMatrixRMaj A) Computes the p=1 norm.static doubleNormOps_DDRM.normP2(DMatrixRMaj A) Computes the p=2 norm.static doubleNormOps_DDRM.normPInf(DMatrixRMaj A) Computes the p=∞ norm.static intMatrixFeatures_DDRM.nullity(DMatrixRMaj A) Computes the nullity of a matrix using the default tolerance.static intMatrixFeatures_DDRM.nullity(DMatrixRMaj A, double threshold) Computes the nullity of a matrix using the specified tolerance.static intSingularOps_DDRM.nullity(DMatrixRMaj A, double threshold) Returns the matrix's nullitystatic DMatrixRMajSingularOps_DDRM.nullSpace(SingularValueDecomposition_F64<DMatrixRMaj> svd, @Nullable DMatrixRMaj nullSpace, double tol) Returns the null-space from the singular value decomposition.static DMatrixRMajSingularOps_DDRM.nullspaceQR(DMatrixRMaj A, int totalSingular) Computes the null space using QR decomposition.static DMatrixRMajSingularOps_DDRM.nullspaceQRP(DMatrixRMaj A, int totalSingular) Computes the null space using QRP decomposition.static DMatrixRMajSingularOps_DDRM.nullspaceSVD(DMatrixRMaj A, int totalSingular) Computes the null space using SVD.static DMatrixRMajSingularOps_DDRM.nullVector(SingularValueDecomposition_F64<DMatrixRMaj> svd, boolean isRight, @Nullable DMatrixRMaj nullVector) The vector associated will the smallest singular value is returned as the null space of the decomposed system.static DMatrixRMajCommonOps_DDRM.permuteRowInv(int[] pinv, DMatrixRMaj input, DMatrixRMaj output) Applies the row permutation specified by the vector to the input matrix and save the results in the output matrix.static voidCommonOps_DDRM.pinv(DMatrixRMaj A, DMatrixRMaj invA) Computes the Moore-Penrose pseudo-inverse:
pinv(A) = (ATA)-1 AT
or
pinv(A) = AT(AAT)-1static DMatrixRMajSpecializedOps_DDRM.pivotMatrix(@Nullable DMatrixRMaj ret, int[] pivots, int numPivots, boolean transposed) Creates a pivot matrix that exchanges the rows in a matrix:
A' = P*Astatic voidCovarianceOps_DDRM.randomVector(DMatrixRMaj cov, DMatrixRMaj vector, Random rand) Sets vector to a random value based upon a zero-mean multivariate Gaussian distribution with covariance 'cov'.static intMatrixFeatures_DDRM.rank(DMatrixRMaj A) Computes the rank of a matrix using a default tolerance.static intMatrixFeatures_DDRM.rank(DMatrixRMaj A, double threshold) Computes the rank of a matrix using the specified tolerance.static intSingularOps_DDRM.rank(DMatrixRMaj A) Returns the matrix's rank.static intSingularOps_DDRM.rank(DMatrixRMaj A, double threshold) Returns the matrix's rankstatic DMatrixRMajCommonOps_ZDRM.real(ZMatrixD1 input, @Nullable DMatrixRMaj output) Places the real component of the input matrix into the output matrix.static voidCommonOps_DDRM.removeColumns(DMatrixRMaj A, int col0, int col1) Removes columns from the matrix.static DMatrixRMaj[]CommonOps_DDRM.rowsToVector(DMatrixRMaj A, @Nullable DMatrixRMaj[] v) Converts the rows in a matrix into a set of vectors.static DMatrixRMajCommonOps_DDRM.rref(DMatrixRMaj A, int numUnknowns, @Nullable DMatrixRMaj reduced) Puts the augmented system matrix into reduced row echelon form (RREF) using Gauss-Jordan elimination with row (partial) pivots.static voidCommonOps_DDRM.scaleCol(double alpha, DMatrixRMaj A, int col) In-place scaling of a column in Astatic voidCommonOps_DDRM.scaleRow(double alpha, DMatrixRMaj A, int row) In-place scaling of a row in Astatic double[]SingularOps_DDRM.singularValues(DMatrixRMaj A) Returns an array of all the singular values in A sorted in ascending orderstatic booleanCommonOps_DDRM.solve(DMatrixRMaj a, DMatrixRMaj b, DMatrixRMaj x) Solves for x in the following equation:
A*x = bstatic booleanCommonOps_DDRM.solveSPD(DMatrixRMaj A, DMatrixRMaj b, DMatrixRMaj x) Linear solver for systems which are symmetric positive definite.
A*x = bstatic DMatrixRMajCommonOps_DDRM.sumCols(DMatrixRMaj input, @Nullable DMatrixRMaj output) Computes the sum of each column in the input matrix and returns the results in a vector:
bj = sum(i=1:m ; aij)static DMatrixRMajCommonOps_DDRM.sumRows(DMatrixRMaj input, @Nullable DMatrixRMaj output) Computes the sum of each row in the input matrix and returns the results in a vector:
bj = sum(i=1:n ; aji)static booleanSingularOps_DDRM.svd(DMatrixRMaj A, @Nullable DMatrixRMaj U, DGrowArray sv, @Nullable DMatrixRMaj Vt) Computes the SVD and sorts singular values in descending order.static voidRandomMatrices_DDRM.symmetric(DMatrixRMaj A, double min, double max, Random rand) Sets the provided square matrix to be a random symmetric matrix whose values are selected from an uniform distribution from min to max, inclusive.static voidCommonOps_DDRM.symmLowerToFull(DMatrixRMaj A) Given a symmetric matrix which is represented by a lower triangular matrix convert it back into a full symmetric matrix.static voidCommonOps_DDRM.symmUpperToFull(DMatrixRMaj A) Given a symmetric matrix which is represented by a lower triangular matrix convert it back into a full symmetric matrix.static voidCommonOps_DDRM.transpose(DMatrixRMaj mat) Performs an "in-place" transpose.static DMatrixRMajCommonOps_DDRM.transpose(DMatrixRMaj A, @Nullable DMatrixRMaj A_tran) Transposes matrix 'a' and stores the results in 'b':
bij = aji
where 'b' is the transpose of 'a'.static voidCommonOps_MT_DDRM.transpose(DMatrixRMaj mat) Performs an "in-place" transpose.static DMatrixRMajCommonOps_MT_DDRM.transpose(DMatrixRMaj A, @Nullable DMatrixRMaj A_tran) Transposes matrix 'a' and stores the results in 'b':
bij = aji
where 'b' is the transpose of 'a'.Method parameters in org.ejml.dense.row with type arguments of type DMatrixRMajModifier and TypeMethodDescriptionstatic DMatrixRMajEigenOps_DDRM.createMatrixV(EigenDecomposition_F64<DMatrixRMaj> eig) Puts all the real eigenvectors into the columns of a matrix.static DMatrixRMajSingularOps_DDRM.nullSpace(SingularValueDecomposition_F64<DMatrixRMaj> svd, @Nullable DMatrixRMaj nullSpace, double tol) Returns the null-space from the singular value decomposition.static DMatrixRMajSingularOps_DDRM.nullVector(SingularValueDecomposition_F64<DMatrixRMaj> svd, boolean isRight, @Nullable DMatrixRMaj nullVector) The vector associated will the smallest singular value is returned as the null space of the decomposed system.Constructors in org.ejml.dense.row with parameters of type DMatrixRMajModifierConstructorDescriptionCovarianceRandomDraw_DDRM(Random rand, DMatrixRMaj cov) Creates a random distribution with the specified mean and covariance. -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition
Methods in org.ejml.dense.row.decomposition that return DMatrixRMajModifier and TypeMethodDescriptionstatic DMatrixRMajUtilDecompositons_DDRM.checkZerosLT(@Nullable DMatrixRMaj A, int numRows, int numCols) Creates a zeros matrix only if A does not already exist.static DMatrixRMajUtilDecompositons_DDRM.checkZerosUT(@Nullable DMatrixRMaj A, int numRows, int numCols) Creates a zeros matrix only if A does not already exist.static DMatrixRMajUtilDecompositons_DDRM.ensureIdentity(@Nullable DMatrixRMaj A, int numRows, int numCols) static DMatrixRMajUtilDecompositons_DDRM.ensureZeros(@Nullable DMatrixRMaj A, int numRows, int numCols) Methods in org.ejml.dense.row.decomposition with parameters of type DMatrixRMajModifier and TypeMethodDescriptionstatic DMatrixRMajUtilDecompositons_DDRM.checkZerosLT(@Nullable DMatrixRMaj A, int numRows, int numCols) Creates a zeros matrix only if A does not already exist.static DMatrixRMajUtilDecompositons_DDRM.checkZerosUT(@Nullable DMatrixRMaj A, int numRows, int numCols) Creates a zeros matrix only if A does not already exist.booleanBaseDecomposition_DDRB_to_DDRM.decompose(DMatrixRMaj A) static DMatrixRMajUtilDecompositons_DDRM.ensureIdentity(@Nullable DMatrixRMaj A, int numRows, int numCols) static DMatrixRMajUtilDecompositons_DDRM.ensureZeros(@Nullable DMatrixRMaj A, int numRows, int numCols) -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.bidiagonal
Methods in org.ejml.dense.row.decomposition.bidiagonal that return DMatrixRMajModifier and TypeMethodDescriptionBidiagonalDecompositionRow_DDRM.getB(@Nullable DMatrixRMaj B, boolean compact) Returns the bidiagonal matrix.BidiagonalDecompositionTall_DDRM.getB(@Nullable DMatrixRMaj B, boolean compact) BidiagonalDecompositionTall_MT_DDRM.getB(@Nullable DMatrixRMaj B, boolean compact) BidiagonalDecompositionRow_DDRM.getU(@Nullable DMatrixRMaj U, boolean transpose, boolean compact) Returns the orthogonal U matrix.BidiagonalDecompositionTall_DDRM.getU(@Nullable DMatrixRMaj U, boolean transpose, boolean compact) BidiagonalDecompositionTall_MT_DDRM.getU(@Nullable DMatrixRMaj U, boolean transpose, boolean compact) BidiagonalDecompositionRow_DDRM.getUBV()The raw UBV matrix that is stored internally.BidiagonalDecompositionRow_DDRM.getV(@Nullable DMatrixRMaj V, boolean transpose, boolean compact) Returns the orthogonal V matrix.BidiagonalDecompositionTall_DDRM.getV(@Nullable DMatrixRMaj V, boolean transpose, boolean compact) BidiagonalDecompositionTall_MT_DDRM.getV(@Nullable DMatrixRMaj V, boolean transpose, boolean compact) static DMatrixRMajBidiagonalDecompositionRow_DDRM.handleB(@Nullable DMatrixRMaj B, boolean compact, int m, int n, int min) static DMatrixRMajBidiagonalDecompositionRow_DDRM.handleU(@Nullable DMatrixRMaj U, boolean transpose, boolean compact, int m, int n, int min) static DMatrixRMajBidiagonalDecompositionRow_DDRM.handleV(@Nullable DMatrixRMaj V, boolean transpose, boolean compact, int m, int n, int min) Methods in org.ejml.dense.row.decomposition.bidiagonal with parameters of type DMatrixRMajModifier and TypeMethodDescriptionbooleanBidiagonalDecompositionRow_DDRM.decompose(DMatrixRMaj A) Computes the decomposition of the provided matrix.booleanBidiagonalDecompositionTall_DDRM.decompose(DMatrixRMaj orig) booleanBidiagonalDecompositionTall_MT_DDRM.decompose(DMatrixRMaj orig) BidiagonalDecompositionRow_DDRM.getB(@Nullable DMatrixRMaj B, boolean compact) Returns the bidiagonal matrix.BidiagonalDecompositionTall_DDRM.getB(@Nullable DMatrixRMaj B, boolean compact) BidiagonalDecompositionTall_MT_DDRM.getB(@Nullable DMatrixRMaj B, boolean compact) BidiagonalDecompositionRow_DDRM.getU(@Nullable DMatrixRMaj U, boolean transpose, boolean compact) Returns the orthogonal U matrix.BidiagonalDecompositionTall_DDRM.getU(@Nullable DMatrixRMaj U, boolean transpose, boolean compact) BidiagonalDecompositionTall_MT_DDRM.getU(@Nullable DMatrixRMaj U, boolean transpose, boolean compact) BidiagonalDecompositionRow_DDRM.getV(@Nullable DMatrixRMaj V, boolean transpose, boolean compact) Returns the orthogonal V matrix.BidiagonalDecompositionTall_DDRM.getV(@Nullable DMatrixRMaj V, boolean transpose, boolean compact) BidiagonalDecompositionTall_MT_DDRM.getV(@Nullable DMatrixRMaj V, boolean transpose, boolean compact) static DMatrixRMajBidiagonalDecompositionRow_DDRM.handleB(@Nullable DMatrixRMaj B, boolean compact, int m, int n, int min) static DMatrixRMajBidiagonalDecompositionRow_DDRM.handleU(@Nullable DMatrixRMaj U, boolean transpose, boolean compact, int m, int n, int min) static DMatrixRMajBidiagonalDecompositionRow_DDRM.handleV(@Nullable DMatrixRMaj V, boolean transpose, boolean compact, int m, int n, int min) protected voidBidiagonalDecompositionRow_DDRM.init(DMatrixRMaj A) Sets up internal data structures and creates a copy of the input matrix.protected voidBidiagonalDecompositionRow_DDRM.rank1UpdateMultL(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected voidBidiagonalDecompositionRow_MT_DDRM.rank1UpdateMultL(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected voidBidiagonalDecompositionRow_DDRM.rank1UpdateMultR(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected voidBidiagonalDecompositionRow_MT_DDRM.rank1UpdateMultR(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.chol
Fields in org.ejml.dense.row.decomposition.chol declared as DMatrixRMajMethods in org.ejml.dense.row.decomposition.chol that return DMatrixRMajModifier and TypeMethodDescriptionCholeskyDecompositionLDL_DDRM.getD(@Nullable DMatrixRMaj D) CholeskyDecompositionLDL_DDRM.getL()Returns L matrix from the decomposition.
L*D*LT=ACholeskyDecompositionLDL_DDRM.getL(@Nullable DMatrixRMaj L) CholeskyDecomposition_DDRB_to_DDRM.getT(@Nullable DMatrixRMaj T) CholeskyDecompositionCommon_DDRM.getT()Returns the triangular matrix from the decomposition.CholeskyDecompositionCommon_DDRM.getT(@Nullable DMatrixRMaj T) Methods in org.ejml.dense.row.decomposition.chol with parameters of type DMatrixRMajModifier and TypeMethodDescriptionbooleanCholeskyDecompositionCommon_DDRM.decompose(DMatrixRMaj mat) Performs Choleksy decomposition on the provided matrix.booleanCholeskyDecompositionLDL_DDRM.decompose(DMatrixRMaj mat) Performs Choleksy decomposition on the provided matrix.CholeskyDecompositionLDL_DDRM.getD(@Nullable DMatrixRMaj D) CholeskyDecompositionLDL_DDRM.getL(@Nullable DMatrixRMaj L) CholeskyDecomposition_DDRB_to_DDRM.getT(@Nullable DMatrixRMaj T) CholeskyDecompositionCommon_DDRM.getT(@Nullable DMatrixRMaj T) voidCholeskyDecompositionBlock_DDRM.solveL_special(double[] L, DMatrixRMaj b_src, int indexSrc, int indexDst, DMatrixRMaj B) This is a variation on theTriangularSolver_DDRM.solveL(double[], double[], int)function.voidCholeskyDecompositionBlock_MT_DDRM.solveL_special(double[] L, DMatrixRMaj b_src, int indexSrc, int indexDst, DMatrixRMaj B) voidCholeskyDecompositionBlock_DDRM.symmRankTranA_sub(DMatrixRMaj a, DMatrixRMaj c, int startIndexC) Performs this operation:
c = c - aTa
where c is a submatrix.voidCholeskyDecompositionBlock_MT_DDRM.symmRankTranA_sub(DMatrixRMaj a, DMatrixRMaj c, int startIndexC) -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.eig
Methods in org.ejml.dense.row.decomposition.eig that return DMatrixRMajModifier and TypeMethodDescriptionEigenPowerMethod_DDRM.getEigenVector()SwitchingEigenDecomposition_DDRM.getEigenVector(int index) SymmetricQRAlgorithmDecomposition_DDRM.getEigenVector(int index) WatchedDoubleStepQRDecomposition_DDRM.getEigenVector(int index) Methods in org.ejml.dense.row.decomposition.eig with parameters of type DMatrixRMajModifier and TypeMethodDescriptionbooleanEigenPowerMethod_DDRM.computeDirect(DMatrixRMaj A) This method computes the eigen vector with the largest eigen value by using the direct power method.booleanEigenPowerMethod_DDRM.computeShiftDirect(DMatrixRMaj A, double alpha) Computes the most dominant eigen vector of A using a shifted matrix.booleanEigenPowerMethod_DDRM.computeShiftInvert(DMatrixRMaj A, double alpha) Computes the most dominant eigen vector of A using an inverted shifted matrix.booleanSwitchingEigenDecomposition_DDRM.decompose(DMatrixRMaj orig) booleanSymmetricQRAlgorithmDecomposition_DDRM.decompose(DMatrixRMaj orig) Decomposes the matrix using the QR algorithm.booleanWatchedDoubleStepQRDecomposition_DDRM.decompose(DMatrixRMaj A) booleanEigenvalueExtractor_DDRM.process(DMatrixRMaj A) voidEigenPowerMethod_DDRM.setSeed(DMatrixRMaj 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 DMatrixRMajModifierConstructorDescriptionSwitchingEigenDecomposition_DDRM(EigenDecomposition_F64<DMatrixRMaj> symmetricAlg, EigenDecomposition_F64<DMatrixRMaj> generalAlg, double tol) SymmetricQRAlgorithmDecomposition_DDRM(TridiagonalSimilarDecomposition_F64<DMatrixRMaj> decomp, boolean computeVectors) -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.eig.symm
Fields in org.ejml.dense.row.decomposition.eig.symm declared as DMatrixRMajMethods in org.ejml.dense.row.decomposition.eig.symm that return DMatrixRMajMethods in org.ejml.dense.row.decomposition.eig.symm with parameters of type DMatrixRMajModifier and TypeMethodDescriptionvoidSymmetricQrAlgorithm_DDRM.setQ(@Nullable DMatrixRMaj q) voidSymmetricQREigenHelper_DDRM.setQ(DMatrixRMaj q) -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.eig.watched
Fields in org.ejml.dense.row.decomposition.eig.watched declared as DMatrixRMajModifier and TypeFieldDescriptionprotected DMatrixRMajWatchedDoubleStepQREigen_DDRM._temp@Nullable DMatrixRMajWatchedDoubleStepQREigen_DDRM.Qprotected DMatrixRMajWatchedDoubleStepQREigen_DDRM.uMethods in org.ejml.dense.row.decomposition.eig.watched that return DMatrixRMajModifier and TypeMethodDescriptionWatchedDoubleStepQREigenvector_DDRM.getEigenvectors()WatchedDoubleStepQREigenvector_DDRM.getQ()Methods in org.ejml.dense.row.decomposition.eig.watched with parameters of type DMatrixRMajModifier and TypeMethodDescriptionbooleanWatchedDoubleStepQREigenvector_DDRM.extractVectors(DMatrixRMaj Q_h) booleanWatchedDoubleStepQREigenvalue_DDRM.process(DMatrixRMaj origA) booleanWatchedDoubleStepQREigenvector_DDRM.process(WatchedDoubleStepQREigen_DDRM implicit, DMatrixRMaj A, DMatrixRMaj Q_h) protected voidWatchedDoubleStepQREigen_DDRM.rank1UpdateMultL(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected voidWatchedDoubleStepQREigen_MT_DDRM.rank1UpdateMultL(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected voidWatchedDoubleStepQREigen_DDRM.rank1UpdateMultR(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected voidWatchedDoubleStepQREigen_MT_DDRM.rank1UpdateMultR(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) voidWatchedDoubleStepQREigen_DDRM.setQ(@Nullable DMatrixRMaj Q) voidWatchedDoubleStepQREigen_DDRM.setup(DMatrixRMaj A) voidWatchedDoubleStepQREigenvalue_DDRM.setup(DMatrixRMaj A) -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.hessenberg
Fields in org.ejml.dense.row.decomposition.hessenberg declared as DMatrixRMajModifier and TypeFieldDescriptionprotected DMatrixRMajTridiagonalDecompositionHouseholder_DDRM.QTOnly the upper right triangle is used.Methods in org.ejml.dense.row.decomposition.hessenberg that return DMatrixRMajModifier and TypeMethodDescriptionHessenbergSimilarDecomposition_DDRM.getH(@Nullable DMatrixRMaj H) An upper Hessenberg matrix from the decomposition.HessenbergSimilarDecomposition_DDRM.getQ(@Nullable DMatrixRMaj Q) An orthogonal matrix that has the following property: H = QTAQTridiagonalDecomposition_DDRB_to_DDRM.getQ(@Nullable DMatrixRMaj Q, boolean transposed) TridiagonalDecompositionHouseholder_DDRM.getQ(@Nullable DMatrixRMaj Q, boolean transposed) An orthogonal matrix that has the following property: T = QTAQTridiagonalDecompositionHouseholderOrig_DDRM.getQ(@Nullable DMatrixRMaj Q) An orthogonal matrix that has the following property: T = QTAQHessenbergSimilarDecomposition_DDRM.getQH()The raw QH matrix that is stored internally.TridiagonalDecompositionHouseholder_DDRM.getQT()Returns the internal matrix where the decomposed results are stored.TridiagonalDecompositionHouseholderOrig_DDRM.getQT()Returns the interal matrix where the decomposed results are stored.TridiagonalDecomposition_DDRB_to_DDRM.getT(@Nullable DMatrixRMaj T) TridiagonalDecompositionHouseholder_DDRM.getT(@Nullable DMatrixRMaj T) Extracts the tridiagonal matrix found in the decomposition.TridiagonalDecompositionHouseholderOrig_DDRM.getT(@Nullable DMatrixRMaj T) Extracts the tridiagonal matrix found in the decomposition.Methods in org.ejml.dense.row.decomposition.hessenberg with parameters of type DMatrixRMajModifier and TypeMethodDescriptionbooleanHessenbergSimilarDecomposition_DDRM.decompose(DMatrixRMaj A) Computes the decomposition of the provided matrix.booleanTridiagonalDecompositionHouseholder_DDRM.decompose(DMatrixRMaj A) Decomposes the provided symmetric matrix.voidTridiagonalDecompositionHouseholderOrig_DDRM.decompose(DMatrixRMaj A) Decomposes the provided symmetric matrix.HessenbergSimilarDecomposition_DDRM.getH(@Nullable DMatrixRMaj H) An upper Hessenberg matrix from the decomposition.HessenbergSimilarDecomposition_DDRM.getQ(@Nullable DMatrixRMaj Q) An orthogonal matrix that has the following property: H = QTAQTridiagonalDecomposition_DDRB_to_DDRM.getQ(@Nullable DMatrixRMaj Q, boolean transposed) TridiagonalDecompositionHouseholder_DDRM.getQ(@Nullable DMatrixRMaj Q, boolean transposed) An orthogonal matrix that has the following property: T = QTAQTridiagonalDecompositionHouseholderOrig_DDRM.getQ(@Nullable DMatrixRMaj Q) An orthogonal matrix that has the following property: T = QTAQTridiagonalDecomposition_DDRB_to_DDRM.getT(@Nullable DMatrixRMaj T) TridiagonalDecompositionHouseholder_DDRM.getT(@Nullable DMatrixRMaj T) Extracts the tridiagonal matrix found in the decomposition.TridiagonalDecompositionHouseholderOrig_DDRM.getT(@Nullable DMatrixRMaj T) Extracts the tridiagonal matrix found in the decomposition.voidTridiagonalDecompositionHouseholder_DDRM.init(DMatrixRMaj A) If needed declares and sets up internal data structures.voidTridiagonalDecompositionHouseholderOrig_DDRM.init(DMatrixRMaj A) If needed declares and sets up internal data structures.protected voidHessenbergSimilarDecomposition_DDRM.rank1UpdateMultL(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected voidHessenbergSimilarDecomposition_MT_DDRM.rank1UpdateMultL(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected voidTridiagonalDecompositionHouseholder_DDRM.rank1UpdateMultL(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected voidTridiagonalDecompositionHouseholder_MT_DDRM.rank1UpdateMultL(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected voidHessenbergSimilarDecomposition_DDRM.rank1UpdateMultR(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected voidHessenbergSimilarDecomposition_MT_DDRM.rank1UpdateMultR(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected voidTridiagonalDecompositionHouseholder_DDRM.rank1UpdateMultR(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) protected voidTridiagonalDecompositionHouseholder_MT_DDRM.rank1UpdateMultR(DMatrixRMaj A, double gamma, int colA0, int w0, int w1) -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.lu
Fields in org.ejml.dense.row.decomposition.lu declared as DMatrixRMajMethods in org.ejml.dense.row.decomposition.lu that return DMatrixRMajModifier and TypeMethodDescriptionLUDecompositionBase_DDRM.getLower(@Nullable DMatrixRMaj lower) Writes the lower triangular matrix into the specified matrix.LUDecompositionBase_DDRM.getLU()LUDecompositionBase_DDRM.getRowPivot(@Nullable DMatrixRMaj pivot) LUDecompositionBase_DDRM.getUpper(@Nullable DMatrixRMaj upper) Writes the upper triangular matrix into the specified matrix.Methods in org.ejml.dense.row.decomposition.lu with parameters of type DMatrixRMajModifier and TypeMethodDescriptionbooleanLUDecompositionAlt_DDRM.decompose(DMatrixRMaj a) This is a modified version of what was found in the JAMA package.protected voidLUDecompositionBase_DDRM.decomposeCommonInit(DMatrixRMaj a) LUDecompositionBase_DDRM.getLower(@Nullable DMatrixRMaj lower) Writes the lower triangular matrix into the specified matrix.LUDecompositionBase_DDRM.getRowPivot(@Nullable DMatrixRMaj pivot) LUDecompositionBase_DDRM.getUpper(@Nullable DMatrixRMaj upper) Writes the upper triangular matrix into the specified matrix. -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.qr
Fields in org.ejml.dense.row.decomposition.qr declared as DMatrixRMajModifier and TypeFieldDescriptionprotected DMatrixRMajQRDecompositionHouseholder_DDRM.QRWhere the Q and R matrices are stored.protected DMatrixRMajQRDecompositionHouseholderTran_DDRM.QRWhere the Q and R matrices are stored.Methods in org.ejml.dense.row.decomposition.qr that return DMatrixRMajModifier and TypeMethodDescriptionQRColPivDecompositionHouseholderColumn_DDRM.getColPivotMatrix(@Nullable DMatrixRMaj P) QRColPivDecompositionHouseholderColumn_DDRM.getQ(@Nullable DMatrixRMaj Q, boolean compact) Computes the Q matrix from the information stored in the QR matrix.QRDecomposition_DDRB_to_DDRM.getQ(@Nullable DMatrixRMaj Q, boolean compact) QRDecompositionHouseholder_DDRM.getQ(@Nullable DMatrixRMaj Q, boolean compact) Computes the Q matrix from the imformation stored in the QR matrix.QRDecompositionHouseholderColumn_DDRM.getQ(@Nullable DMatrixRMaj Q, boolean compact) Computes the Q matrix from the imformation stored in the QR matrix.QRDecompositionHouseholderColumn_MT_DDRM.getQ(@Nullable DMatrixRMaj Q, boolean compact) QRDecompositionHouseholderTran_DDRM.getQ(@Nullable DMatrixRMaj Q, boolean compact) Computes the Q matrix from the information stored in the QR matrix.QRDecompositionHouseholder_DDRM.getQR()Returns a single matrix which contains the combined values of Q and R.QRDecompositionHouseholderTran_DDRM.getQR()Inner matrix that stores the decompositionQRDecomposition_DDRB_to_DDRM.getR(@Nullable DMatrixRMaj R, boolean compact) QRDecompositionHouseholder_DDRM.getR(@Nullable DMatrixRMaj R, boolean compact) Returns an upper triangular matrix which is the R in the QR decomposition.QRDecompositionHouseholderColumn_DDRM.getR(@Nullable DMatrixRMaj R, boolean compact) Returns an upper triangular matrix which is the R in the QR decomposition.QRDecompositionHouseholderTran_DDRM.getR(@Nullable DMatrixRMaj R, boolean compact) Returns an upper triangular matrix which is the R in the QR decomposition.QrUpdate_DDRM.getU_tran()Methods in org.ejml.dense.row.decomposition.qr with parameters of type DMatrixRMajModifier and TypeMethodDescriptionvoidQrUpdate_DDRM.addRow(DMatrixRMaj Q, DMatrixRMaj R, double[] row, int rowIndex, boolean resizeR) Adjusts the values of the Q and R matrices to take in account the effects of inserting a row to the 'A' matrix at the specified location.voidQRDecompositionHouseholderTran_DDRM.applyQ(DMatrixRMaj A) A = Q*AvoidQRDecompositionHouseholderTran_DDRM.applyTranQ(DMatrixRMaj A) A = QT*Aprotected voidQRDecompositionHouseholder_DDRM.commonSetup(DMatrixRMaj A) This function performs sanity check on the input for decompose and sets up the QR matrix.protected voidQRDecompositionHouseholderColumn_DDRM.convertToColumnMajor(DMatrixRMaj A) Converts the standard row-major matrix into a column-major vector that is advantageous for this problem.booleanQRColPivDecompositionHouseholderColumn_DDRM.decompose(DMatrixRMaj A) To decompose the matrix 'A' it must have full rank.booleanQRDecompositionHouseholder_DDRM.decompose(DMatrixRMaj A) In order to decompose the matrix 'A' it must have full rank.booleanQRDecompositionHouseholderColumn_DDRM.decompose(DMatrixRMaj A) To decompose the matrix 'A' it must have full rank.booleanQRDecompositionHouseholderTran_DDRM.decompose(DMatrixRMaj A) To decompose the matrix 'A' it must have full rank.voidQrUpdate_DDRM.deleteRow(DMatrixRMaj Q, DMatrixRMaj R, int rowIndex, boolean resizeR) Adjusts the values of the Q and R matrices to take in account the effects of removing a row from the 'A' matrix at the specified location.QRColPivDecompositionHouseholderColumn_DDRM.getColPivotMatrix(@Nullable DMatrixRMaj P) QRColPivDecompositionHouseholderColumn_DDRM.getQ(@Nullable DMatrixRMaj Q, boolean compact) Computes the Q matrix from the information stored in the QR matrix.QRDecomposition_DDRB_to_DDRM.getQ(@Nullable DMatrixRMaj Q, boolean compact) QRDecompositionHouseholder_DDRM.getQ(@Nullable DMatrixRMaj Q, boolean compact) Computes the Q matrix from the imformation stored in the QR matrix.QRDecompositionHouseholderColumn_DDRM.getQ(@Nullable DMatrixRMaj Q, boolean compact) Computes the Q matrix from the imformation stored in the QR matrix.QRDecompositionHouseholderColumn_MT_DDRM.getQ(@Nullable DMatrixRMaj Q, boolean compact) QRDecompositionHouseholderTran_DDRM.getQ(@Nullable DMatrixRMaj Q, boolean compact) Computes the Q matrix from the information stored in the QR matrix.QRDecomposition_DDRB_to_DDRM.getR(@Nullable DMatrixRMaj R, boolean compact) QRDecompositionHouseholder_DDRM.getR(@Nullable DMatrixRMaj R, boolean compact) Returns an upper triangular matrix which is the R in the QR decomposition.QRDecompositionHouseholderColumn_DDRM.getR(@Nullable DMatrixRMaj R, boolean compact) Returns an upper triangular matrix which is the R in the QR decomposition.QRDecompositionHouseholderTran_DDRM.getR(@Nullable DMatrixRMaj R, boolean compact) Returns an upper triangular matrix which is the R in the QR decomposition.static voidQrHelperFunctions_DDRM.rank1UpdateMultL(DMatrixRMaj A, double[] u, double gamma, int colA0, int w0, int w1) Performs a rank-1 update operation on the submatrix specified by w with the multiply on the left.
A = A(I - γ*u*uT)static voidQrHelperFunctions_MT_DDRM.rank1UpdateMultL(DMatrixRMaj A, double[] u, double gamma, int colA0, int w0, int w1) Performs a rank-1 update operation on the submatrix specified by w with the multiply on the left.
A = A(I - γ*u*uT)static voidQrHelperFunctions_DDRM.rank1UpdateMultR(DMatrixRMaj A, double[] u, double gamma, int colA0, int w0, int w1, double[] _temp) Performs a rank-1 update operation on the submatrix specified by w with the multiply on the right.
A = (I - γ*u*uT)*Astatic voidQrHelperFunctions_DDRM.rank1UpdateMultR(DMatrixRMaj A, double[] u, int offsetU, double gamma, int colA0, int w0, int w1, double[] _temp) static voidQrHelperFunctions_MT_DDRM.rank1UpdateMultR(DMatrixRMaj A, double[] u, double gamma, int colA0, int w0, int w1, double[] _temp) Performs a rank-1 update operation on the submatrix specified by w with the multiply on the right.
A = (I - γ*u*uT)*Astatic voidQrHelperFunctions_MT_DDRM.rank1UpdateMultR(DMatrixRMaj A, double[] u, int offsetU, double gamma, int colA0, int w0, int w1, double[] _temp) static voidQrHelperFunctions_DDRM.rank1UpdateMultR_u0(DMatrixRMaj A, double[] u, double u_0, double gamma, int colA0, int w0, int w1, double[] _temp) static voidQrHelperFunctions_MT_DDRM.rank1UpdateMultR_u0(DMatrixRMaj A, double[] u, double u_0, double gamma, int colA0, int w0, int w1, double[] _temp) -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.svd
Fields in org.ejml.dense.row.decomposition.svd with type parameters of type DMatrixRMajModifier and TypeFieldDescriptionprotected BidiagonalDecomposition_F64<DMatrixRMaj>SvdImplicitQrDecompose_DDRM.bidiagMethods in org.ejml.dense.row.decomposition.svd that return DMatrixRMajModifier and TypeMethodDescriptionSafeSvd_DDRM.getU(@Nullable DMatrixRMaj U, boolean transposed) SvdImplicitQrDecompose_DDRM.getU(@Nullable DMatrixRMaj U, boolean transpose) SafeSvd_DDRM.getV(@Nullable DMatrixRMaj V, boolean transposed) SvdImplicitQrDecompose_DDRM.getV(@Nullable DMatrixRMaj V, boolean transpose) SafeSvd_DDRM.getW(@Nullable DMatrixRMaj W) SvdImplicitQrDecompose_DDRM.getW(@Nullable DMatrixRMaj W) Methods in org.ejml.dense.row.decomposition.svd with parameters of type DMatrixRMajModifier and TypeMethodDescriptionbooleanSafeSvd_DDRM.decompose(DMatrixRMaj orig) booleanSvdImplicitQrDecompose_DDRM.decompose(DMatrixRMaj orig) SafeSvd_DDRM.getU(@Nullable DMatrixRMaj U, boolean transposed) SvdImplicitQrDecompose_DDRM.getU(@Nullable DMatrixRMaj U, boolean transpose) SafeSvd_DDRM.getV(@Nullable DMatrixRMaj V, boolean transposed) SvdImplicitQrDecompose_DDRM.getV(@Nullable DMatrixRMaj V, boolean transpose) SafeSvd_DDRM.getW(@Nullable DMatrixRMaj W) SvdImplicitQrDecompose_DDRM.getW(@Nullable DMatrixRMaj W) protected voidSvdImplicitQrDecompose_DDRM.transpose(@NotNull DMatrixRMaj V, DMatrixRMaj Vt) protected voidSvdImplicitQrDecompose_MT_DDRM.transpose(@NotNull DMatrixRMaj V, DMatrixRMaj Vt) Constructor parameters in org.ejml.dense.row.decomposition.svd with type arguments of type DMatrixRMaj -
Uses of DMatrixRMaj in org.ejml.dense.row.decomposition.svd.implicitqr
Fields in org.ejml.dense.row.decomposition.svd.implicitqr declared as DMatrixRMajModifier and TypeFieldDescriptionprotected @Nullable DMatrixRMajSvdImplicitQrAlgorithm_DDRM.Utprotected @Nullable DMatrixRMajSvdImplicitQrAlgorithm_DDRM.VtMethods in org.ejml.dense.row.decomposition.svd.implicitqr that return DMatrixRMajModifier and TypeMethodDescription@Nullable DMatrixRMajSvdImplicitQrAlgorithm_DDRM.getUt()@Nullable DMatrixRMajSvdImplicitQrAlgorithm_DDRM.getVt()Methods in org.ejml.dense.row.decomposition.svd.implicitqr with parameters of type DMatrixRMajModifier and TypeMethodDescriptionvoidSvdImplicitQrAlgorithm_DDRM.setUt(@Nullable DMatrixRMaj ut) voidSvdImplicitQrAlgorithm_DDRM.setVt(@Nullable DMatrixRMaj vt) protected voidSvdImplicitQrAlgorithm_DDRM.updateRotator(DMatrixRMaj Q, int m, int n, double c, double s) Multiplied a transpose orthogonal matrix Q by the specified rotator. -
Uses of DMatrixRMaj in org.ejml.dense.row.factory
Methods in org.ejml.dense.row.factory that return types with arguments of type DMatrixRMajModifier and TypeMethodDescriptionstatic CholeskyDecomposition_F64<DMatrixRMaj>DecompositionFactory_DDRM.chol(boolean lower) Returns aCholeskyDecomposition_F64that isn't specialized for any specific matrix size.static CholeskyDecomposition_F64<DMatrixRMaj>DecompositionFactory_DDRM.chol(int matrixSize, boolean lower) Returns aCholeskyDecomposition_F64that has been optimized for the specified matrix size.static CholeskyDecomposition_F64<DMatrixRMaj>DecompositionFactory_MT_DDRM.chol(boolean lower) Returns aCholeskyDecomposition_F64that isn't specialized for any specific matrix size.static CholeskyDecomposition_F64<DMatrixRMaj>DecompositionFactory_MT_DDRM.chol(int matrixSize, boolean lower) Returns aCholeskyDecomposition_F64that has been optimized for the specified matrix size.static LinearSolverDense<DMatrixRMaj>LinearSolverFactory_DDRM.chol(int numRows) Creates a linear solver using Cholesky decompositionstatic LinearSolverDense<DMatrixRMaj>LinearSolverFactory_MT_DDRM.chol(int numRows) Creates a linear solver using Cholesky decompositionDecompositionFactory_DDRM.cholLDL()DecompositionFactory_DDRM.cholLDL(int matrixSize) Returns aCholeskyDecompositionLDL_DDRMthat has been optimized for the specified matrix size.static EigenDecomposition_F64<DMatrixRMaj>DecompositionFactory_DDRM.eig(boolean needVectors) static EigenDecomposition_F64<DMatrixRMaj>DecompositionFactory_DDRM.eig(boolean computeVectors, boolean isSymmetric) static EigenDecomposition_F64<DMatrixRMaj>DecompositionFactory_DDRM.eig(int matrixSize, boolean needVectors) Returns anEigenDecompositionthat has been optimized for the specified matrix size.static EigenDecomposition_F64<DMatrixRMaj>DecompositionFactory_DDRM.eig(int matrixSize, boolean computeVectors, boolean isSymmetric) Returns anEigenDecompositionwhich is specialized for symmetric matrices or the general problem.static EigenDecomposition_F64<DMatrixRMaj>DecompositionFactory_MT_DDRM.eig(boolean needVectors) static EigenDecomposition_F64<DMatrixRMaj>DecompositionFactory_MT_DDRM.eig(boolean computeVectors, boolean isSymmetric) static EigenDecomposition_F64<DMatrixRMaj>DecompositionFactory_MT_DDRM.eig(int matrixSize, boolean needVectors) Returns anEigenDecompositionthat has been optimized for the specified matrix size.static EigenDecomposition_F64<DMatrixRMaj>DecompositionFactory_MT_DDRM.eig(int matrixSize, boolean computeVectors, boolean isSymmetric) Returns anEigenDecompositionwhich is specialized for symmetric matrices or the general problem.static LinearSolverDense<DMatrixRMaj>LinearSolverFactory_DDRM.general(int numRows, int numCols) Creates a general purpose solver.static LinearSolverDense<DMatrixRMaj>LinearSolverFactory_DDRM.leastSquares(int numRows, int numCols) Creates a good general purpose solver for over determined systems and returns the optimal least-squares solution.static LinearSolverDense<DMatrixRMaj>LinearSolverFactory_MT_DDRM.leastSquares(int numRows, int numCols) Creates a good general purpose solver for over determined systems and returns the optimal least-squares solution.static LinearSolverDense<DMatrixRMaj>LinearSolverFactory_DDRM.leastSquaresQrPivot(boolean computeNorm2, boolean computeQ) Linear solver which uses QR pivot decomposition.static LinearSolverDense<DMatrixRMaj>LinearSolverFactory_DDRM.linear(int matrixSize) Creates a solver for linear systems.static LUDecomposition_F64<DMatrixRMaj>DecompositionFactory_DDRM.lu()static LUDecomposition_F64<DMatrixRMaj>DecompositionFactory_DDRM.lu(int numRows, int numCol) Returns aLUDecompositionthat has been optimized for the specified matrix size.static LinearSolverDense<DMatrixRMaj>LinearSolverFactory_DDRM.lu(int numRows) Creates a linear solver using LU decompositionstatic LinearSolverDense<DMatrixRMaj>LinearSolverFactory_DDRM.pseudoInverse(boolean useSVD) Returns a solver which uses the pseudo inverse.static QRDecomposition<DMatrixRMaj>DecompositionFactory_DDRM.qr()static QRDecomposition<DMatrixRMaj>DecompositionFactory_DDRM.qr(int numRows, int numCols) Returns aQRDecompositionthat has been optimized for the specified matrix size.static QRDecomposition<DMatrixRMaj>DecompositionFactory_MT_DDRM.qr()static QRDecomposition<DMatrixRMaj>DecompositionFactory_MT_DDRM.qr(int numRows, int numCols) Returns aQRDecompositionthat has been optimized for the specified matrix size.static LinearSolverDense<DMatrixRMaj>LinearSolverFactory_DDRM.qr(int numRows, int numCols) Creates a linear solver using QR decompositionstatic LinearSolverDense<DMatrixRMaj>LinearSolverFactory_MT_DDRM.qr(int numRows, int numCols) Creates a linear solver using QR decompositionstatic QRPDecomposition_F64<DMatrixRMaj>DecompositionFactory_DDRM.qrp()static QRPDecomposition_F64<DMatrixRMaj>DecompositionFactory_DDRM.qrp(int numRows, int numCols) Returns aQRPDecomposition_F64that has been optimized for the specified matrix size.static LinearSolverDense<DMatrixRMaj>LinearSolverFactory_DDRM.qrp(boolean computeNorm2, boolean computeQ) Creates a linear solver using QRP decompositionDecompositionFactory_DDRM.svd(boolean needU, boolean needV, boolean compact) Returns aSingularValueDecompositionthat is NOT optimized for any specified matrix size.DecompositionFactory_DDRM.svd(int numRows, int numCols, boolean needU, boolean needV, boolean compact) Returns aSingularValueDecompositionthat has been optimized for the specified matrix size.DecompositionFactory_MT_DDRM.svd(boolean needU, boolean needV, boolean compact) Returns aSingularValueDecompositionthat is NOT optimized for any specified matrix size.DecompositionFactory_MT_DDRM.svd(int numRows, int numCols, boolean needU, boolean needV, boolean compact) Returns aSingularValueDecompositionthat has been optimized for the specified matrix size.static LinearSolverDense<DMatrixRMaj>LinearSolverFactory_DDRM.symmPosDef(int matrixWidth) Creates a solver for symmetric positive definite matrices.static LinearSolverDense<DMatrixRMaj>LinearSolverFactory_MT_DDRM.symmPosDef(int matrixWidth) Creates a solver for symmetric positive definite matrices.DecompositionFactory_DDRM.tridiagonal(int matrixSize) Checks to see if the passed in tridiagonal decomposition is of the appropriate type for the matrix of the provided size.DecompositionFactory_MT_DDRM.tridiagonal(int matrixSize) Checks to see if the passed in tridiagonal decomposition is of the appropriate type for the matrix of the provided size.Methods in org.ejml.dense.row.factory with parameters of type DMatrixRMajModifier and TypeMethodDescriptionstatic doubleDecompositionFactory_DDRM.quality(DMatrixRMaj orig, DMatrixRMaj U, DMatrixRMaj W, DMatrixRMaj Vt) static doubleDecompositionFactory_DDRM.quality(DMatrixRMaj orig, EigenDecomposition_F64<DMatrixRMaj> eig) Computes a metric which measures the the quality of an eigen value decomposition.static doubleDecompositionFactory_DDRM.quality(DMatrixRMaj orig, SingularValueDecomposition<DMatrixRMaj> 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 DMatrixRMajModifier and TypeMethodDescriptionstatic doubleDecompositionFactory_DDRM.quality(DMatrixRMaj orig, EigenDecomposition_F64<DMatrixRMaj> eig) Computes a metric which measures the the quality of an eigen value decomposition.static doubleDecompositionFactory_DDRM.quality(DMatrixRMaj orig, SingularValueDecomposition<DMatrixRMaj> svd) Computes a metric which measures the the quality of a singular value decomposition. -
Uses of DMatrixRMaj in org.ejml.dense.row.linsol
Fields in org.ejml.dense.row.linsol declared as DMatrixRMajMethods in org.ejml.dense.row.linsol that return DMatrixRMajMethods in org.ejml.dense.row.linsol with parameters of type DMatrixRMajModifier and TypeMethodDescriptionprotected voidLinearSolverAbstract_DDRM._setA(DMatrixRMaj A) static voidInvertUsingSolve_DDRM.invert(LinearSolverDense<DMatrixRMaj> solver, DMatrix1Row A, DMatrixRMaj A_inv) static voidInvertUsingSolve_DDRM.invert(LinearSolverDense<DMatrixRMaj> solver, DMatrix1Row A, DMatrixRMaj A_inv, DMatrixRMaj storage) voidLinearSolver_DDRB_to_DDRM.invert(DMatrixRMaj A_inv) Creates a block matrix the same size as A_inv, inverts the matrix and copies the results back onto A_inv.voidLinearSolverAbstract_DDRM.invert(DMatrixRMaj A_inv) voidLinearSolverUnrolled_DDRM.invert(DMatrixRMaj A_inv) booleanLinearSolver_DDRB_to_DDRM.setA(DMatrixRMaj A) Converts 'A' into a block matrix and call setA() on the block matrix solver.booleanLinearSolverUnrolled_DDRM.setA(DMatrixRMaj A) voidLinearSolver_DDRB_to_DDRM.solve(DMatrixRMaj B, DMatrixRMaj X) Converts B and X into block matrices and calls the block matrix solve routine.voidLinearSolverUnrolled_DDRM.solve(DMatrixRMaj B, DMatrixRMaj X) Method parameters in org.ejml.dense.row.linsol with type arguments of type DMatrixRMajModifier and TypeMethodDescriptionstatic voidInvertUsingSolve_DDRM.invert(LinearSolverDense<DMatrixRMaj> solver, DMatrix1Row A, DMatrixRMaj A_inv) static voidInvertUsingSolve_DDRM.invert(LinearSolverDense<DMatrixRMaj> solver, DMatrix1Row A, DMatrixRMaj A_inv, DMatrixRMaj storage) -
Uses of DMatrixRMaj in org.ejml.dense.row.linsol.chol
Methods in org.ejml.dense.row.linsol.chol that return types with arguments of type DMatrixRMajModifier and TypeMethodDescriptionLinearSolverChol_DDRM.getDecomposition()LinearSolverCholLDL_DDRM.getDecomposition()Methods in org.ejml.dense.row.linsol.chol with parameters of type DMatrixRMajModifier and TypeMethodDescriptionvoidLinearSolverChol_DDRM.invert(DMatrixRMaj inv) Sets the matrix 'inv' equal to the inverse of the matrix that was decomposed.voidLinearSolverCholLDL_DDRM.invert(DMatrixRMaj inv) Sets the matrix 'inv' equal to the inverse of the matrix that was decomposed.booleanLinearSolverChol_DDRM.setA(DMatrixRMaj A) booleanLinearSolverCholLDL_DDRM.setA(DMatrixRMaj A) voidLinearSolverChol_DDRB.solve(DMatrixRMaj B, DMatrixRMaj X) Only converts the B matrix and passes that onto solve.voidLinearSolverChol_DDRM.solve(DMatrixRMaj B, DMatrixRMaj X) Using the decomposition, finds the value of 'X' in the linear equation below:
A*x = b
where A has dimension of n by n, x and b are n by m dimension.voidLinearSolverCholLDL_DDRM.solve(DMatrixRMaj B, DMatrixRMaj X) Using the decomposition, finds the value of 'X' in the linear equation below:
A*x = b
where A has dimension of n by n, x and b are n by m dimension.static voidLinearSolverChol_DDRM.solveLower(DMatrixRMaj L, DMatrixRMaj B, DMatrixRMaj X, double[] vv) -
Uses of DMatrixRMaj in org.ejml.dense.row.linsol.lu
Methods in org.ejml.dense.row.linsol.lu with parameters of type DMatrixRMajModifier and TypeMethodDescriptionvoidLinearSolverLuBase_DDRM.improveSol(DMatrixRMaj b, DMatrixRMaj x) This attempts to improve upon the solution generated by account for numerical imprecisions.voidLinearSolverLuBase_DDRM.invert(DMatrixRMaj A_inv) booleanLinearSolverLuBase_DDRM.setA(DMatrixRMaj A) booleanLinearSolverLuKJI_DDRM.setA(DMatrixRMaj A) voidLinearSolverLu_DDRM.solve(DMatrixRMaj B, DMatrixRMaj X) voidLinearSolverLuKJI_DDRM.solve(DMatrixRMaj B, DMatrixRMaj X) An other implementation of solve() that processes the matrices in a different order. -
Uses of DMatrixRMaj in org.ejml.dense.row.linsol.qr
Fields in org.ejml.dense.row.linsol.qr declared as DMatrixRMajModifier and TypeFieldDescriptionprotected final DMatrixRMajLinearSolverQrHouseCol_DDRM.aprotected DMatrixRMajBaseLinearSolverQrp_DDRM.Iprotected DMatrixRMajLinearSolverQr_DDRM.Qprotected DMatrixRMajBaseLinearSolverQrp_DDRM.Rprotected DMatrixRMajLinearSolverQr_DDRM.Rprotected final DMatrixRMajLinearSolverQrHouseCol_DDRM.Rprotected DMatrixRMajBaseLinearSolverQrp_DDRM.R11protected final DMatrixRMajLinearSolverQrHouseCol_DDRM.tempprotected DMatrixRMajBaseLinearSolverQrp_DDRM.YFields in org.ejml.dense.row.linsol.qr with type parameters of type DMatrixRMajModifier and TypeFieldDescriptionprotected LinearSolverDense<DMatrixRMaj>BaseLinearSolverQrp_DDRM.internalSolverMethods in org.ejml.dense.row.linsol.qr that return DMatrixRMajModifier and TypeMethodDescriptionAdjLinearSolverQr_DDRM.getA()Compute the A matrix from the Q and R matrices.LinearSolverQr_DDRM.getQ()SolveNullSpaceQR_DDRM.getQ()SolveNullSpaceQRP_DDRM.getQ()LinearSolverQr_DDRM.getR()Methods in org.ejml.dense.row.linsol.qr that return types with arguments of type DMatrixRMajModifier and TypeMethodDescriptionLinearSolverQr_DDRM.getDecomposer()BaseLinearSolverQrp_DDRM.getDecomposition()LinearSolverQr_DDRM.getDecomposition()LinearSolverQrHouse_DDRM.getDecomposition()LinearSolverQrHouseCol_DDRM.getDecomposition()LinearSolverQrHouseTran_DDRM.getDecomposition()Methods in org.ejml.dense.row.linsol.qr with parameters of type DMatrixRMajModifier and TypeMethodDescriptionvoidBaseLinearSolverQrp_DDRM.invert(DMatrixRMaj A_inv) booleanSolveNullSpaceQR_DDRM.process(DMatrixRMaj A, int numSingularValues, DMatrixRMaj nullspace) Finds the null space of AbooleanSolveNullSpaceQRP_DDRM.process(DMatrixRMaj A, int numSingularValues, DMatrixRMaj nullspace) Finds the null space of AbooleanBaseLinearSolverQrp_DDRM.setA(DMatrixRMaj A) booleanLinearSolverQr_DDRM.setA(DMatrixRMaj A) Performs QR decomposition on AbooleanLinearSolverQrHouse_DDRM.setA(DMatrixRMaj A) Performs QR decomposition on AbooleanLinearSolverQrHouseCol_DDRM.setA(DMatrixRMaj A) Performs QR decomposition on AbooleanLinearSolverQrHouseTran_DDRM.setA(DMatrixRMaj A) Performs QR decomposition on AbooleanSolvePseudoInverseQrp_DDRM.setA(DMatrixRMaj A) voidLinearSolverQr_DDRM.solve(DMatrixRMaj B, DMatrixRMaj X) Solves for X using the QR decomposition.voidLinearSolverQrHouse_DDRM.solve(DMatrixRMaj B, DMatrixRMaj X) Solves for X using the QR decomposition.voidLinearSolverQrHouseCol_DDRM.solve(DMatrixRMaj B, DMatrixRMaj X) Solves for X using the QR decomposition.voidLinearSolverQrHouseCol_MT_DDRM.solve(DMatrixRMaj B, DMatrixRMaj X) Solves for X using the QR decomposition.voidLinearSolverQrHouseTran_DDRM.solve(DMatrixRMaj B, DMatrixRMaj X) Solves for X using the QR decomposition.voidLinearSolverQrpHouseCol_DDRM.solve(DMatrixRMaj B, DMatrixRMaj X) voidSolvePseudoInverseQrp_DDRM.solve(DMatrixRMaj B, DMatrixRMaj X) protected voidBaseLinearSolverQrp_DDRM.upgradeSolution(DMatrixRMaj 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 DMatrixRMajModifierConstructorDescriptionprotectedBaseLinearSolverQrp_DDRM(QRPDecomposition_F64<DMatrixRMaj> decomposition, boolean norm2Solution) Configures internal parameters.LinearSolverQr_DDRM(QRDecomposition<DMatrixRMaj> decomposer) Creates a linear solver that uses QR decomposition.SolvePseudoInverseQrp_DDRM(QRPDecomposition_F64<DMatrixRMaj> decomposition, boolean norm2Solution) Configure and provide decomposition -
Uses of DMatrixRMaj in org.ejml.dense.row.linsol.svd
Methods in org.ejml.dense.row.linsol.svd that return types with arguments of type DMatrixRMajModifier and TypeMethodDescriptionSolvePseudoInverseSvd_DDRM.getDecomposer()SolvePseudoInverseSvd_DDRM.getDecomposition()SolveNullSpaceSvd_DDRM.getSvd()Methods in org.ejml.dense.row.linsol.svd with parameters of type DMatrixRMajModifier and TypeMethodDescriptionvoidSolvePseudoInverseSvd_DDRM.invert(DMatrixRMaj A_inv) booleanSolveNullSpaceSvd_DDRM.process(DMatrixRMaj input, int numberOfSingular, DMatrixRMaj nullspace) booleanSolvePseudoInverseSvd_DDRM.setA(DMatrixRMaj A) voidSolvePseudoInverseSvd_DDRM.solve(DMatrixRMaj b, DMatrixRMaj x) -
Uses of DMatrixRMaj in org.ejml.dense.row.misc
Methods in org.ejml.dense.row.misc with parameters of type DMatrixRMajModifier and TypeMethodDescriptionstatic voidImplCommonOps_DDRM.extract(DMatrixRMaj src, int srcY0, int srcX0, DMatrixRMaj dst, int dstY0, int dstX0, int numRows, int numCols) static voidUnrolledInverseFromMinor_DDRM.inv(DMatrixRMaj mat, DMatrixRMaj inv) static voidUnrolledInverseFromMinor_DDRM.inv2(DMatrixRMaj mat, DMatrixRMaj inv, double scale) static voidUnrolledInverseFromMinor_DDRM.inv3(DMatrixRMaj mat, DMatrixRMaj inv, double scale) static voidUnrolledInverseFromMinor_DDRM.inv4(DMatrixRMaj mat, DMatrixRMaj inv, double scale) static voidUnrolledInverseFromMinor_DDRM.inv5(DMatrixRMaj mat, DMatrixRMaj inv, double scale) voidRrefGaussJordanRowPivot_DDRM.reduce(DMatrixRMaj A, int coefficientColumns) protected static voidRrefGaussJordanRowPivot_DDRM.swapRows(DMatrixRMaj A, int rowA, int rowB) -
Uses of DMatrixRMaj in org.ejml.dense.row.mult
Methods in org.ejml.dense.row.mult with parameters of type DMatrixRMajModifier and TypeMethodDescriptionstatic voidVectorVectorMult_DDRM.rank1Update(double gamma, DMatrixRMaj A, DMatrixRMaj u, DMatrixRMaj w) Performs a rank one update on matrix A using vectors u and w.static voidVectorVectorMult_DDRM.rank1Update(double gamma, DMatrixRMaj A, DMatrixRMaj u, DMatrixRMaj w, DMatrixRMaj B) Performs a rank one update on matrix A using vectors u and w. -
Uses of DMatrixRMaj in org.ejml.equation
Fields in org.ejml.equation declared as DMatrixRMajMethods in org.ejml.equation that return DMatrixRMajMethods in org.ejml.equation with parameters of type DMatrixRMajModifier and TypeMethodDescriptionvoidEquation.alias(DMatrixRMaj variable, String name) Adds a new Matrix variable.protected voidMatrixConstructor.setToRequiredSize(DMatrixRMaj matrix) Constructors in org.ejml.equation with parameters of type DMatrixRMajModifierConstructorDescriptionVariableMatrix(DMatrixRMaj matrix) Initializes the matrix variable. -
Uses of DMatrixRMaj in org.ejml.ops
Methods in org.ejml.ops that return DMatrixRMajModifier and TypeMethodDescriptionstatic DMatrixRMajDConvertArrays.convert(double[][] src, @Nullable DMatrixRMaj dst) static DMatrixRMajDConvertMatrixStruct.convert(DMatrix2 input, @Nullable DMatrixRMaj output) ConvertsDMatrix2intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrix2x2 input, @Nullable DMatrixRMaj output) ConvertsDMatrix2x2intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrix3 input, @Nullable DMatrixRMaj output) ConvertsDMatrix3intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrix3x3 input, @Nullable DMatrixRMaj output) ConvertsDMatrix3x3intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrix4 input, @Nullable DMatrixRMaj output) ConvertsDMatrix4intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrix4x4 input, @Nullable DMatrixRMaj output) ConvertsDMatrix4x4intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrix5 input, @Nullable DMatrixRMaj output) ConvertsDMatrix5intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrix5x5 input, @Nullable DMatrixRMaj output) ConvertsDMatrix5x5intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrix6 input, @Nullable DMatrixRMaj output) ConvertsDMatrix6intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrix6x6 input, @Nullable DMatrixRMaj output) ConvertsDMatrix6x6intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrixRBlock src, @Nullable DMatrixRMaj dst) ConvertsDMatrixRBlockintoDMatrixRMajstatic DMatrixRMajDConvertMatrixStruct.convert(DMatrixSparseCSC src, @Nullable DMatrixRMaj dst) static DMatrixRMajDConvertMatrixStruct.convert(DMatrixSparseTriplet src, @Nullable DMatrixRMaj dst) static DMatrixRMajReads a matrix in which has been encoded using a Column Space Value (CSV) file format.static DMatrixRMajMatrixIO.loadMatrixMarketDDRM(Reader reader) Reads a stream in Matrix Market Coordinate formatstatic DMatrixRMajMatrixIO.matlabToDDRM(String text) Converts a text string in matlab format into a DDRM matrixReadMatrixCsv.readDDRM(int numRows, int numCols) Reads in aDMatrixRMajfrom the IO stream where the user specifies the matrix dimensions.Methods in org.ejml.ops with parameters of type DMatrixRMajModifier and TypeMethodDescriptionstatic voidConvertMatrixData.convert(DMatrixRMaj src, CMatrixRMaj dst) static voidConvertMatrixData.convert(DMatrixRMaj src, FMatrixRMaj dst) static voidConvertMatrixData.convert(DMatrixRMaj src, ZMatrixRMaj dst) static voidConvertMatrixData.convert(FMatrixRMaj src, DMatrixRMaj dst) static DMatrixRMajDConvertArrays.convert(double[][] src, @Nullable DMatrixRMaj dst) static double[][]DConvertArrays.convert(DMatrixRMaj src) Convert aDMatrixRMajto a two-dimensional array, given DMatrixRMaj can take a double[][] as input to constructorstatic DMatrixRMajDConvertMatrixStruct.convert(DMatrix2 input, @Nullable DMatrixRMaj output) ConvertsDMatrix2intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrix2x2 input, @Nullable DMatrixRMaj output) ConvertsDMatrix2x2intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrix3 input, @Nullable DMatrixRMaj output) ConvertsDMatrix3intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrix3x3 input, @Nullable DMatrixRMaj output) ConvertsDMatrix3x3intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrix4 input, @Nullable DMatrixRMaj output) ConvertsDMatrix4intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrix4x4 input, @Nullable DMatrixRMaj output) ConvertsDMatrix4x4intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrix5 input, @Nullable DMatrixRMaj output) ConvertsDMatrix5intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrix5x5 input, @Nullable DMatrixRMaj output) ConvertsDMatrix5x5intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrix6 input, @Nullable DMatrixRMaj output) ConvertsDMatrix6intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrix6x6 input, @Nullable DMatrixRMaj output) ConvertsDMatrix6x6intoDMatrixRMaj.static DMatrixRMajDConvertMatrixStruct.convert(DMatrixRBlock src, @Nullable DMatrixRMaj dst) ConvertsDMatrixRBlockintoDMatrixRMajstatic DMatrix2DConvertMatrixStruct.convert(DMatrixRMaj input, @Nullable DMatrix2 output) ConvertsDMatrixRMajintoDMatrix2static DMatrix2x2DConvertMatrixStruct.convert(DMatrixRMaj input, @Nullable DMatrix2x2 output) ConvertsDMatrixRMajintoDMatrix2x2static DMatrix3DConvertMatrixStruct.convert(DMatrixRMaj input, @Nullable DMatrix3 output) ConvertsDMatrixRMajintoDMatrix3static DMatrix3x3DConvertMatrixStruct.convert(DMatrixRMaj input, @Nullable DMatrix3x3 output) ConvertsDMatrixRMajintoDMatrix3x3static DMatrix4DConvertMatrixStruct.convert(DMatrixRMaj input, @Nullable DMatrix4 output) ConvertsDMatrixRMajintoDMatrix4static DMatrix4x4DConvertMatrixStruct.convert(DMatrixRMaj input, @Nullable DMatrix4x4 output) ConvertsDMatrixRMajintoDMatrix4x4static DMatrix5DConvertMatrixStruct.convert(DMatrixRMaj input, @Nullable DMatrix5 output) ConvertsDMatrixRMajintoDMatrix5static DMatrix5x5DConvertMatrixStruct.convert(DMatrixRMaj input, @Nullable DMatrix5x5 output) ConvertsDMatrixRMajintoDMatrix5x5static DMatrix6DConvertMatrixStruct.convert(DMatrixRMaj input, @Nullable DMatrix6 output) ConvertsDMatrixRMajintoDMatrix6static DMatrix6x6DConvertMatrixStruct.convert(DMatrixRMaj input, @Nullable DMatrix6x6 output) ConvertsDMatrixRMajintoDMatrix6x6static DMatrixSparseCSCDConvertMatrixStruct.convert(DMatrixRMaj src, @Nullable DMatrixSparseCSC dst, double tol) Converts DMatrixRMaj into a DMatrixSparseCSCstatic DMatrixSparseTripletDConvertMatrixStruct.convert(DMatrixRMaj src, @Nullable DMatrixSparseTriplet dst, double tol) static voidDConvertMatrixStruct.convert(DMatrixRMaj src, DMatrixRBlock dst) ConvertsDMatrixRMajintoDMatrixRBlockCan't handle null output matrix since block size needs to be specified.static DMatrixRMajDConvertMatrixStruct.convert(DMatrixSparseCSC src, @Nullable DMatrixRMaj dst) static DMatrixRMajDConvertMatrixStruct.convert(DMatrixSparseTriplet src, @Nullable DMatrixRMaj dst) static voidMatrixIO.saveMatrixMarket(DMatrixRMaj matrix, String floatFormat, Writer writer) Writes a stream using the Matrix Market Coordinate format. -
Uses of DMatrixRMaj in org.ejml.simple
Methods in org.ejml.simple that return DMatrixRMajModifier and TypeMethodDescriptionSimpleBase.getDDRM()Returns a reference to the matrix that it uses internally if this is aDMatrixRMaj. -
Uses of DMatrixRMaj in org.ejml.simple.ops
Methods in org.ejml.simple.ops that return DMatrixRMajMethods in org.ejml.simple.ops with parameters of type DMatrixRMajModifier and TypeMethodDescriptionvoidSimpleOperations_DDRM.changeSign(DMatrixRMaj a) doubleSimpleOperations_DDRM.conditionP2(DMatrixRMaj A) doubleSimpleOperations_DDRM.determinant(DMatrixRMaj A) SimpleOperations_DDRM.diag(DMatrixRMaj A) voidSimpleOperations_DDRM.divide(DMatrixRMaj A, double val, DMatrixRMaj output) doubleSimpleOperations_DDRM.dot(DMatrixRMaj A, DMatrixRMaj v) voidSimpleOperations_DDRM.elementDiv(DMatrixRMaj A, DMatrixRMaj B, DMatrixRMaj output) voidSimpleOperations_DDRM.elementExp(DMatrixRMaj A, DMatrixRMaj output) voidSimpleOperations_DDRM.elementLog(DMatrixRMaj A, DMatrixRMaj output) doubleSimpleOperations_DDRM.elementMax(DMatrixRMaj A) doubleSimpleOperations_DDRM.elementMaxAbs(DMatrixRMaj A) doubleSimpleOperations_DDRM.elementMin(DMatrixRMaj A) doubleSimpleOperations_DDRM.elementMinAbs(DMatrixRMaj A) voidSimpleOperations_DDRM.elementMult(DMatrixRMaj A, DMatrixRMaj B, DMatrixRMaj output) voidSimpleOperations_DDRM.elementOp(DMatrixRMaj A, SimpleOperations.ElementOpComplex op, DMatrixRMaj output) voidSimpleOperations_DDRM.elementOp(DMatrixRMaj A, SimpleOperations.ElementOpReal op, DMatrixRMaj output) voidSimpleOperations_DDRM.elementPower(DMatrixRMaj A, double b, DMatrixRMaj output) voidSimpleOperations_DDRM.elementPower(DMatrixRMaj A, DMatrixRMaj B, DMatrixRMaj output) doubleSimpleOperations_DDRM.elementSum(DMatrixRMaj A) voidSimpleOperations_DDRM.extract(DMatrixRMaj src, int srcY0, int srcY1, int srcX0, int srcX1, DMatrixRMaj dst, int dstY0, int dstX0) voidSimpleOperations_DSCC.extractDiag(DMatrixSparseCSC input, DMatrixRMaj output) voidSimpleOperations_DDRM.fill(DMatrixRMaj A, double value) doubleSimpleOperations_DDRM.get(DMatrixRMaj A, int row, int column) voidSimpleOperations_DDRM.get(DMatrixRMaj A, int row, int column, Complex_F64 value) double[]SimpleOperations_DDRM.getColumn(DMatrixRMaj A, int col, int row0, int row1) doubleSimpleOperations_DDRM.getImaginary(DMatrixRMaj A, int row, int column) doubleSimpleOperations_DDRM.getReal(DMatrixRMaj A, int row, int column) double[]SimpleOperations_DDRM.getRow(DMatrixRMaj A, int row, int idx0, int idx1) booleanSimpleOperations_DDRM.hasUncountable(DMatrixRMaj M) booleanSimpleOperations_DDRM.invert(DMatrixRMaj A, DMatrixRMaj output) booleanSimpleOperations_DDRM.isIdentical(DMatrixRMaj A, DMatrixRMaj B, double tol) voidSimpleOperations_DDRM.kron(DMatrixRMaj A, DMatrixRMaj B, DMatrixRMaj output) voidSimpleOperations_DDRM.minus(DMatrixRMaj A, double b, DMatrixRMaj output) voidSimpleOperations_DDRM.minus(DMatrixRMaj A, DMatrixRMaj B, DMatrixRMaj output) voidSimpleOperations_DDRM.mult(DMatrixRMaj A, DMatrixRMaj B, DMatrixRMaj output) voidSimpleOperations_DSCC.mult(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj output) voidSimpleOperations_DDRM.multTransA(DMatrixRMaj A, DMatrixRMaj B, DMatrixRMaj output) voidSimpleOperations_DSCC.multTransA(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj output) doubleSimpleOperations_DDRM.normF(DMatrixRMaj A) voidSimpleOperations_DDRM.plus(double alpha, DMatrixRMaj A, double beta, DMatrixRMaj b, DMatrixRMaj output) voidSimpleOperations_DDRM.plus(DMatrixRMaj A, double b, DMatrixRMaj output) voidSimpleOperations_DDRM.plus(DMatrixRMaj A, double beta, DMatrixRMaj b, DMatrixRMaj output) voidSimpleOperations_DDRM.plus(DMatrixRMaj A, DMatrixRMaj B, DMatrixRMaj output) voidSimpleOperations_DDRM.pseudoInverse(DMatrixRMaj A, DMatrixRMaj output) voidSimpleOperations_DDRM.scale(DMatrixRMaj A, double val, DMatrixRMaj output) voidSimpleOperations_DDRM.set(DMatrixRMaj A, int row, int column, double value) voidSimpleOperations_DDRM.set(DMatrixRMaj A, int row, int column, double real, double imaginary) voidSimpleOperations_DDRM.setColumn(DMatrixRMaj A, int column, int startRow, double... values) voidSimpleOperations_DDRM.setIdentity(DMatrixRMaj A) voidSimpleOperations_DDRM.setRow(DMatrixRMaj A, int row, int startColumn, double... values) booleanSimpleOperations_DDRM.solve(DMatrixRMaj A, DMatrixRMaj X, DMatrixRMaj B) booleanSimpleOperations_DSCC.solve(DMatrixSparseCSC A, DMatrixRMaj X, DMatrixRMaj B) doubleSimpleOperations_DDRM.trace(DMatrixRMaj A) voidSimpleOperations_DDRM.transpose(DMatrixRMaj input, DMatrixRMaj output) voidSimpleOperations_DDRM.zero(DMatrixRMaj A) -
Uses of DMatrixRMaj in org.ejml.sparse.csc
Methods in org.ejml.sparse.csc that return DMatrixRMajModifier and TypeMethodDescriptionstatic DMatrixRMajCommonOps_DSCC.maxCols(DMatrixSparseCSC input, @Nullable DMatrixRMaj output) Computes the maximums of each column in the input matrix and returns the results in a vector:
bj = max(i=1:m ; aij)static DMatrixRMajCommonOps_DSCC.maxRows(DMatrixSparseCSC input, @Nullable DMatrixRMaj output, @Nullable IGrowArray gw) Computes the maximum of each row in the input matrix and returns the results in a vector:
bj = max(i=1:n ; aji)static DMatrixRMajCommonOps_DSCC.minCols(DMatrixSparseCSC input, @Nullable DMatrixRMaj output) Computes the minimum of each column in the input matrix and returns the results in a vector:
bj = min(i=1:m ; aij)static DMatrixRMajCommonOps_DSCC.minRows(DMatrixSparseCSC input, @Nullable DMatrixRMaj output, @Nullable IGrowArray gw) Computes the minimum of each row in the input matrix and returns the results in a vector:
bj = min(i=1:n ; aji)static DMatrixRMajCommonOps_DSCC.mult(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC) Performs matrix multiplication.static DMatrixRMajCommonOps_MT_DSCC.mult(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable GrowArray<DGrowArray> workspace) Performs matrix multiplication.static DMatrixRMajCommonOpsWithSemiRing_DSCC.mult(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj output, DSemiRing semiRing) Performs matrix multiplication.static DMatrixRMajCommonOps_DSCC.multTransA(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable DGrowArray work) Performs matrix multiplication.static DMatrixRMajCommonOps_MT_DSCC.multTransA(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable GrowArray<DGrowArray> workspace) Performs matrix multiplication.static DMatrixRMajCommonOpsWithSemiRing_DSCC.multTransA(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj output, DSemiRing semiRing) Performs matrix multiplication.static DMatrixRMajCommonOps_DSCC.multTransAB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC) Performs matrix multiplication.static DMatrixRMajCommonOps_MT_DSCC.multTransAB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC) Performs matrix multiplication.static DMatrixRMajCommonOpsWithSemiRing_DSCC.multTransAB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj output, DSemiRing semiRing) Performs matrix multiplication.static DMatrixRMajCommonOps_DSCC.multTransB(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable DGrowArray work) Performs matrix multiplication.static DMatrixRMajCommonOps_MT_DSCC.multTransB(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable GrowArray<DGrowArray> workspace) Performs matrix multiplication.static DMatrixRMajCommonOpsWithSemiRing_DSCC.multTransB(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj output, DSemiRing semiRing) Performs matrix multiplication.static DMatrixRMajCommonOps_DSCC.reduceColumnWise(DMatrixSparseCSC input, double initValue, DOperatorBinary func, @Nullable DMatrixRMaj output, @Nullable Mask mask) This accumulates the values per column to a scalar valuestatic DMatrixRMajCommonOps_DSCC.reduceRowWise(DMatrixSparseCSC input, double initValue, DOperatorBinary func, @Nullable DMatrixRMaj output) This accumulates the values per row to a scalar valuestatic DMatrixRMajCommonOps_DSCC.sumCols(DMatrixSparseCSC input, @Nullable DMatrixRMaj output) Computes the sum of each column in the input matrix and returns the results in a vector:
bj = sum(i=1:m ; aij)static DMatrixRMajCommonOps_DSCC.sumRows(DMatrixSparseCSC input, @Nullable DMatrixRMaj output) Computes the sum of each row in the input matrix and returns the results in a vector:
bj = sum(i=1:n ; aji)Methods in org.ejml.sparse.csc with parameters of type DMatrixRMajModifier and TypeMethodDescriptionstatic voidCommonOps_DSCC.extractDiag(DMatrixSparseCSC A, DMatrixRMaj outputB) Extracts the diagonal elements 'src' write it to the 'dst' vector.static booleanCommonOps_DSCC.invert(DMatrixSparseCSC A, DMatrixRMaj inverse) Performs a matrix inversion operation that does not modify the original and stores the results in another matrix.static voidCommonOps_DSCC.maxAbsCols(DMatrixSparseCSC A, @Nullable DMatrixRMaj outputB) Finds the maximum abs in each column of A and stores it into valuesstatic DMatrixRMajCommonOps_DSCC.maxCols(DMatrixSparseCSC input, @Nullable DMatrixRMaj output) Computes the maximums of each column in the input matrix and returns the results in a vector:
bj = max(i=1:m ; aij)static DMatrixRMajCommonOps_DSCC.maxRows(DMatrixSparseCSC input, @Nullable DMatrixRMaj output, @Nullable IGrowArray gw) Computes the maximum of each row in the input matrix and returns the results in a vector:
bj = max(i=1:n ; aji)static DMatrixRMajCommonOps_DSCC.minCols(DMatrixSparseCSC input, @Nullable DMatrixRMaj output) Computes the minimum of each column in the input matrix and returns the results in a vector:
bj = min(i=1:m ; aij)static DMatrixRMajCommonOps_DSCC.minRows(DMatrixSparseCSC input, @Nullable DMatrixRMaj output, @Nullable IGrowArray gw) Computes the minimum of each row in the input matrix and returns the results in a vector:
bj = min(i=1:n ; aji)static DMatrixRMajCommonOps_DSCC.mult(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC) Performs matrix multiplication.static DMatrixRMajCommonOps_MT_DSCC.mult(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable GrowArray<DGrowArray> workspace) Performs matrix multiplication.static DMatrixRMajCommonOpsWithSemiRing_DSCC.mult(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj output, DSemiRing semiRing) Performs matrix multiplication.static voidCommonOps_DSCC.multAdd(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC) C = C + A*Bstatic voidCommonOps_MT_DSCC.multAdd(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC, @Nullable GrowArray<DGrowArray> workspace) C = C + AT*Bstatic voidCommonOpsWithSemiRing_DSCC.multAdd(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj output, DSemiRing semiRing) output = output + A*Bstatic voidCommonOps_DSCC.multAddTransA(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC, @Nullable DGrowArray work) C = C + AT*Bstatic voidCommonOps_MT_DSCC.multAddTransA(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC, @Nullable GrowArray<DGrowArray> workspace) C = C + AT*Bstatic voidCommonOpsWithSemiRing_DSCC.multAddTransA(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj output, DSemiRing semiRing) output = output + AT*Bstatic voidCommonOps_DSCC.multAddTransAB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC) C = C + AT*BTstatic voidCommonOps_MT_DSCC.multAddTransAB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC) C = C + AT*BTstatic voidCommonOpsWithSemiRing_DSCC.multAddTransAB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DSemiRing semiRing) C = C + AT*BTstatic voidCommonOps_DSCC.multAddTransB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC, @Nullable DGrowArray work) C = C + A*BTstatic voidCommonOps_MT_DSCC.multAddTransB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC, @Nullable GrowArray<DGrowArray> workspace) C = C + A*BTstatic voidCommonOpsWithSemiRing_DSCC.multAddTransB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj output, DSemiRing semiRing) output = output + A*BTstatic DMatrixRMajCommonOps_DSCC.multTransA(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable DGrowArray work) Performs matrix multiplication.static DMatrixRMajCommonOps_MT_DSCC.multTransA(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable GrowArray<DGrowArray> workspace) Performs matrix multiplication.static DMatrixRMajCommonOpsWithSemiRing_DSCC.multTransA(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj output, DSemiRing semiRing) Performs matrix multiplication.static DMatrixRMajCommonOps_DSCC.multTransAB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC) Performs matrix multiplication.static DMatrixRMajCommonOps_MT_DSCC.multTransAB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj outputC) Performs matrix multiplication.static DMatrixRMajCommonOpsWithSemiRing_DSCC.multTransAB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj output, DSemiRing semiRing) Performs matrix multiplication.static DMatrixRMajCommonOps_DSCC.multTransB(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable DGrowArray work) Performs matrix multiplication.static DMatrixRMajCommonOps_MT_DSCC.multTransB(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj outputC, @Nullable GrowArray<DGrowArray> workspace) Performs matrix multiplication.static DMatrixRMajCommonOpsWithSemiRing_DSCC.multTransB(DMatrixSparseCSC A, DMatrixRMaj B, @Nullable DMatrixRMaj output, DSemiRing semiRing) Performs matrix multiplication.static DMatrixRMajCommonOps_DSCC.reduceColumnWise(DMatrixSparseCSC input, double initValue, DOperatorBinary func, @Nullable DMatrixRMaj output, @Nullable Mask mask) This accumulates the values per column to a scalar valuestatic DMatrixRMajCommonOps_DSCC.reduceRowWise(DMatrixSparseCSC input, double initValue, DOperatorBinary func, @Nullable DMatrixRMaj output) This accumulates the values per row to a scalar valuestatic booleanCommonOps_DSCC.solve(DMatrixSparseCSC a, DMatrixRMaj b, DMatrixRMaj x) Solves for x in the following equation:
A*x = bstatic DMatrixRMajCommonOps_DSCC.sumCols(DMatrixSparseCSC input, @Nullable DMatrixRMaj output) Computes the sum of each column in the input matrix and returns the results in a vector:
bj = sum(i=1:m ; aij)static DMatrixRMajCommonOps_DSCC.sumRows(DMatrixSparseCSC input, @Nullable DMatrixRMaj output) Computes the sum of each row in the input matrix and returns the results in a vector:
bj = sum(i=1:n ; aji) -
Uses of DMatrixRMaj in org.ejml.sparse.csc.factory
Methods in org.ejml.sparse.csc.factory that return types with arguments of type DMatrixRMajModifier and TypeMethodDescriptionLinearSolverFactory_DSCC.cholesky(FillReducing permutation) LinearSolverFactory_DSCC.lu(FillReducing permutation) LinearSolverFactory_DSCC.qr(FillReducing permutation) -
Uses of DMatrixRMaj in org.ejml.sparse.csc.linsol.chol
Methods in org.ejml.sparse.csc.linsol.chol with parameters of type DMatrixRMajModifier and TypeMethodDescriptionvoidLinearSolverCholesky_DSCC.solve(DMatrixRMaj B, DMatrixRMaj X) -
Uses of DMatrixRMaj in org.ejml.sparse.csc.linsol.lu
Methods in org.ejml.sparse.csc.linsol.lu with parameters of type DMatrixRMaj -
Uses of DMatrixRMaj in org.ejml.sparse.csc.linsol.qr
Methods in org.ejml.sparse.csc.linsol.qr with parameters of type DMatrixRMajModifier and TypeMethodDescriptionvoidLinearSolverQrLeftLooking_DSCC.solve(DMatrixRMaj B, DMatrixRMaj X) -
Uses of DMatrixRMaj in org.ejml.sparse.csc.mult
Methods in org.ejml.sparse.csc.mult with parameters of type DMatrixRMajModifier and TypeMethodDescriptionstatic doubleMatrixVectorMult_DSCC.innerProduct(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixSparseCSC C) scalar = AT*B*Cstatic doubleMatrixVectorMult_DSCC.innerProductSelfSymmetrical(DMatrixSparseCSC A, DMatrixRMaj B) scalar = AT*B*Astatic voidImplMultiplication_DSCC.mult(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C) Invoke throughCommonOps_DSCCstatic voidImplMultiplication_MT_DSCC.mult(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, boolean add, GrowArray<DGrowArray> listWork) Invoke throughCommonOps_MT_DSCCas it will manage the input contractstatic voidImplMultiplication_MT_DSCC.mult(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, GrowArray<DGrowArray> listWork) Invoke throughCommonOps_MT_DSCCas it will manage the input contractstatic voidImplMultiplicationWithSemiRing_DSCC.mult(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DSemiRing semiRing) static voidImplMultiplication_DSCC.multAdd(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C) Invoke throughCommonOps_DSCCstatic voidImplMultiplication_MT_DSCC.multAdd(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, GrowArray<DGrowArray> listWork) Invoke throughCommonOps_MT_DSCCas it will manage the input contractstatic voidImplMultiplicationWithSemiRing_DSCC.multAdd(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DSemiRing semiRing) static voidImplMultiplication_DSCC.multAddTransA(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DGrowArray workArray) Invoke throughCommonOps_DSCCstatic voidImplMultiplication_MT_DSCC.multAddTransA(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, GrowArray<DGrowArray> listWork) Invoke throughCommonOps_MT_DSCCas it will manage the input contractstatic voidImplMultiplicationWithSemiRing_DSCC.multAddTransA(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DSemiRing semiRing) static voidImplMultiplication_DSCC.multAddTransAB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C) Invoke throughCommonOps_DSCCstatic voidImplMultiplication_MT_DSCC.multAddTransAB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C) Invoke throughCommonOps_MT_DSCCas it will manage the input contractstatic voidImplMultiplicationWithSemiRing_DSCC.multAddTransAB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DSemiRing semiRing) static voidImplMultiplication_DSCC.multAddTransB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DGrowArray workArray) Invoke throughCommonOps_DSCCstatic voidImplMultiplication_MT_DSCC.multAddTransB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, GrowArray<DGrowArray> listWork) Invoke throughCommonOps_MT_DSCCas it will manage the input contractstatic voidImplMultiplicationWithSemiRing_DSCC.multAddTransB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DSemiRing semiRing) static voidImplMultiplication_DSCC.multTransA(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DGrowArray workArray) Invoke throughCommonOps_DSCCstatic voidImplMultiplication_DSCC.multTransA(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DGrowArray workArray, DOperatorBinary op) Invoke throughCommonOps_DSCCstatic voidImplMultiplication_MT_DSCC.multTransA(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, GrowArray<DGrowArray> listWork) Invoke throughCommonOps_MT_DSCCas it will manage the input contractstatic voidImplMultiplicationWithSemiRing_DSCC.multTransA(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DSemiRing semiRing) static voidImplMultiplication_DSCC.multTransAB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C) Invoke throughCommonOps_DSCCstatic voidImplMultiplication_MT_DSCC.multTransAB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C) Invoke throughCommonOps_MT_DSCCas it will manage the input contractstatic voidImplMultiplicationWithSemiRing_DSCC.multTransAB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DSemiRing semiRing) static voidImplMultiplication_DSCC.multTransB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DGrowArray workArray) Invoke throughCommonOps_DSCCstatic voidImplMultiplication_MT_DSCC.multTransB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, boolean add, GrowArray<DGrowArray> listWork) Invoke throughCommonOps_MT_DSCCas it will manage the input contractstatic voidImplMultiplication_MT_DSCC.multTransB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, GrowArray<DGrowArray> listWork) Invoke throughCommonOps_MT_DSCCas it will manage the input contractstatic voidImplMultiplicationWithSemiRing_DSCC.multTransB(DMatrixSparseCSC A, DMatrixRMaj B, DMatrixRMaj C, DSemiRing semiRing)