Uses of Class
org.ejml.data.IGrowArray
Package
Description
-
Uses of IGrowArray in org.ejml
Modifier 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
-
Uses of IGrowArray in org.ejml.dense.row.decompose.lu
Modifier 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
Modifier and TypeMethodDescriptionint[]
LUDecompositionBase_DDRM.getRowPivotV
(@Nullable IGrowArray pivot) int[]
LUDecompositionBase_FDRM.getRowPivotV
(@Nullable IGrowArray pivot) -
Uses of IGrowArray in org.ejml.interfaces.decomposition
Modifier and TypeMethodDescriptionint[]
LUDecomposition.getRowPivotV
(@Nullable IGrowArray pivot) Returns the row pivot vector -
Uses of IGrowArray in org.ejml.masks
Modifier and TypeMethodDescriptionDMaskSparse.Builder.withWorkArray
(IGrowArray gw) DMaskSparseStructural.Builder.withWorkArray
(IGrowArray gw) FMaskSparse.Builder.withWorkArray
(IGrowArray gw) FMaskSparseStructural.Builder.withWorkArray
(IGrowArray gw) ModifierConstructorDescriptionDMaskSparse
(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
Modifier and TypeMethodDescriptionstatic DMatrixSparseCSC
DConvertMatrixStruct.convert
(DMatrixSparseTriplet src, @Nullable DMatrixSparseCSC dst, @Nullable IGrowArray histStorage) Converts DMatrixSparseTriplet into a DMatrixSparseCSC.static FMatrixSparseCSC
FConvertMatrixStruct.convert
(FMatrixSparseTriplet src, @Nullable FMatrixSparseCSC dst, @Nullable IGrowArray histStorage) Converts FMatrixSparseTriplet into a FMatrixSparseCSC. -
Uses of IGrowArray in org.ejml.simple.ops
-
Uses of IGrowArray in org.ejml.sparse
Modifier and TypeFieldDescriptionprotected @Nullable IGrowArray
ComputePermutation.pcol
protected @Nullable IGrowArray
ComputePermutation.prow
Modifier and TypeMethodDescription@Nullable IGrowArray
ComputePermutation.getColumn()
Returns column permutation@Nullable IGrowArray
ComputePermutation.getRow()
Returns row permutation -
Uses of IGrowArray in org.ejml.sparse.csc
Modifier and TypeMethodDescriptionstatic DMatrixSparseCSC
CommonOps_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 FMatrixSparseCSC
CommonOps_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 DMatrixSparseCSC
CommonOpsWithSemiRing_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 FMatrixSparseCSC
CommonOpsWithSemiRing_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 double
CommonOps_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 float
CommonOps_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 void
CommonOps_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 void
CommonOps_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 DMatrixSparseCSC
CommonOps_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 FMatrixSparseCSC
CommonOps_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 DMatrixSparseCSC
CommonOpsWithSemiRing_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 FMatrixSparseCSC
CommonOpsWithSemiRing_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 DMatrixRMaj
CommonOps_DSCC.maxRows
(DMatrixSparseCSC input, @Nullable DMatrixRMaj output, @Nullable IGrowArray gw) Computes the maximum of each row in the input matrix and returns the results in a vector:
bj = max(i=1:n ; aji)static FMatrixRMaj
CommonOps_FSCC.maxRows
(FMatrixSparseCSC input, @Nullable FMatrixRMaj output, @Nullable IGrowArray gw) Computes the maximum of each row in the input matrix and returns the results in a vector:
bj = max(i=1:n ; aji)static DMatrixRMaj
CommonOps_DSCC.minRows
(DMatrixSparseCSC input, @Nullable DMatrixRMaj output, @Nullable IGrowArray gw) Computes the minimum of each row in the input matrix and returns the results in a vector:
bj = min(i=1:n ; aji)static FMatrixRMaj
CommonOps_FSCC.minRows
(FMatrixSparseCSC input, @Nullable FMatrixRMaj output, @Nullable IGrowArray gw) Computes the minimum of each row in the input matrix and returns the results in a vector:
bj = min(i=1:n ; aji)static DMatrixSparseCSC
CommonOps_DSCC.mult
(DMatrixSparseCSC A, DMatrixSparseCSC B, @Nullable DMatrixSparseCSC outputC, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs matrix multiplication.static FMatrixSparseCSC
CommonOps_FSCC.mult
(FMatrixSparseCSC A, FMatrixSparseCSC B, @Nullable FMatrixSparseCSC outputC, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs matrix multiplication.static DMatrixSparseCSC
CommonOpsWithSemiRing_DSCC.mult
(DMatrixSparseCSC A, DMatrixSparseCSC B, @Nullable DMatrixSparseCSC output, DSemiRing semiRing, @Nullable Mask mask, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs matrix multiplication.static FMatrixSparseCSC
CommonOpsWithSemiRing_FSCC.mult
(FMatrixSparseCSC A, FMatrixSparseCSC B, @Nullable FMatrixSparseCSC output, FSemiRing semiRing, @Nullable Mask mask, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs matrix multiplication.static void
CommonOps_DSCC.permuteSymmetric
(DMatrixSparseCSC input, int[] permInv, DMatrixSparseCSC output, @Nullable IGrowArray gw) Applies the permutation to upper triangular symmetric matrices.static void
CommonOps_FSCC.permuteSymmetric
(FMatrixSparseCSC input, int[] permInv, FMatrixSparseCSC output, @Nullable IGrowArray gw) Applies the permutation to upper triangular symmetric matrices.static void
CommonOps_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 void
CommonOps_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 DMatrixSparseCSC
CommonOps_DSCC.transpose
(DMatrixSparseCSC A, @Nullable DMatrixSparseCSC A_t, @Nullable IGrowArray gw) Perform matrix transposestatic FMatrixSparseCSC
CommonOps_FSCC.transpose
(FMatrixSparseCSC A, @Nullable FMatrixSparseCSC A_t, @Nullable IGrowArray gw) Perform matrix transpose -
Uses of IGrowArray in org.ejml.sparse.csc.decomposition.chol
-
Uses of IGrowArray in org.ejml.sparse.csc.decomposition.lu
Modifier and TypeMethodDescriptionLuUpLooking_DSCC.getGw()
LuUpLooking_FSCC.getGw()
LuUpLooking_DSCC.getGxi()
LuUpLooking_FSCC.getGxi()
Modifier 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
Modifier and TypeMethodDescriptionQrLeftLookingDecomposition_DSCC.getGwork()
QrLeftLookingDecomposition_FSCC.getGwork()
Modifier and TypeMethodDescriptionstatic void
QrHelperFunctions_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 void
QrHelperFunctions_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)*Avoid
QrStructuralCounts_DSCC.setGwork
(IGrowArray gwork) void
QrStructuralCounts_FSCC.setGwork
(IGrowArray gwork) -
Uses of IGrowArray in org.ejml.sparse.csc.misc
Modifier and TypeMethodDescriptionApplyFillReductionPermutation_DSCC.getGw()
ApplyFillReductionPermutation_FSCC.getGw()
Modifier and TypeMethodDescriptionstatic void
ImplCommonOps_DSCC.add
(double alpha, DMatrixSparseCSC A, double beta, DMatrixSparseCSC B, DMatrixSparseCSC C, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs matrix addition:
C = αA + βBstatic void
ImplCommonOps_FSCC.add
(float alpha, FMatrixSparseCSC A, float beta, FMatrixSparseCSC B, FMatrixSparseCSC C, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs matrix addition:
C = αA + βBstatic void
ImplCommonOpsWithSemiRing_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 void
ImplCommonOpsWithSemiRing_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 void
ImplCommonOps_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 void
ImplCommonOps_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 void
ImplCommonOpsWithSemiRing_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 void
ImplCommonOpsWithSemiRing_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 void
ImplCommonOps_DSCC.duplicatesAdd
(DMatrixSparseCSC A, @Nullable IGrowArray work) static void
ImplCommonOps_FSCC.duplicatesAdd
(FMatrixSparseCSC A, @Nullable IGrowArray work) static void
ImplCommonOps_DSCC.elementMult
(DMatrixSparseCSC A, DMatrixSparseCSC B, DMatrixSparseCSC C, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs element-wise multiplication:
C_ij = A_ij * B_ijstatic void
ImplCommonOps_FSCC.elementMult
(FMatrixSparseCSC A, FMatrixSparseCSC B, FMatrixSparseCSC C, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs element-wise multiplication:
C_ij = A_ij * B_ijstatic void
ImplCommonOpsWithSemiRing_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 void
ImplCommonOpsWithSemiRing_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 void
TriangularSolver_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 void
TriangularSolver_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 void
TriangularSolver_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 void
TriangularSolver_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.void
ApplyFillReductionPermutation_DSCC.setGw
(IGrowArray gw) void
ApplyFillReductionPermutation_FSCC.setGw
(IGrowArray gw) static void
TriangularSolver_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 void
TriangularSolver_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 int
TriangularSolver_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 int
TriangularSolver_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 void
TriangularSolver_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 void
TriangularSolver_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 void
ImplCommonOps_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 void
ImplCommonOps_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 void
ImplCommonOps_DSCC.transpose
(DMatrixSparseCSC A, DMatrixSparseCSC C, @Nullable IGrowArray gw) Performs a matrix transpose.static void
ImplCommonOps_FSCC.transpose
(FMatrixSparseCSC A, FMatrixSparseCSC C, @Nullable IGrowArray gw) Performs a matrix transpose. -
Uses of IGrowArray in org.ejml.sparse.csc.mult
Modifier and TypeFieldDescriptionfinal IGrowArray
Workspace_MT_DSCC.gw
final IGrowArray
Workspace_MT_FSCC.gw
Modifier and TypeMethodDescriptionstatic double
ImplMultiplication_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 float
ImplMultiplication_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 void
ImplMultiplication_DSCC.mult
(DMatrixSparseCSC A, DMatrixSparseCSC B, DMatrixSparseCSC C, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs matrix multiplication.static void
ImplMultiplication_FSCC.mult
(FMatrixSparseCSC A, FMatrixSparseCSC B, FMatrixSparseCSC C, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs matrix multiplication.static void
ImplMultiplicationWithSemiRing_DSCC.mult
(DMatrixSparseCSC A, DMatrixSparseCSC B, DMatrixSparseCSC C, DSemiRing semiRing, @Nullable Mask mask, @Nullable IGrowArray gw, @Nullable DGrowArray gx) Performs matrix multiplication.static void
ImplMultiplicationWithSemiRing_FSCC.mult
(FMatrixSparseCSC A, FMatrixSparseCSC B, FMatrixSparseCSC C, FSemiRing semiRing, @Nullable Mask mask, @Nullable IGrowArray gw, @Nullable FGrowArray gx) Performs matrix multiplication.