Skip navigation links
A C D E F G H I L M N O P Q R S T U V Z 

A

add(double, DMatrixSparseCSC, double, DMatrixSparseCSC, DMatrixSparseCSC, IGrowArray, DGrowArray) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Performs matrix addition:
C = αA + βB
add(double, DMatrixSparseCSC, double, DMatrixSparseCSC, DMatrixSparseCSC, IGrowArray, DGrowArray) - Static method in class org.ejml.sparse.csc.misc.ImplCommonOps_DSCC
Performs matrix addition:
C = αA + βB
addColAppend(double, DMatrixSparseCSC, int, double, DMatrixSparseCSC, int, DMatrixSparseCSC, IGrowArray) - Static method in class org.ejml.sparse.csc.misc.ImplCommonOps_DSCC
Adds the results of adding a column in A and B as a new column in C.
C(:,end+1) = α*A(:,colA) + β*B(:,colB)
addRowsInAInToC(DMatrixSparseCSC, int, DMatrixSparseCSC, int, int[]) - Static method in class org.ejml.sparse.csc.mult.ImplSparseSparseMult_DSCC
Adds rows to C[*,colC] that are in A[*,colA] as long as they are marked in w.
adjust(IGrowArray, int) - Static method in class org.ejml.sparse.csc.misc.TriangularSolver_DSCC
Resizes the array to ensure that it is at least of length desired and returns its internal array
adjust(IGrowArray, int, int) - Static method in class org.ejml.sparse.csc.misc.TriangularSolver_DSCC
 
adjust(DGrowArray, int) - Static method in class org.ejml.sparse.csc.misc.TriangularSolver_DSCC
Resizes the array to ensure that it is at least of length desired and returns its internal array
adjustClear(IGrowArray, int) - Static method in class org.ejml.sparse.csc.misc.TriangularSolver_DSCC
 
apply(DMatrixSparseCSC) - Method in class org.ejml.sparse.csc.misc.ApplyFillReductionPermutation
Computes and applies the fill reduction permutation.
ApplyFillReductionPermutation - Class in org.ejml.sparse.csc.misc
Applies the fill reduction row pivots to the input matrix to reduce fill in during decomposition/solve.
ApplyFillReductionPermutation(ComputePermutation<DMatrixSparseCSC>, boolean) - Constructor for class org.ejml.sparse.csc.misc.ApplyFillReductionPermutation
 
applyHouseholder(DMatrixSparseCSC, int, double, double[]) - Static method in class org.ejml.sparse.csc.decomposition.qr.QrHelperFunctions_DSCC
Applies a sparse Householder vector to a dense vector.

C

