Uses of Class
org.ejml.data.IGrowArray
Packages that use IGrowArray
Package
Description
-
Uses of IGrowArray in org.ejml
Methods in org.ejml with parameters of type IGrowArrayModifier and TypeMethodDescriptionstatic int[]UtilEjml.adjust(@Nullable IGrowArray gwork, int desired) Resizes the array to ensure that it is at least of length desired and returns its internal arraystatic int[]UtilEjml.adjust(@Nullable IGrowArray gwork, int desired, int zeroToM) static int[]UtilEjml.adjustClear(@Nullable IGrowArray gwork, int desired) static int[]UtilEjml.adjustFill(@Nullable IGrowArray gwork, int desired, int value) static int[]UtilEjml.pivotVector(int[] pivots, int length, @Nullable IGrowArray storage) -
Uses of IGrowArray in org.ejml.data
Fields in org.ejml.data declared as IGrowArrayModifier and TypeFieldDescriptionDMatrixSparseTriplet.nz_rowcolStorage for row and column coordinate for non-zero elementsFMatrixSparseTriplet.nz_rowcolStorage for row and column coordinate for non-zero elementsMethods in org.ejml.data with parameters of type IGrowArray -
Uses of IGrowArray in org.ejml.dense.row.decompose.lu
Methods in org.ejml.dense.row.decompose.lu with parameters of type IGrowArrayModifier and TypeMethodDescriptionint[]LUDecompositionBase_CDRM.getRowPivotV(@Nullable IGrowArray pivot) int[]LUDecompositionBase_ZDRM.getRowPivotV(@Nullable IGrowArray pivot) -
Uses of IGrowArray in org.ejml.dense.row.decomposition.lu
Methods in org.ejml.dense.row.decomposition.lu with parameters of type IGrowArrayModifier and TypeMethodDescriptionint[]LUDecompositionBase_DDRM.getRowPivotV(@Nullable IGrowArray pivot) int[]LUDecompositionBase_FDRM.getRowPivotV(@Nullable IGrowArray pivot) -
Uses of IGrowArray in org.ejml.interfaces.decomposition
Methods in org.ejml.interfaces.decomposition with parameters of type IGrowArrayModifier and TypeMethodDescriptionint[]LUDecomposition.getRowPivotV(@Nullable IGrowArray pivot) Returns the row pivot vector -
Uses of IGrowArray in org.ejml.masks
Methods in org.ejml.masks with parameters of type IGrowArrayModifier and TypeMethodDescriptionDMaskSparse.Builder.withWorkArray(IGrowArray gw) DMaskSparseStructural.Builder.withWorkArray(IGrowArray gw) FMaskSparse.Builder.withWorkArray(IGrowArray gw) FMaskSparseStructural.Builder.withWorkArray(IGrowArray gw) Constructors in org.ejml.masks with parameters of type IGrowArrayModifierConstructorDescriptionDMaskSparse(DMatrixSparseCSC matrix, boolean negated, double zeroElement, @Nullable IGrowArray gw, boolean indexFirstColumn) DMaskSparseStructural(DMatrixSparseCSC matrix, boolean negated, @Nullable IGrowArray gw, boolean indexFirstColumn) FMaskSparse(FMatrixSparseCSC matrix, boolean negated, float zeroElement, @Nullable IGrowArray gw, boolean indexFirstColumn) FMaskSparseStructural(FMatrixSparseCSC matrix, boolean negated, @Nullable IGrowArray gw, boolean indexFirstColumn) -
Uses of IGrowArray in org.ejml.ops
Methods in org.ejml.ops with parameters of type IGrowArrayModifier and TypeMethodDescriptionstatic DMatrixSparseCSCDConvertMatrixStruct.convert(DMatrixSparseTriplet src, @Nullable DMatrixSparseCSC dst, @Nullable IGrowArray histStorage) Converts DMatrixSparseTriplet into a DMatrixSparseCSC.static FMatrixSparseCSCFConvertMatrixStruct.convert(FMatrixSparseTriplet src, @Nullable FMatrixSparseCSC dst, @Nullable IGrowArray histStorage) Converts FMatrixSparseTriplet into a FMatrixSparseCSC. -
Uses of IGrowArray in org.ejml.simple.ops
Fields in org.ejml.simple.ops declared as IGrowArray -
Uses of IGrowArray in org.ejml.sparse
Fields in org.ejml.sparse declared as IGrowArrayModifier and TypeFieldDescriptionprotected @Nullable IGrowArrayComputePermutation.pcolprotected @Nullable IGrowArrayComputePermutation.prowMethods in org.ejml.sparse that return IGrowArrayModifier and TypeMethodDescription@Nullable IGrowArrayComputePermutation.getColumn()Returns column permutation@Nullable IGrowArrayComputePermutation.getRow()Returns row permutation -
Uses of IGrowArray in org.ejml.sparse.csc
Methods in org.ejml.sparse.csc with parameters of type IGrowArrayModifier and TypeMethodDescriptionstatic DMatrixSparseCSCCommonOps_DSCC.add(double alpha, DMatrixSparseCSC A, double beta, DMatrixSparseCSC B, @Nullable DMatrixSparseCSC outputC, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs matrix addition:
C = αA + βBstatic FMatrixSparseCSCCommonOps_FSCC.add(float alpha, FMatrixSparseCSC A, float beta, FMatrixSparseCSC B, @Nullable FMatrixSparseCSC outputC, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs matrix addition:
C = αA + βBstatic DMatrixSparseCSCCommonOpsWithSemiRing_DSCC.add(double alpha, DMatrixSparseCSC A, double beta, DMatrixSparseCSC B, @Nullable DMatrixSparseCSC output, DSemiRing semiRing, @Nullable Mask mask, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs matrix addition:
output = αA + βBstatic FMatrixSparseCSCCommonOpsWithSemiRing_FSCC.add(float alpha, FMatrixSparseCSC A, float beta, FMatrixSparseCSC B, @Nullable FMatrixSparseCSC output, FSemiRing semiRing, @Nullable Mask mask, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs matrix addition:
output = αA + βBstatic doubleCommonOps_DSCC.dotInnerColumns(DMatrixSparseCSC A, int colA, DMatrixSparseCSC B, int colB, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Computes the inner product of two column vectors taken from the input matrices.static floatCommonOps_FSCC.dotInnerColumns(FMatrixSparseCSC A, int colA, FMatrixSparseCSC B, int colB, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Computes the inner product of two column vectors taken from the input matrices.static voidCommonOps_DSCC.duplicatesAdd(DMatrixSparseCSC A, @Nullable IGrowArray work) For each duplicate element in the matrix it will remove the duplicates and replace them with a single element that is the sum of all the duplicates.static voidCommonOps_FSCC.duplicatesAdd(FMatrixSparseCSC A, @Nullable IGrowArray work) For each duplicate element in the matrix it will remove the duplicates and replace them with a single element that is the sum of all the duplicates.static DMatrixSparseCSCCommonOps_DSCC.elementMult(DMatrixSparseCSC A, DMatrixSparseCSC B, @Nullable DMatrixSparseCSC output, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs an element-wise multiplication.
output[i,j] = A[i,j]*B[i,j]
All matrices must have the same shape.static FMatrixSparseCSCCommonOps_FSCC.elementMult(FMatrixSparseCSC A, FMatrixSparseCSC B, @Nullable FMatrixSparseCSC output, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs an element-wise multiplication.
output[i,j] = A[i,j]*B[i,j]
All matrices must have the same shape.static DMatrixSparseCSCCommonOpsWithSemiRing_DSCC.elementMult(DMatrixSparseCSC A, DMatrixSparseCSC B, @Nullable DMatrixSparseCSC output, DSemiRing semiRing, @Nullable Mask mask, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs an element-wise multiplication.
output[i,j] = A[i,j]*B[i,j]
All matrices must have the same shape.static FMatrixSparseCSCCommonOpsWithSemiRing_FSCC.elementMult(FMatrixSparseCSC A, FMatrixSparseCSC B, @Nullable FMatrixSparseCSC output, FSemiRing semiRing, @Nullable Mask mask, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs an element-wise multiplication.
output[i,j] = A[i,j]*B[i,j]
All matrices must have the same shape.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 FMatrixRMajCommonOps_FSCC.maxRows(FMatrixSparseCSC input, @Nullable FMatrixRMaj output, @Nullable IGrowArray gw) Computes the maximum of each row in the input matrix and returns the results in a vector:
bj = max(i=1:n ; aji)static 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 FMatrixRMajCommonOps_FSCC.minRows(FMatrixSparseCSC input, @Nullable FMatrixRMaj output, @Nullable IGrowArray gw) Computes the minimum of each row in the input matrix and returns the results in a vector:
bj = min(i=1:n ; aji)static DMatrixSparseCSCCommonOps_DSCC.mult(DMatrixSparseCSC A, DMatrixSparseCSC B, @Nullable DMatrixSparseCSC outputC, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs matrix multiplication.static FMatrixSparseCSCCommonOps_FSCC.mult(FMatrixSparseCSC A, FMatrixSparseCSC B, @Nullable FMatrixSparseCSC outputC, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs matrix multiplication.static DMatrixSparseCSCCommonOpsWithSemiRing_DSCC.mult(DMatrixSparseCSC A, DMatrixSparseCSC B, @Nullable DMatrixSparseCSC output, DSemiRing semiRing, @Nullable Mask mask, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs matrix multiplication.static FMatrixSparseCSCCommonOpsWithSemiRing_FSCC.mult(FMatrixSparseCSC A, FMatrixSparseCSC B, @Nullable FMatrixSparseCSC output, FSemiRing semiRing, @Nullable Mask mask, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs matrix multiplication.static voidCommonOps_DSCC.permuteSymmetric(DMatrixSparseCSC input, int[] permInv, DMatrixSparseCSC output, @Nullable IGrowArray gw) Applies the permutation to upper triangular symmetric matrices.static voidCommonOps_FSCC.permuteSymmetric(FMatrixSparseCSC input, int[] permInv, FMatrixSparseCSC output, @Nullable IGrowArray gw) Applies the permutation to upper triangular symmetric matrices.static voidCommonOps_DSCC.symmLowerToFull(DMatrixSparseCSC A, DMatrixSparseCSC outputB, @Nullable IGrowArray gw) Given a symmetric matrix, which is represented by a lower triangular matrix, convert it back into a full symmetric matrixstatic voidCommonOps_FSCC.symmLowerToFull(FMatrixSparseCSC A, FMatrixSparseCSC outputB, @Nullable IGrowArray gw) Given a symmetric matrix, which is represented by a lower triangular matrix, convert it back into a full symmetric matrixstatic DMatrixSparseCSCCommonOps_DSCC.transpose(DMatrixSparseCSC A, @Nullable DMatrixSparseCSC A_t, @Nullable IGrowArray gw) Perform matrix transposestatic FMatrixSparseCSCCommonOps_FSCC.transpose(FMatrixSparseCSC A, @Nullable FMatrixSparseCSC A_t, @Nullable IGrowArray gw) Perform matrix transpose -
Uses of IGrowArray in org.ejml.sparse.csc.decomposition.chol
Methods in org.ejml.sparse.csc.decomposition.chol that return IGrowArray -
Uses of IGrowArray in org.ejml.sparse.csc.decomposition.lu
Methods in org.ejml.sparse.csc.decomposition.lu that return IGrowArrayModifier and TypeMethodDescriptionLuUpLooking_DSCC.getGw()LuUpLooking_FSCC.getGw()LuUpLooking_DSCC.getGxi()LuUpLooking_FSCC.getGxi()Methods in org.ejml.sparse.csc.decomposition.lu with parameters of type IGrowArrayModifier and TypeMethodDescriptionint[]LuUpLooking_DSCC.getRowPivotV(@Nullable IGrowArray pivot) int[]LuUpLooking_FSCC.getRowPivotV(@Nullable IGrowArray pivot) -
Uses of IGrowArray in org.ejml.sparse.csc.decomposition.qr
Methods in org.ejml.sparse.csc.decomposition.qr that return IGrowArrayModifier and TypeMethodDescriptionQrLeftLookingDecomposition_DSCC.getGwork()QrLeftLookingDecomposition_FSCC.getGwork()Methods in org.ejml.sparse.csc.decomposition.qr with parameters of type IGrowArrayModifier and TypeMethodDescriptionstatic voidQrHelperFunctions_DSCC.rank1UpdateMultR(DMatrixSparseCSC V, int colV, double gamma, DMatrixSparseCSC A, DMatrixSparseCSC C, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs a rank-1 update operation on the submatrix specified by V with the multiply on the right.
C = (I - γ*v*vT)*Astatic voidQrHelperFunctions_FSCC.rank1UpdateMultR(FMatrixSparseCSC V, int colV, float gamma, FMatrixSparseCSC A, FMatrixSparseCSC C, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs a rank-1 update operation on the submatrix specified by V with the multiply on the right.
C = (I - γ*v*vT)*AvoidQrStructuralCounts_DSCC.setGwork(IGrowArray gwork) voidQrStructuralCounts_FSCC.setGwork(IGrowArray gwork) -
Uses of IGrowArray in org.ejml.sparse.csc.misc
Methods in org.ejml.sparse.csc.misc that return IGrowArrayModifier and TypeMethodDescriptionApplyFillReductionPermutation_DSCC.getGw()ApplyFillReductionPermutation_FSCC.getGw()Methods in org.ejml.sparse.csc.misc with parameters of type IGrowArrayModifier and TypeMethodDescriptionstatic voidImplCommonOps_DSCC.add(double alpha, DMatrixSparseCSC A, double beta, DMatrixSparseCSC B, DMatrixSparseCSC C, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs matrix addition:
C = αA + βBstatic voidImplCommonOps_FSCC.add(float alpha, FMatrixSparseCSC A, float beta, FMatrixSparseCSC B, FMatrixSparseCSC C, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs matrix addition:
C = αA + βBstatic voidImplCommonOpsWithSemiRing_DSCC.add(double alpha, DMatrixSparseCSC A, double beta, DMatrixSparseCSC B, DMatrixSparseCSC C, DSemiRing semiRing, @Nullable Mask mask, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs matrix addition:
C = A + Bstatic voidImplCommonOpsWithSemiRing_FSCC.add(float alpha, FMatrixSparseCSC A, float beta, FMatrixSparseCSC B, FMatrixSparseCSC C, FSemiRing semiRing, @Nullable Mask mask, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs matrix addition:
C = A + Bstatic voidImplCommonOps_DSCC.addColAppend(double alpha, DMatrixSparseCSC A, int colA, double beta, DMatrixSparseCSC B, int colB, DMatrixSparseCSC C, @Nullable IGrowArray gw) Adds the results of adding a column in A and B as a new column in C.
C(:,end+1) = α*A(:,colA) + β*B(:,colB)static voidImplCommonOps_FSCC.addColAppend(float alpha, FMatrixSparseCSC A, int colA, float beta, FMatrixSparseCSC B, int colB, FMatrixSparseCSC C, @Nullable IGrowArray gw) Adds the results of adding a column in A and B as a new column in C.
C(:,end+1) = α*A(:,colA) + β*B(:,colB)static voidImplCommonOpsWithSemiRing_DSCC.addColAppend(DMatrixSparseCSC A, int colA, DMatrixSparseCSC B, int colB, DMatrixSparseCSC C, DSemiRing semiRing, @Nullable IGrowArray gw) Adds the results of adding a column in A and B as a new column in C.
C(:,end+1) = A(:,colA) + B(:,colB)static voidImplCommonOpsWithSemiRing_FSCC.addColAppend(FMatrixSparseCSC A, int colA, FMatrixSparseCSC B, int colB, FMatrixSparseCSC C, FSemiRing semiRing, @Nullable IGrowArray gw) Adds the results of adding a column in A and B as a new column in C.
C(:,end+1) = A(:,colA) + B(:,colB)static voidImplCommonOps_DSCC.duplicatesAdd(DMatrixSparseCSC A, @Nullable IGrowArray work) static voidImplCommonOps_FSCC.duplicatesAdd(FMatrixSparseCSC A, @Nullable IGrowArray work) static voidImplCommonOps_DSCC.elementMult(DMatrixSparseCSC A, DMatrixSparseCSC B, DMatrixSparseCSC C, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs element-wise multiplication:
C_ij = A_ij * B_ijstatic voidImplCommonOps_FSCC.elementMult(FMatrixSparseCSC A, FMatrixSparseCSC B, FMatrixSparseCSC C, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs element-wise multiplication:
C_ij = A_ij * B_ijstatic voidImplCommonOpsWithSemiRing_DSCC.elementMult(DMatrixSparseCSC A, DMatrixSparseCSC B, DMatrixSparseCSC C, DSemiRing semiRing, @Nullable Mask mask, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs element-wise multiplication:
C_ij = A_ij * B_ijstatic voidImplCommonOpsWithSemiRing_FSCC.elementMult(FMatrixSparseCSC A, FMatrixSparseCSC B, FMatrixSparseCSC C, FSemiRing semiRing, @Nullable Mask mask, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs element-wise multiplication:
C_ij = A_ij * B_ijstatic voidTriangularSolver_DSCC.eliminationTree(DMatrixSparseCSC A, boolean ata, int[] parent, @Nullable IGrowArray gwork) If ata=false then it computes the elimination tree for sparse lower triangular square matrix generated from Cholesky decomposition.static voidTriangularSolver_FSCC.eliminationTree(FMatrixSparseCSC A, boolean ata, int[] parent, @Nullable IGrowArray gwork) If ata=false then it computes the elimination tree for sparse lower triangular square matrix generated from Cholesky decomposition.static voidTriangularSolver_DSCC.postorder(int[] parent, int N, int[] post, @Nullable IGrowArray gwork) Sorts an elimination treeTriangularSolver_DSCC.eliminationTree(org.ejml.data.DMatrixSparseCSC, boolean, int[], org.ejml.data.IGrowArray)into postorder.static voidTriangularSolver_FSCC.postorder(int[] parent, int N, int[] post, @Nullable IGrowArray gwork) Sorts an elimination treeTriangularSolver_FSCC.eliminationTree(org.ejml.data.FMatrixSparseCSC, boolean, int[], org.ejml.data.IGrowArray)into postorder.voidApplyFillReductionPermutation_DSCC.setGw(IGrowArray gw) voidApplyFillReductionPermutation_FSCC.setGw(IGrowArray gw) static voidTriangularSolver_DSCC.solve(DMatrixSparseCSC G, boolean lower, DMatrixSparseCSC B, DMatrixSparseCSC X, @org.jetbrains.annotations.Nullable int[] pinv, @Nullable DGrowArray g_x, @Nullable IGrowArray g_xi, @Nullable IGrowArray g_w) Computes the solution to the triangular system.static voidTriangularSolver_FSCC.solve(FMatrixSparseCSC G, boolean lower, FMatrixSparseCSC B, FMatrixSparseCSC X, @org.jetbrains.annotations.Nullable int[] pinv, @Nullable FGrowArray g_x, @Nullable IGrowArray g_xi, @Nullable IGrowArray g_w) Computes the solution to the triangular system.static intTriangularSolver_DSCC.solveColB(DMatrixSparseCSC G, boolean lower, DMatrixSparseCSC B, int colB, double[] x, @org.jetbrains.annotations.Nullable int[] pinv, @Nullable IGrowArray g_xi, int[] w) Computes the solution to a triangular system with (optional) pivots.static intTriangularSolver_FSCC.solveColB(FMatrixSparseCSC G, boolean lower, FMatrixSparseCSC B, int colB, float[] x, @org.jetbrains.annotations.Nullable int[] pinv, @Nullable IGrowArray g_xi, int[] w) Computes the solution to a triangular system with (optional) pivots.static voidTriangularSolver_DSCC.solveTran(DMatrixSparseCSC G, boolean lower, DMatrixSparseCSC B, DMatrixSparseCSC X, @org.jetbrains.annotations.Nullable int[] pinv, @Nullable DGrowArray g_x, @Nullable IGrowArray g_xi, @Nullable IGrowArray g_w) Solution to a sparse transposed triangular system with sparse B and sparse Xstatic voidTriangularSolver_FSCC.solveTran(FMatrixSparseCSC G, boolean lower, FMatrixSparseCSC B, FMatrixSparseCSC X, @org.jetbrains.annotations.Nullable int[] pinv, @Nullable FGrowArray g_x, @Nullable IGrowArray g_xi, @Nullable IGrowArray g_w) Solution to a sparse transposed triangular system with sparse B and sparse Xstatic voidImplCommonOps_DSCC.symmLowerToFull(DMatrixSparseCSC A, DMatrixSparseCSC B, @Nullable IGrowArray gw) Given a symmetric matrix which is represented by a lower triangular matrix convert it back into a full symmetric matrixstatic voidImplCommonOps_FSCC.symmLowerToFull(FMatrixSparseCSC A, FMatrixSparseCSC B, @Nullable IGrowArray gw) Given a symmetric matrix which is represented by a lower triangular matrix convert it back into a full symmetric matrixstatic voidImplCommonOps_DSCC.transpose(DMatrixSparseCSC A, DMatrixSparseCSC C, @Nullable IGrowArray gw) Performs a matrix transpose.static voidImplCommonOps_FSCC.transpose(FMatrixSparseCSC A, FMatrixSparseCSC C, @Nullable IGrowArray gw) Performs a matrix transpose. -
Uses of IGrowArray in org.ejml.sparse.csc.mult
Fields in org.ejml.sparse.csc.mult declared as IGrowArrayModifier and TypeFieldDescriptionfinal IGrowArrayWorkspace_MT_DSCC.gwfinal IGrowArrayWorkspace_MT_FSCC.gwMethods in org.ejml.sparse.csc.mult with parameters of type IGrowArrayModifier and TypeMethodDescriptionstatic doubleImplMultiplication_DSCC.dotInnerColumns(DMatrixSparseCSC A, int colA, DMatrixSparseCSC B, int colB, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Computes the inner product of two column vectors taken from the input matrices.static floatImplMultiplication_FSCC.dotInnerColumns(FMatrixSparseCSC A, int colA, FMatrixSparseCSC B, int colB, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Computes the inner product of two column vectors taken from the input matrices.static voidImplMultiplication_DSCC.mult(DMatrixSparseCSC A, DMatrixSparseCSC B, DMatrixSparseCSC C, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs matrix multiplication.static voidImplMultiplication_FSCC.mult(FMatrixSparseCSC A, FMatrixSparseCSC B, FMatrixSparseCSC C, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs matrix multiplication.static voidImplMultiplicationWithSemiRing_DSCC.mult(DMatrixSparseCSC A, DMatrixSparseCSC B, DMatrixSparseCSC C, DSemiRing semiRing, @Nullable Mask mask, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs matrix multiplication.static voidImplMultiplicationWithSemiRing_FSCC.mult(FMatrixSparseCSC A, FMatrixSparseCSC B, FMatrixSparseCSC C, FSemiRing semiRing, @Nullable Mask mask, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs matrix multiplication.