changeSign(DMatrixSparseCSC, DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
B = -A.
checkDuplicateElements(DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Checks for duplicate elements.
checkIndicesSorted(DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Checks to see if row indicies are sorted into ascending order.
checkSortedFlag(DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
 
checkStructure(DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
 
cholesky() - Static method in class org.ejml.sparse.csc.factory.DecompositionFactory_DSCC
 
cholesky(FillReducing) - Static method in class org.ejml.sparse.csc.factory.LinearSolverFactory_DSCC
 
CholeskyUpLooking_DSCC - Class in org.ejml.sparse.csc.decomposition.chol
Performs a Cholesky decomposition using an up looking algorthm on a DMatrixSparseCSC.
CholeskyUpLooking_DSCC() - Constructor for class org.ejml.sparse.csc.decomposition.chol.CholeskyUpLooking_DSCC
 
ColumnCounts_DSCC - Class in org.ejml.sparse.csc.misc
Computes the column counts of the upper triangular portion of L as in L*LT=A.
ColumnCounts_DSCC(boolean) - Constructor for class org.ejml.sparse.csc.misc.ColumnCounts_DSCC
Configures column count algorithm.
CommonOps_DSCC - Class in org.ejml.sparse.csc
 
CommonOps_DSCC() - Constructor for class org.ejml.sparse.csc.CommonOps_DSCC
 
computeDeterminant() - Method in class org.ejml.sparse.csc.decomposition.chol.CholeskyUpLooking_DSCC
 
computeDeterminant() - Method in class org.ejml.sparse.csc.decomposition.lu.LuUpLooking_DSCC
 
computeHouseholder(double[], int, int, double, DScalar) - Static method in class org.ejml.sparse.csc.decomposition.qr.QrHelperFunctions_DSCC
Creates a householder reflection.
ComputePermutation<T extends org.ejml.data.Matrix> - Class in org.ejml.sparse
 
ComputePermutation(boolean, boolean) - Constructor for class org.ejml.sparse.ComputePermutation
 
concatColumns(DMatrixSparseCSC, DMatrixSparseCSC, DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Concats two matrices along their columns (horizontal).
concatRows(DMatrixSparseCSC, DMatrixSparseCSC, DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Concats two matrices along their rows (vertical).
create(FillReducing) - Static method in class org.ejml.sparse.csc.factory.FillReductionFactory_DSCC
 

D

decompose(DMatrixSparseCSC) - Method in class org.ejml.sparse.csc.decomposition.chol.CholeskyUpLooking_DSCC
 
decompose(DMatrixSparseCSC) - Method in class org.ejml.sparse.csc.decomposition.lu.LuUpLooking_DSCC
 
decompose(DMatrixSparseCSC) - Method in class org.ejml.sparse.csc.decomposition.qr.QrLeftLookingDecomposition_DSCC
 
DecompositionFactory_DSCC - Class in org.ejml.sparse.csc.factory
Factory for sparse matrix decompositions
DecompositionFactory_DSCC() - Constructor for class org.ejml.sparse.csc.factory.DecompositionFactory_DSCC
 
det(DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Returns the determinant of the matrix.
diag(double...) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Returns a diagonal matrix with the specified diagonal elements.
diag(DMatrixSparseCSC, int, double...) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
 
divide(DMatrixSparseCSC, double, DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
B = A/scalar.
dotInnerColumns(DMatrixSparseCSC, int, DMatrixSparseCSC, int, IGrowArray, DGrowArray) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Computes the inner product of two column vectors taken from the input matrices.
dotInnerColumns(DMatrixSparseCSC, int, DMatrixSparseCSC, int, IGrowArray, DGrowArray) - Static method in class org.ejml.sparse.csc.mult.ImplSparseSparseMult_DSCC
Computes the inner product of two column vectors taken from the input matrices.

E

elementMax(DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
 
elementMaxAbs(DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
 
elementMin(DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
 
elementMinAbs(DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Returns the value of the element with the largest abs()
elementMult(DMatrixSparseCSC, DMatrixSparseCSC, DMatrixSparseCSC, IGrowArray, DGrowArray) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Performs an element-wise multiplication.
C[i,j] = A[i,j]*B[i,j]
All matrices must have the same shape.
elementMult(DMatrixSparseCSC, DMatrixSparseCSC, DMatrixSparseCSC, IGrowArray, DGrowArray) - Static method in class org.ejml.sparse.csc.misc.ImplCommonOps_DSCC
Performs element-wise multiplication:
C_ij = A_ij * B_ij
elementSum(DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
 
eliminationTree(DMatrixSparseCSC, boolean, int[], IGrowArray) - Static method in class org.ejml.sparse.csc.misc.TriangularSolver_DSCC
If ata=false then it computes the elimination tree for sparse lower triangular square matrix generated from Cholesky decomposition.
ensureNotSingular(DMatrixSparseCSC, Random) - Static method in class org.ejml.sparse.csc.RandomMatrices_DSCC
Modies the matrix to make sure that at least one element in each column has a value
extract(DMatrixSparseCSC, int, int, int, int, DMatrixSparseCSC, int, int) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Extracts a submatrix from 'src' and inserts it in a submatrix in 'dst'.
extractColumn(DMatrixSparseCSC, int, DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Extracts a column from A and stores it into out.
extractDiag(DMatrixSparseCSC, DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Extracts the diagonal elements 'src' write it to the 'dst' vector.
extractRows(DMatrixSparseCSC, int, int, DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Creates a submatrix by extracting the specified rows from A.

F

fastNormF(DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.NormOps_DSCC
 
FillReducing - Enum in org.ejml.sparse
Different types of fill in reducing techniques that can be selected
FillReductionFactory_DSCC - Class in org.ejml.sparse.csc.factory
 
FillReductionFactory_DSCC() - Constructor for class org.ejml.sparse.csc.factory.FillReductionFactory_DSCC
 

G

getArrayP() - Method in class org.ejml.sparse.csc.misc.ApplyFillReductionPermutation
 
getArrayPinv() - Method in class org.ejml.sparse.csc.misc.ApplyFillReductionPermutation
 
getArrayQ() - Method in class org.ejml.sparse.csc.misc.ApplyFillReductionPermutation
 
getBeta() - Method in class org.ejml.sparse.csc.decomposition.qr.QrLeftLookingDecomposition_DSCC
 
getBeta(int) - Method in class org.ejml.sparse.csc.decomposition.qr.QrLeftLookingDecomposition_DSCC
 
getColPivotMatrix(T) - Method in interface org.ejml.sparse.csc.decomposition.qr.QrpSparseDecomposition
Creates the column pivot matrix.
getColPivots() - Method in interface org.ejml.sparse.csc.decomposition.qr.QrpSparseDecomposition
Ordering of each column after pivoting.
getColumn() - Method in class org.ejml.sparse.ComputePermutation
Returns column permutation
getDecomposition() - Method in class org.ejml.sparse.csc.linsol.chol.LinearSolverCholesky_DSCC
 
getDecomposition() - Method in class org.ejml.sparse.csc.linsol.lu.LinearSolverLu_DSCC
 
getDecomposition() - Method in class org.ejml.sparse.csc.linsol.qr.LinearSolverQrLeftLooking_DSCC
 
getFicticousRowCount() - Method in class org.ejml.sparse.csc.decomposition.qr.QrStructuralCounts_DSCC
 
getFillPermutation() - Method in class org.ejml.sparse.csc.decomposition.qr.QrLeftLookingDecomposition_DSCC
 
getFillReduce() - Method in class org.ejml.sparse.csc.misc.ApplyFillReductionPermutation
 
getGw() - Method in class org.ejml.sparse.csc.decomposition.chol.CholeskyUpLooking_DSCC
 
getGw() - Method in class org.ejml.sparse.csc.misc.ApplyFillReductionPermutation
 
getGx() - Method in class org.ejml.sparse.csc.decomposition.chol.CholeskyUpLooking_DSCC
 
getL() - Method in class org.ejml.sparse.csc.decomposition.chol.CholeskyUpLooking_DSCC
 
getL() - Method in class org.ejml.sparse.csc.decomposition.lu.LuUpLooking_DSCC
 
getLeftMost() - Method in class org.ejml.sparse.csc.decomposition.qr.QrStructuralCounts_DSCC
 
getLower(DMatrixSparseCSC) - Method in class org.ejml.sparse.csc.decomposition.lu.LuUpLooking_DSCC
 
getM2() - Method in class org.ejml.sparse.csc.decomposition.qr.QrStructuralCounts_DSCC
 
getParent() - Method in class org.ejml.sparse.csc.decomposition.qr.QrStructuralCounts_DSCC
 
getPinv() - Method in class org.ejml.sparse.csc.decomposition.lu.LuUpLooking_DSCC
 
getPinv() - Method in class org.ejml.sparse.csc.decomposition.qr.QrStructuralCounts_DSCC
 
getQ(DMatrixSparseCSC, boolean) - Method in class org.ejml.sparse.csc.decomposition.qr.QrLeftLookingDecomposition_DSCC
 
getR(DMatrixSparseCSC, boolean) - Method in class org.ejml.sparse.csc.decomposition.qr.QrLeftLookingDecomposition_DSCC
 
getR() - Method in class org.ejml.sparse.csc.decomposition.qr.QrLeftLookingDecomposition_DSCC
 
getRank() - Method in interface org.ejml.sparse.csc.decomposition.qr.QrpSparseDecomposition
Returns the rank as determined by the algorithm.
getReduceFill() - Method in class org.ejml.sparse.csc.decomposition.lu.LuUpLooking_DSCC
 
getReducePermutation() - Method in class org.ejml.sparse.csc.decomposition.lu.LuUpLooking_DSCC
 
getRow() - Method in class org.ejml.sparse.ComputePermutation
Returns row permutation
getRowPivot(DMatrixSparseCSC) - Method in class org.ejml.sparse.csc.decomposition.lu.LuUpLooking_DSCC
 
getRowPivotMatrix(T) - Method in interface org.ejml.sparse.csc.decomposition.qr.QrpSparseDecomposition
Creates the row pivot matrix.
getRowPivots() - Method in interface org.ejml.sparse.csc.decomposition.qr.QrpSparseDecomposition
Ordering of each row after pivoting.
getRowPivotV(IGrowArray) - Method in class org.ejml.sparse.csc.decomposition.lu.LuUpLooking_DSCC
 
getStructure() - Method in class org.ejml.sparse.csc.decomposition.qr.QrLeftLookingDecomposition_DSCC
 
getT(DMatrixSparseCSC) - Method in class org.ejml.sparse.csc.decomposition.chol.CholeskyUpLooking_DSCC
 
getU() - Method in class org.ejml.sparse.csc.decomposition.lu.LuUpLooking_DSCC
 
getUpper(DMatrixSparseCSC) - Method in class org.ejml.sparse.csc.decomposition.lu.LuUpLooking_DSCC
 
getV() - Method in class org.ejml.sparse.csc.decomposition.qr.QrLeftLookingDecomposition_DSCC
 

H

hasColumnPermutation() - Method in class org.ejml.sparse.ComputePermutation
 
hasRowPermutation() - Method in class org.ejml.sparse.ComputePermutation
 
hasUncountable(DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.MatrixFeatures_DSCC
 

I

identity(int) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
 
identity(int, int) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
 
ImplCommonOps_DSCC - Class in org.ejml.sparse.csc.misc
Implementation class.
ImplCommonOps_DSCC() - Constructor for class org.ejml.sparse.csc.misc.ImplCommonOps_DSCC
 
ImplSparseSparseMult_DSCC - Class in org.ejml.sparse.csc.mult
 
ImplSparseSparseMult_DSCC() - Constructor for class org.ejml.sparse.csc.mult.ImplSparseSparseMult_DSCC
 
inputModified() - Method in class org.ejml.sparse.csc.decomposition.chol.CholeskyUpLooking_DSCC
 
inputModified() - Method in class org.ejml.sparse.csc.decomposition.lu.LuUpLooking_DSCC
 
inputModified() - Method in class org.ejml.sparse.csc.decomposition.qr.QrLeftLookingDecomposition_DSCC
 
invert(DMatrixSparseCSC, DMatrixRMaj) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Performs a matrix inversion operation that does not modify the original and stores the results in another matrix.
isApplied() - Method in class org.ejml.sparse.csc.misc.ApplyFillReductionPermutation
 
isColumnPivot() - Method in interface org.ejml.sparse.csc.decomposition.qr.QrpSparseDecomposition
 
isEquals(DMatrixSparseCSC, DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.MatrixFeatures_DSCC
 
isEquals(DMatrixSparseCSC, DMatrixSparseCSC, double) - Static method in class org.ejml.sparse.csc.MatrixFeatures_DSCC
 
isEquals(DMatrixSparseTriplet, DMatrixSparseTriplet) - Static method in class org.ejml.sparse.triplet.MatrixFeatures_DSTL
 
isEquals(DMatrixSparseTriplet, DMatrixSparseTriplet, double) - Static method in class org.ejml.sparse.triplet.MatrixFeatures_DSTL
 
isEqualsSort(DMatrixSparseCSC, DMatrixSparseCSC, double) - Static method in class org.ejml.sparse.csc.MatrixFeatures_DSCC
 
isFillPermutated() - Method in class org.ejml.sparse.csc.decomposition.qr.QrLeftLookingDecomposition_DSCC
 
isIdenticalSort(DMatrixSparseCSC, DMatrixSparseCSC, double) - Static method in class org.ejml.sparse.csc.MatrixFeatures_DSCC
 
isIdentity(DMatrixSparseCSC, double) - Static method in class org.ejml.sparse.csc.MatrixFeatures_DSCC
 
isLower() - Method in class org.ejml.sparse.csc.decomposition.chol.CholeskyUpLooking_DSCC
 
isLowerTriangle(DMatrixSparseCSC, int, double) - Static method in class org.ejml.sparse.csc.MatrixFeatures_DSCC
Checks to see if a matrix is lower triangular or Hessenberg.
isOrthogonal(DMatrixSparseCSC, double) - Static method in class org.ejml.sparse.csc.MatrixFeatures_DSCC
Checks to see if a matrix is orthogonal or isometric.
isPositiveDefinite(DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.MatrixFeatures_DSCC
Checks to see if the matrix is positive definite.
isRowPivot() - Method in interface org.ejml.sparse.csc.decomposition.qr.QrpSparseDecomposition
 
isSameShape(DMatrixSparseTriplet, DMatrixSparseTriplet) - Static method in class org.ejml.sparse.triplet.MatrixFeatures_DSTL
 
isSameStructure(DMatrixSparseCSC, DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.MatrixFeatures_DSCC
Checks to see if the two matrices have the same shape and same pattern of non-zero elements
isSingular() - Method in class org.ejml.sparse.csc.decomposition.lu.LuUpLooking_DSCC
 
isSingular() - Method in class org.ejml.sparse.csc.decomposition.qr.QrLeftLookingDecomposition_DSCC
 
isStructureLocked() - Method in class org.ejml.sparse.csc.decomposition.chol.CholeskyUpLooking_DSCC
 
isStructureLocked() - Method in class org.ejml.sparse.csc.decomposition.lu.LuUpLooking_DSCC
 
isStructureLocked() - Method in class org.ejml.sparse.csc.decomposition.qr.QrLeftLookingDecomposition_DSCC
 
isStructureLocked() - Method in class org.ejml.sparse.csc.linsol.chol.LinearSolverCholesky_DSCC
 
isStructureLocked() - Method in class org.ejml.sparse.csc.linsol.lu.LinearSolverLu_DSCC
 
isStructureLocked() - Method in class org.ejml.sparse.csc.linsol.qr.LinearSolverQrLeftLooking_DSCC
 
isSymmetric(DMatrixSparseCSC, double) - Static method in class org.ejml.sparse.csc.MatrixFeatures_DSCC
Checks to see if the matrix is symmetric to within tolerance.
isTranspose(DMatrixSparseCSC, DMatrixSparseCSC, double) - Static method in class org.ejml.sparse.csc.MatrixFeatures_DSCC
 
isVector(DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.MatrixFeatures_DSCC
Returns true if the input is a vector
isZeros(DMatrixSparseCSC, double) - Static method in class org.ejml.sparse.csc.MatrixFeatures_DSCC
 

L

LinearSolverCholesky_DSCC - Class in org.ejml.sparse.csc.linsol.chol
Linear solver using a sparse Cholesky decomposition.
LinearSolverCholesky_DSCC(CholeskyUpLooking_DSCC, ComputePermutation<DMatrixSparseCSC>) - Constructor for class org.ejml.sparse.csc.linsol.chol.LinearSolverCholesky_DSCC
 
LinearSolverFactory_DSCC - Class in org.ejml.sparse.csc.factory
Factory for sparse linear solvers
LinearSolverFactory_DSCC() - Constructor for class org.ejml.sparse.csc.factory.LinearSolverFactory_DSCC
 
LinearSolverLu_DSCC - Class in org.ejml.sparse.csc.linsol.lu
LU Decomposition based solver for square matrices.
LinearSolverLu_DSCC(LuUpLooking_DSCC) - Constructor for class org.ejml.sparse.csc.linsol.lu.LinearSolverLu_DSCC
 
LinearSolverQrLeftLooking_DSCC - Class in org.ejml.sparse.csc.linsol.qr
Sparse linear solver implemented using QrLeftLookingDecomposition_DSCC.
LinearSolverQrLeftLooking_DSCC(QrLeftLookingDecomposition_DSCC) - Constructor for class org.ejml.sparse.csc.linsol.qr.LinearSolverQrLeftLooking_DSCC
 
lockStructure() - Method in class org.ejml.sparse.csc.decomposition.chol.CholeskyUpLooking_DSCC
 
lockStructure() - Method in class org.ejml.sparse.csc.decomposition.lu.LuUpLooking_DSCC
 
lockStructure() - Method in class org.ejml.sparse.csc.decomposition.qr.QrLeftLookingDecomposition_DSCC
 
lockStructure() - Method in class org.ejml.sparse.csc.linsol.chol.LinearSolverCholesky_DSCC
 
lockStructure() - Method in class org.ejml.sparse.csc.linsol.lu.LinearSolverLu_DSCC
 
lockStructure() - Method in class org.ejml.sparse.csc.linsol.qr.LinearSolverQrLeftLooking_DSCC
 
lu(FillReducing) - Static method in class org.ejml.sparse.csc.factory.DecompositionFactory_DSCC
 
lu(FillReducing) - Static method in class org.ejml.sparse.csc.factory.LinearSolverFactory_DSCC
 
LuUpLooking_DSCC - Class in org.ejml.sparse.csc.decomposition.lu
LU Decomposition using a left looking algorithm for DMatrixSparseCSC.
LuUpLooking_DSCC(ComputePermutation<DMatrixSparseCSC>) - Constructor for class org.ejml.sparse.csc.decomposition.lu.LuUpLooking_DSCC
 

M

MatrixFeatures_DSCC - Class in org.ejml.sparse.csc
 
MatrixFeatures_DSCC() - Constructor for class org.ejml.sparse.csc.MatrixFeatures_DSCC
 
MatrixFeatures_DSTL - Class in org.ejml.sparse.triplet
 
MatrixFeatures_DSTL() - Constructor for class org.ejml.sparse.triplet.MatrixFeatures_DSTL
 
modifiesA() - Method in class org.ejml.sparse.csc.linsol.chol.LinearSolverCholesky_DSCC
 
modifiesA() - Method in class org.ejml.sparse.csc.linsol.lu.LinearSolverLu_DSCC
 
modifiesA() - Method in class org.ejml.sparse.csc.linsol.qr.LinearSolverQrLeftLooking_DSCC
 
modifiesB() - Method in class org.ejml.sparse.csc.linsol.chol.LinearSolverCholesky_DSCC
 
modifiesB() - Method in class org.ejml.sparse.csc.linsol.lu.LinearSolverLu_DSCC
 
modifiesB() - Method in class org.ejml.sparse.csc.linsol.qr.LinearSolverQrLeftLooking_DSCC
 
mult(DMatrixSparseCSC, DMatrixSparseCSC, DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
 
mult(DMatrixSparseCSC, DMatrixSparseCSC, DMatrixSparseCSC, IGrowArray, DGrowArray) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Performs matrix multiplication.
mult(DMatrixSparseCSC, DMatrixRMaj, DMatrixRMaj) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Performs matrix multiplication.
mult(DMatrixSparseCSC, DMatrixSparseCSC, DMatrixSparseCSC, IGrowArray, DGrowArray) - Static method in class org.ejml.sparse.csc.mult.ImplSparseSparseMult_DSCC
Performs matrix multiplication.
mult(DMatrixSparseCSC, DMatrixRMaj, DMatrixRMaj) - Static method in class org.ejml.sparse.csc.mult.ImplSparseSparseMult_DSCC
 
multAddColA(DMatrixSparseCSC, int, double, DMatrixSparseCSC, int, double[], int[]) - Static method in class org.ejml.sparse.csc.mult.ImplSparseSparseMult_DSCC
Performs the performing operation x = x + A(:,i)*alpha
multTransA(DMatrixSparseCSC, DMatrixSparseCSC, DMatrixSparseCSC, IGrowArray, DGrowArray) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
 
multTransA(DMatrixSparseCSC, DMatrixSparseCSC, DMatrixSparseCSC, IGrowArray, DGrowArray) - Static method in class org.ejml.sparse.csc.mult.ImplSparseSparseMult_DSCC
Performs matrix multiplication.
multTransB(DMatrixSparseCSC, DMatrixSparseCSC, DMatrixSparseCSC, IGrowArray, DGrowArray) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Performs matrix multiplication.
multTransB(DMatrixSparseCSC, DMatrixSparseCSC, DMatrixSparseCSC, IGrowArray, DGrowArray) - Static method in class org.ejml.sparse.csc.mult.ImplSparseSparseMult_DSCC
Performs matrix multiplication.

N

nonzero(int, int, double, double, Random) - Static method in class org.ejml.sparse.csc.RandomMatrices_DSCC
 
normF(DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.NormOps_DSCC
 
NormOps_DSCC - Class in org.ejml.sparse.csc
 
NormOps_DSCC() - Constructor for class org.ejml.sparse.csc.NormOps_DSCC
 

O

org.ejml.sparse - package org.ejml.sparse
 
org.ejml.sparse.csc - package org.ejml.sparse.csc
 
org.ejml.sparse.csc.decomposition.chol - package org.ejml.sparse.csc.decomposition.chol
 
org.ejml.sparse.csc.decomposition.lu - package org.ejml.sparse.csc.decomposition.lu
 
org.ejml.sparse.csc.decomposition.qr - package org.ejml.sparse.csc.decomposition.qr
 
org.ejml.sparse.csc.factory - package org.ejml.sparse.csc.factory
 
org.ejml.sparse.csc.linsol.chol - package org.ejml.sparse.csc.linsol.chol
 
org.ejml.sparse.csc.linsol.lu - package org.ejml.sparse.csc.linsol.lu
 
org.ejml.sparse.csc.linsol.qr - package org.ejml.sparse.csc.linsol.qr
 
org.ejml.sparse.csc.misc - package org.ejml.sparse.csc.misc
 
org.ejml.sparse.csc.mult - package org.ejml.sparse.csc.mult
 
org.ejml.sparse.triplet - package org.ejml.sparse.triplet
 

P

pcol - Variable in class org.ejml.sparse.ComputePermutation
 
performSymbolic(DMatrixSparseCSC) - Method in class org.ejml.sparse.csc.decomposition.chol.CholeskyUpLooking_DSCC
 
permutationInverse(int[], int[], int) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Computes the inverse permutation vector
permutationInverse(int[], int) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
 
permutationMatrix(int[], boolean, int, DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Converts the permutation vector into a matrix.
permutationVector(DMatrixSparseCSC, int[]) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Converts the permutation matrix into a vector
permute(int[], DMatrixSparseCSC, int[], DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Applies the forward column and inverse row permutation specified by the two vector to the input matrix and save the results in the output matrix.
permute(int[], double[], double[], int) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Permutes a vector.
permuteInv(int[], double[], double[], int) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Permutes a vector in the inverse.
permuteRowInv(int[], DMatrixSparseCSC, DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Applies the row permutation specified by the vector to the input matrix and save the results in the output matrix.
permuteSymmetric(DMatrixSparseCSC, int[], DMatrixSparseCSC, IGrowArray) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Applies the permutation to upper triangular symmetric matrices.
postorder(int[], int, int[], IGrowArray) - Static method in class org.ejml.sparse.csc.misc.TriangularSolver_DSCC
postorder_dfs(int, int, int[], int[], int) - Static method in class org.ejml.sparse.csc.misc.TriangularSolver_DSCC
process(T) - Method in class org.ejml.sparse.ComputePermutation
 
process(DMatrixSparseCSC) - Method in class org.ejml.sparse.csc.decomposition.qr.QrStructuralCounts_DSCC
Examins the structure of A for QR decomposition
process(DMatrixSparseCSC, int[], int[], int[]) - Method in class org.ejml.sparse.csc.misc.ColumnCounts_DSCC
Processes and computes column counts of A
prow - Variable in class org.ejml.sparse.ComputePermutation
 

Q

qr(FillReducing) - Static method in class org.ejml.sparse.csc.factory.DecompositionFactory_DSCC
 
qr(FillReducing) - Static method in class org.ejml.sparse.csc.factory.LinearSolverFactory_DSCC
 
QrHelperFunctions_DSCC - Class in org.ejml.sparse.csc.decomposition.qr
Functions used with a sparse QR decomposition
QrHelperFunctions_DSCC() - Constructor for class org.ejml.sparse.csc.decomposition.qr.QrHelperFunctions_DSCC
 
QrLeftLookingDecomposition_DSCC - Class in org.ejml.sparse.csc.decomposition.qr
Left-looking QR decomposition algorithm for sparse matrices.
QrLeftLookingDecomposition_DSCC(ComputePermutation<DMatrixSparseCSC>) - Constructor for class org.ejml.sparse.csc.decomposition.qr.QrLeftLookingDecomposition_DSCC
 
QrpSparseDecomposition<T extends org.ejml.data.Matrix> - Interface in org.ejml.sparse.csc.decomposition.qr
Similar to QRDecomposition but it can handle the rank deficient case by performing column pivots during the decomposition.
QrStructuralCounts_DSCC - Class in org.ejml.sparse.csc.decomposition.qr
Determines the structure of the QR decomposition.
QrStructuralCounts_DSCC() - Constructor for class org.ejml.sparse.csc.decomposition.qr.QrStructuralCounts_DSCC
 
quality() - Method in class org.ejml.sparse.csc.linsol.chol.LinearSolverCholesky_DSCC
 
quality() - Method in class org.ejml.sparse.csc.linsol.lu.LinearSolverLu_DSCC
 
quality() - Method in class org.ejml.sparse.csc.linsol.qr.LinearSolverQrLeftLooking_DSCC
 
qualityTriangular(DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.misc.TriangularSolver_DSCC
Computes the quality of a triangular matrix, where the quality of a matrix is defined in LinearSolver.quality().

R

rand - Static variable in class org.ejml.sparse.csc.factory.FillReductionFactory_DSCC
 
RandomMatrices_DSCC - Class in org.ejml.sparse.csc
 
RandomMatrices_DSCC() - Constructor for class org.ejml.sparse.csc.RandomMatrices_DSCC
 
RandomMatrices_DSTL - Class in org.ejml.sparse.triplet
 
RandomMatrices_DSTL() - Constructor for class org.ejml.sparse.triplet.RandomMatrices_DSTL
 
rank1UpdateMultR(DMatrixSparseCSC, int, double, DMatrixSparseCSC, DMatrixSparseCSC, IGrowArray, DGrowArray) - Static method in class org.ejml.sparse.csc.decomposition.qr.QrHelperFunctions_DSCC
Performs a rank-1 update operation on the submatrix specified by V with the multiply on the right.

C = (I - γ*v*vT)*A
rectangle(int, int, int, double, double, Random) - Static method in class org.ejml.sparse.csc.RandomMatrices_DSCC
Randomly generates matrix with the specified number of non-zero elements filled with values from min to max.
rectangle(int, int, int, Random) - Static method in class org.ejml.sparse.csc.RandomMatrices_DSCC
 
removeZeros(DMatrixSparseCSC, DMatrixSparseCSC, double) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Copies all elements from input into output which are > tol.
removeZeros(DMatrixSparseCSC, double) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Removes all elements from the matrix that are > tol.
removeZeros(DMatrixSparseCSC, DMatrixSparseCSC, double) - Static method in class org.ejml.sparse.csc.misc.ImplCommonOps_DSCC
 
removeZeros(DMatrixSparseCSC, double) - Static method in class org.ejml.sparse.csc.misc.ImplCommonOps_DSCC
 

S

scale(double, DMatrixSparseCSC, DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
B = scalar*A.
searchNzRowsElim(DMatrixSparseCSC, int, int[], int[], int[]) - Static method in class org.ejml.sparse.csc.misc.TriangularSolver_DSCC
Given an elimination tree compute the non-zero elements in the specified row of L given the symmetric A matrix.
searchNzRowsInB(DMatrixSparseCSC, DMatrixSparseCSC, int, int[], int[], IGrowArray) - Static method in class org.ejml.sparse.csc.misc.TriangularSolver_DSCC
Determines which elements in 'X' will be non-zero when the system below is solved for.
setA(DMatrixSparseCSC) - Method in class org.ejml.sparse.csc.linsol.chol.LinearSolverCholesky_DSCC
 
setA(DMatrixSparseCSC) - Method in class org.ejml.sparse.csc.linsol.lu.LinearSolverLu_DSCC
 
setA(DMatrixSparseCSC) - Method in class org.ejml.sparse.csc.linsol.qr.LinearSolverQrLeftLooking_DSCC
 
setGw(IGrowArray) - Method in class org.ejml.sparse.csc.misc.ApplyFillReductionPermutation
 
setGwork(IGrowArray) - Method in class org.ejml.sparse.csc.decomposition.qr.QrStructuralCounts_DSCC
 
setIdentity(DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
 
solve(DMatrixSparseCSC, DMatrixRMaj, DMatrixRMaj) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Solves for x in the following equation:

A*x = b
solve(DMatrixRMaj, DMatrixRMaj) - Method in class org.ejml.sparse.csc.linsol.chol.LinearSolverCholesky_DSCC
 
solve(DMatrixRMaj, DMatrixRMaj) - Method in class org.ejml.sparse.csc.linsol.lu.LinearSolverLu_DSCC
 
solve(DMatrixRMaj, DMatrixRMaj) - Method in class org.ejml.sparse.csc.linsol.qr.LinearSolverQrLeftLooking_DSCC
 
solve(DMatrixSparseCSC, boolean, DMatrixSparseCSC, DMatrixSparseCSC, DGrowArray, IGrowArray, IGrowArray) - Static method in class org.ejml.sparse.csc.misc.TriangularSolver_DSCC
Computes the solution to the triangular system.
solve(DMatrixSparseCSC, boolean, DMatrixSparseCSC, int, double[], int[], IGrowArray, IGrowArray) - Static method in class org.ejml.sparse.csc.misc.TriangularSolver_DSCC
Computes the solution to a triangular system with (optional) pivots.
solveL(DMatrixSparseCSC, double[]) - Static method in class org.ejml.sparse.csc.misc.TriangularSolver_DSCC
Solves for a lower triangular matrix against a dense matrix.
solveTranL(DMatrixSparseCSC, double[]) - Static method in class org.ejml.sparse.csc.misc.TriangularSolver_DSCC
Solves for the transpose of a lower triangular matrix against a dense matrix.
solveU(DMatrixSparseCSC, double[]) - Static method in class org.ejml.sparse.csc.misc.TriangularSolver_DSCC
Solves for an upper triangular matrix against a dense vector.
symmetric(int, int, double, double, Random) - Static method in class org.ejml.sparse.csc.RandomMatrices_DSCC
Creates a random symmetric matrix.
symmetricPosDef(int, int, Random) - Static method in class org.ejml.sparse.csc.RandomMatrices_DSCC
Creates a random symmetric positive definite matrix.

T

trace(DMatrixSparseCSC) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
This computes the trace of the matrix:

trace = ∑i=1:n { aii }
where n = min(numRows,numCols)
transpose(DMatrixSparseCSC, DMatrixSparseCSC, IGrowArray) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Perform matrix transpose
transpose(DMatrixSparseCSC, DMatrixSparseCSC, IGrowArray) - Static method in class org.ejml.sparse.csc.misc.ImplCommonOps_DSCC
Performs a matrix transpose.
triangle(boolean, int, double, double, Random) - Static method in class org.ejml.sparse.csc.RandomMatrices_DSCC
Creates a triangular matrix where the amount of fill is randomly selected too.
triangleLower(int, int, int, double, double, Random) - Static method in class org.ejml.sparse.csc.RandomMatrices_DSCC
Randomly generates lower triangular (or hessenberg) matrix with the specified number of of non-zero elements.
triangleUpper(int, int, int, double, double, Random) - Static method in class org.ejml.sparse.csc.RandomMatrices_DSCC
 
TriangularSolver_DSCC - Class in org.ejml.sparse.csc.misc
 
TriangularSolver_DSCC() - Constructor for class org.ejml.sparse.csc.misc.TriangularSolver_DSCC
 

U

uniform(int, int, int, double, double, Random) - Static method in class org.ejml.sparse.triplet.RandomMatrices_DSTL
Randomly generates matrix with the specified number of matrix elements filled with values from min to max.

V

valueOf(String) - Static method in enum org.ejml.sparse.FillReducing
Returns the enum constant of this type with the specified name.
values() - Static method in enum org.ejml.sparse.FillReducing
Returns an array containing the constants of this enum type, in the order they are declared.

Z

zero(DMatrixSparseCSC, int, int, int, int) - Static method in class org.ejml.sparse.csc.CommonOps_DSCC
Zeros an inner rectangle inside the matrix.
A C D E F G H I L M N O P Q R S T U V Z 
Skip navigation links