- A - Variable in class org.ejml.dense.block.decomposition.hessenberg.TridiagonalDecompositionHouseholder_DDRB
-
- A - Variable in class org.ejml.dense.row.linsol.LinearSolverAbstract_DDRM
-
- Ablock - Variable in class org.ejml.dense.row.decomposition.BaseDecomposition_DDRB_to_DDRM
-
- add(DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c = a + b
cij = aij + bij
- add(DMatrix2, DMatrix2, DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c = a + b
ci = ai + bi
- add(DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c = a + b
cij = aij + bij
- add(DMatrix3, DMatrix3, DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c = a + b
ci = ai + bi
- add(DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c = a + b
cij = aij + bij
- add(DMatrix4, DMatrix4, DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c = a + b
ci = ai + bi
- add(DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c = a + b
cij = aij + bij
- add(DMatrix5, DMatrix5, DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c = a + b
ci = ai + bi
- add(DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c = a + b
cij = aij + bij
- add(DMatrix6, DMatrix6, DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c = a + b
ci = ai + bi
- add(DMatrixD1, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = a + b
cij = aij + bij
- add(DMatrixD1, double, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = a + β * b
cij = aij + β * bij
- add(double, DMatrixD1, double, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = α * a + β * b
cij = α * aij + β * bij
- add(double, DMatrixD1, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = α * a + b
cij = α * aij + bij
- add(DMatrixD1, double) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs an in-place scalar addition:
a = a + val
aij = aij + val
- add(DMatrixD1, double, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs scalar addition:
c = a + val
cij = aij + val
- add_row(int, DSubmatrixD1, int, double, DSubmatrixD1, int, double, DSubmatrixD1, int, int, int) - Static method in class org.ejml.dense.block.decomposition.qr.BlockHouseHolder_DDRB
-
- add_row(int, DSubmatrixD1, int, double, DSubmatrixD1, int, double, DSubmatrixD1, int, int, int) - Static method in class org.ejml.dense.block.VectorOps_DDRB
-
Row vector add:
add: ci = α*ai + βBi
where 'a', 'b', and 'c' are row vectors within the row block vectors of A, B, and C respectively.
- addComputedEigen2x2(int, int) - Method in class org.ejml.dense.row.decomposition.eig.watched.WatchedDoubleStepQREigen_DDRM
-
- addEigenAt(int) - Method in class org.ejml.dense.row.decomposition.eig.watched.WatchedDoubleStepQREigen_DDRM
-
- addEquals(DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
a = a + b
aij = aij + bij
- addEquals(DMatrix2, DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
a = a + b
ai = ai + bi
- addEquals(DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
a = a + b
aij = aij + bij
- addEquals(DMatrix3, DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
a = a + b
ai = ai + bi
- addEquals(DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
a = a + b
aij = aij + bij
- addEquals(DMatrix4, DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
a = a + b
ai = ai + bi
- addEquals(DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
a = a + b
aij = aij + bij
- addEquals(DMatrix5, DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
a = a + b
ai = ai + bi
- addEquals(DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
a = a + b
aij = aij + bij
- addEquals(DMatrix6, DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
a = a + b
ai = ai + bi
- addEquals(DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
a = a + b
aij = aij + bij
- addEquals(DMatrixD1, double, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
a = a + β * b
aij = aij + β * bij
- addIdentity(DMatrix1Row, DMatrix1Row, double) - Static method in class org.ejml.dense.row.SpecializedOps_DDRM
-
Performs the following operation:
B = A + αI
- addOuterProd(double, DMatrixD1, DMatrixD1, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.VectorVectorMult_DDRM
-
Adds to A ∈ ℜ m × n the results of an outer product multiplication
of the two vectors.
- addRow(DMatrixRMaj, DMatrixRMaj, double[], int, boolean) - Method in class org.ejml.dense.row.decomposition.qr.QrUpdate_DDRM
-
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.
- addRowToA(double[], int) - Method in interface org.ejml.dense.row.linsol.AdjustableLinearSolver_DDRM
-
Adds a row to A.
- addRowToA(double[], int) - Method in class org.ejml.dense.row.linsol.qr.AdjLinearSolverQr_DDRM
-
- addUniform(DMatrixRMaj, double, double, Random) - Static method in class org.ejml.dense.row.RandomMatrices_DDRM
-
Adds random values to each element in the matrix from an uniform distribution.
aij = aij + U(min,max)
- AdjLinearSolverQr_DDRM - Class in org.ejml.dense.row.linsol.qr
-
A solver for QR decomposition that can efficiently modify the previous decomposition when
data is added or removed.
- AdjLinearSolverQr_DDRM() - Constructor for class org.ejml.dense.row.linsol.qr.AdjLinearSolverQr_DDRM
-
- adjustable() - Static method in class org.ejml.dense.row.factory.LinearSolverFactory_DDRM
-
Create a solver which can efficiently add and remove elements instead of recomputing
everything from scratch.
- AdjustableLinearSolver_DDRM - Interface in org.ejml.dense.row.linsol
-
In many situations solutions to linear systems that share many of the same data points are needed.
- alg - Variable in class org.ejml.dense.row.decomposition.BaseDecomposition_DDRB_to_DDRM
-
- alg - Variable in class org.ejml.dense.row.linsol.LinearSolver_DDRB_to_DDRM
-
- applyQ(DMatrixRBlock) - Method in class org.ejml.dense.block.decomposition.qr.QRDecompositionHouseholder_DDRB
-
Multiplies the provided matrix by Q using householder reflectors.
- applyQ(DMatrixRBlock, boolean) - Method in class org.ejml.dense.block.decomposition.qr.QRDecompositionHouseholder_DDRB
-
Specialized version of applyQ() that allows the zeros in an identity matrix
to be taken advantage of depending on if isIdentity is true or not.
- applyQ(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholderTran_DDRM
-
A = Q*A
- applyQTran(DMatrixRBlock) - Method in class org.ejml.dense.block.decomposition.qr.QRDecompositionHouseholder_DDRB
-
Multiplies the provided matrix by QT using householder reflectors.
- applyReflectorsToRow(int, DSubmatrixD1, DSubmatrixD1, int) - Static method in class org.ejml.dense.block.decomposition.hessenberg.TridiagonalHelper_DDRB
-
Applies the reflectors that have been computed previously to the specified row.
- applyTranQ(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholderTran_DDRM
-
A = QT*A
- changeSign(DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Changes the sign of every element in the matrix.
aij = -aij
- changeSign(DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Changes the sign of every element in the vector.
ai = -ai
- changeSign(DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Changes the sign of every element in the matrix.
aij = -aij
- changeSign(DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Changes the sign of every element in the vector.
ai = -ai
- changeSign(DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Changes the sign of every element in the matrix.
aij = -aij
- changeSign(DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Changes the sign of every element in the vector.
ai = -ai
- changeSign(DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Changes the sign of every element in the matrix.
aij = -aij
- changeSign(DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Changes the sign of every element in the vector.
ai = -ai
- changeSign(DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Changes the sign of every element in the matrix.
aij = -aij
- changeSign(DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Changes the sign of every element in the vector.
ai = -ai
- changeSign(DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Changes the sign of every element in the matrix.
aij = -aij
- changeSign(DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Changes the sign of every element in the matrix.
outputij = -inputij
- checkForAndHandleZeros() - Method in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
Checks to see if either the diagonal element or off diagonal element is zero.
- checkIdenticalShape(DMatrixRBlock, DMatrixRBlock) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
Checks to see if the two matrices have an identical shape an block size.
- checkIdentity(DMatrixRMaj, int, int) - Static method in class org.ejml.dense.row.decomposition.UtilDecompositons_DDRM
-
- checkSvdMatrixSize(DMatrixRMaj, boolean, DMatrixRMaj, DMatrixRMaj, boolean) - Static method in class org.ejml.dense.row.SingularOps_DDRM
-
Checks to see if all the provided matrices are the expected size for an SVD.
- checkZeros(DMatrixRMaj, int, int) - Static method in class org.ejml.dense.row.decomposition.UtilDecompositons_DDRM
-
- checkZerosLT(DMatrixRMaj, int, int) - Static method in class org.ejml.dense.row.decomposition.UtilDecompositons_DDRM
-
Creates a zeros matrix only if A does not already exist.
- checkZerosUT(DMatrixRMaj, int, int) - Static method in class org.ejml.dense.row.decomposition.UtilDecompositons_DDRM
-
Creates a zeros matrix only if A does not already exist.
- chol(int, boolean) - Static method in class org.ejml.dense.row.factory.DecompositionFactory_DDRM
-
Returns a CholeskyDecomposition_F64
that has been optimized for the specified matrix size.
- chol(int) - Static method in class org.ejml.dense.row.factory.LinearSolverFactory_DDRM
-
Creates a linear solver using Cholesky decomposition
- CholeskyDecomposition_DDRB_to_DDRM - Class in org.ejml.dense.row.decomposition.chol
-
- CholeskyDecomposition_DDRB_to_DDRM(boolean) - Constructor for class org.ejml.dense.row.decomposition.chol.CholeskyDecomposition_DDRB_to_DDRM
-
- CholeskyDecompositionBlock_DDRM - Class in org.ejml.dense.row.decomposition.chol
-
This is an implementation of Cholesky that processes internal submatrices as blocks.
- CholeskyDecompositionBlock_DDRM(int) - Constructor for class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionBlock_DDRM
-
Creates a CholeksyDecomposition capable of decomposing a matrix that is
n by n, where n is the width.
- CholeskyDecompositionCommon_DDRM - Class in org.ejml.dense.row.decomposition.chol
-
This is an abstract class for a Cholesky decomposition.
- CholeskyDecompositionCommon_DDRM(boolean) - Constructor for class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionCommon_DDRM
-
Specifies if a lower or upper variant should be constructed.
- CholeskyDecompositionInner_DDRM - Class in org.ejml.dense.row.decomposition.chol
-
This implementation of a Cholesky decomposition using the inner-product form.
- CholeskyDecompositionInner_DDRM() - Constructor for class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionInner_DDRM
-
- CholeskyDecompositionInner_DDRM(boolean) - Constructor for class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionInner_DDRM
-
- CholeskyDecompositionLDL_DDRM - Class in org.ejml.dense.row.decomposition.chol
-
This variant on the Cholesky decomposition avoid the need to take the square root
by performing the following decomposition:
L*D*LT=A
where L is a lower triangular matrix with zeros on the diagonal.
- CholeskyDecompositionLDL_DDRM() - Constructor for class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionLDL_DDRM
-
- CholeskyOuterForm_DDRB - Class in org.ejml.dense.block.decomposition.chol
-
Block Cholesky using outer product form.
- CholeskyOuterForm_DDRB(boolean) - Constructor for class org.ejml.dense.block.decomposition.chol.CholeskyOuterForm_DDRB
-
Creates a new BlockCholeskyOuterForm
- CholeskyOuterSolver_DDRB - Class in org.ejml.dense.block.linsol.chol
-
Linear solver that uses a block cholesky decomposition.
- CholeskyOuterSolver_DDRB() - Constructor for class org.ejml.dense.block.linsol.chol.CholeskyOuterSolver_DDRB
-
- cholLDL(int) - Static method in class org.ejml.dense.row.factory.DecompositionFactory_DDRM
-
- columnsToVector(DMatrixRMaj, DMatrixRMaj[]) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Converts the columns in a matrix into a set of vectors.
- CommonOps_DDF2 - Class in org.ejml.dense.fixed
-
Common matrix operations for fixed sized matrices which are 2 x 2 or 2 element vectors.
- CommonOps_DDF2() - Constructor for class org.ejml.dense.fixed.CommonOps_DDF2
-
- CommonOps_DDF3 - Class in org.ejml.dense.fixed
-
Common matrix operations for fixed sized matrices which are 3 x 3 or 3 element vectors.
- CommonOps_DDF3() - Constructor for class org.ejml.dense.fixed.CommonOps_DDF3
-
- CommonOps_DDF4 - Class in org.ejml.dense.fixed
-
Common matrix operations for fixed sized matrices which are 4 x 4 or 4 element vectors.
- CommonOps_DDF4() - Constructor for class org.ejml.dense.fixed.CommonOps_DDF4
-
- CommonOps_DDF5 - Class in org.ejml.dense.fixed
-
Common matrix operations for fixed sized matrices which are 5 x 5 or 5 element vectors.
- CommonOps_DDF5() - Constructor for class org.ejml.dense.fixed.CommonOps_DDF5
-
- CommonOps_DDF6 - Class in org.ejml.dense.fixed
-
Common matrix operations for fixed sized matrices which are 6 x 6 or 6 element vectors.
- CommonOps_DDF6() - Constructor for class org.ejml.dense.fixed.CommonOps_DDF6
-
- CommonOps_DDRM - Class in org.ejml.dense.row
-
Common matrix operations are contained here.
- CommonOps_DDRM() - Constructor for class org.ejml.dense.row.CommonOps_DDRM
-
- commonSetup(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholder_DDRM
-
This function performs sanity check on the input for decompose and sets up the QR matrix.
- compute(DMatrix1Row) - Method in class org.ejml.dense.row.misc.DeterminantFromMinor_DDRM
-
Computes the determinant for the specified matrix.
- computeDeterminant() - Method in class org.ejml.dense.block.decomposition.chol.CholeskyOuterForm_DDRB
-
- computeDeterminant() - Method in class org.ejml.dense.row.decomposition.chol.CholeskyDecomposition_DDRB_to_DDRM
-
- computeDeterminant() - Method in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionCommon_DDRM
-
- computeDeterminant() - Method in class org.ejml.dense.row.decomposition.lu.LUDecompositionBase_DDRM
-
Computes the determinant from the LU decomposition.
- computeDirect(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.eig.EigenPowerMethod_DDRM
-
This method computes the eigen vector with the largest eigen value by using the
direct power method.
- computeEigenValue(DMatrixRMaj, DMatrixRMaj) - Static method in class org.ejml.dense.row.EigenOps_DDRM
-
Given matrix A and an eigen vector of A, compute the corresponding eigen value.
- computeEigenVector(DMatrixRMaj, double) - Static method in class org.ejml.dense.row.EigenOps_DDRM
-
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)
}
- computeHouseHolderCol(int, DSubmatrixD1, double[], int) - Static method in class org.ejml.dense.block.decomposition.qr.BlockHouseHolder_DDRB
-
Computes the householder vector that is used to create reflector for the column.
- computeHouseHolderRow(int, DSubmatrixD1, double[], int) - Static method in class org.ejml.dense.block.decomposition.qr.BlockHouseHolder_DDRB
-
Computes the householder vector from the specified row
- computeLikelihoodP() - Method in class org.ejml.dense.row.CovarianceRandomDraw_DDRM
-
Computes the likelihood of the random draw
- computeRotator(double, double) - Method in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
Computes a rotator that will set run to zero (?)
- computeRowOfV(int, DSubmatrixD1, DSubmatrixD1, int, double) - Static method in class org.ejml.dense.block.decomposition.hessenberg.TridiagonalHelper_DDRB
-
Final computation for a single row of 'v':
v = y -(1/2)γ(y^T*u)*u
- computeShift() - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
- computeShiftDirect(DMatrixRMaj, double) - Method in class org.ejml.dense.row.decomposition.eig.EigenPowerMethod_DDRM
-
Computes the most dominant eigen vector of A using a shifted matrix.
- computeShiftInvert(DMatrixRMaj, double) - Method in class org.ejml.dense.row.decomposition.eig.EigenPowerMethod_DDRM
-
Computes the most dominant eigen vector of A using an inverted shifted matrix.
- computeTauAndDivide(int, int, double[], int, double) - Static method in class org.ejml.dense.row.decomposition.qr.QrHelperFunctions_DDRM
-
- computeTauAndDivide(int, int, double[], double) - Static method in class org.ejml.dense.row.decomposition.qr.QrHelperFunctions_DDRM
-
Normalizes elements in 'u' by dividing by max and computes the norm2 of the normalized
array u.
- computeTauAndDivideCol(int, DSubmatrixD1, int, double) - Static method in class org.ejml.dense.block.decomposition.qr.BlockHouseHolder_DDRB
-
From the specified column of Y tau is computed and each element is divided by 'max'.
- computeTauAndDivideRow(int, DSubmatrixD1, int, int, double) - Static method in class org.ejml.dense.block.decomposition.qr.BlockHouseHolder_DDRB
-
From the specified row of Y tau is computed and each element is divided by 'max'.
- computeU(int) - Method in class org.ejml.dense.row.decomposition.bidiagonal.BidiagonalDecompositionRow_DDRM
-
- computeV(int) - Method in class org.ejml.dense.row.decomposition.bidiagonal.BidiagonalDecompositionRow_DDRM
-
- computeV_blockVector(int, DSubmatrixD1, double[], DSubmatrixD1) - Static method in class org.ejml.dense.block.decomposition.hessenberg.TridiagonalHelper_DDRB
-
Given an already computed tridiagonal decomposition, compute the V row block vector.
y(:) = A*u
v(i) = y - (1/2)*γ*(y^T*u)*u
- computeW_Column(int, DSubmatrixD1, DSubmatrixD1, double[], double[], int) - Static method in class org.ejml.dense.block.decomposition.qr.BlockHouseHolder_DDRB
-
Computes W from the householder reflectors stored in the columns of the column block
submatrix Y.
- computeW_row(int, DSubmatrixD1, DSubmatrixD1, double[], int) - Static method in class org.ejml.dense.block.decomposition.hessenberg.TridiagonalHelper_DDRB
-
Computes W from the householder reflectors stored in the columns of the row block
submatrix Y.
- computeWilkinsonShift() - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
- computeY(int, DSubmatrixD1, DSubmatrixD1, int, double) - Static method in class org.ejml.dense.block.decomposition.hessenberg.TridiagonalHelper_DDRB
-
Computes the 'y' vector and stores the result in 'v'
y = -γ(A + U*V^T + V*U^T)u
- computeY_t_V(int, DSubmatrixD1, int, double[]) - Static method in class org.ejml.dense.block.decomposition.qr.BlockHouseHolder_DDRB
-
Computes YTv(j).
- computeZ(int, DSubmatrixD1, DSubmatrixD1, int, double[], double) - Static method in class org.ejml.dense.block.decomposition.qr.BlockHouseHolder_DDRB
-
- concatColumns(DMatrixRMaj...) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Concatinates all the matrices together along their columns.
- concatRows(DMatrixRMaj...) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Concatinates all the matrices together along their columns.
- conditionP(DMatrixRMaj, double) - Static method in class org.ejml.dense.row.NormOps_DDRM
-
The condition number of a matrix is used to measure the sensitivity of the linear
system Ax=b.
- conditionP2(DMatrixRMaj) - Static method in class org.ejml.dense.row.NormOps_DDRM
-
The condition p = 2 number of a matrix is used to measure the sensitivity of the linear
system Ax=b.
- convert(DMatrixRMaj, DMatrixRBlock) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
Converts a row major matrix into a row major block matrix.
- convert(DMatrixRBlock, DMatrixRMaj) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
Converts a row major block matrix into a row major matrix.
- convert(DMatrixRMaj, int) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
- convert(DMatrixRMaj) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
- convertBlockToRow(int, int, int, double[], double[]) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
Converts matrix data stored is a block row major format into a row major format in place.
- convertBlockToRow(int, int, int, double[]) - Method in class org.ejml.dense.row.decomposition.BaseDecomposition_DDRB_to_DDRM
-
- convertRowToBlock(int, int, int, double[], double[]) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
Converts matrix data stored is a row major format into a block row major format in place.
- convertToColumnMajor(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholderColumn_DDRM
-
Converts the standard row-major matrix into a column-major vector
that is advantageous for this problem.
- convertTranSrc(DMatrixRMaj, DMatrixRBlock) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
Converts the transpose of a row major matrix into a row major block matrix.
- copy(DMatrix, DMatrix) - Static method in class org.ejml.generic.GenericMatrixOps_F64
-
- copyChangeRow(int[], DMatrixRMaj, DMatrixRMaj) - Static method in class org.ejml.dense.row.SpecializedOps_DDRM
-
Creates a copy of a matrix but swaps the rows as specified by the order array.
- copyDiag(double[]) - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
- copyEigenvalues(double[]) - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
- copyOff(double[]) - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
- copyTriangle(boolean, DMatrixRBlock, DMatrixRBlock) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
Copies either the upper or lower triangular portion of src into dst.
- copyTriangle(DMatrixRMaj, DMatrixRMaj, boolean) - Static method in class org.ejml.dense.row.SpecializedOps_DDRM
-
Copies just the upper or lower triangular portion of a matrix.
- countNonZero(DMatrixRMaj) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Counts the number of elements in A which are not zero.
- countTrue(BMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Counts the number of elements in A which are true
- CovarianceOps_DDRM - Class in org.ejml.dense.row
-
Contains operations specific to covariance matrices.
- CovarianceOps_DDRM() - Constructor for class org.ejml.dense.row.CovarianceOps_DDRM
-
- CovarianceRandomDraw_DDRM - Class in org.ejml.dense.row
-
Generates random vectors based on a zero mean multivariate Gaussian distribution.
- CovarianceRandomDraw_DDRM(Random, DMatrixRMaj) - Constructor for class org.ejml.dense.row.CovarianceRandomDraw_DDRM
-
Creates a random distribution with the specified mean and covariance.
- createBulge(int, double, boolean) - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
Performs a similar transform on A-pI
- createBulge(int, double, double, boolean) - Method in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
Performs a similar transform on BTB-pI
- createBulge2by2(int, double, boolean) - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
- createBulgeSingleStep(int, double) - Method in class org.ejml.dense.row.decomposition.eig.watched.WatchedDoubleStepQREigen_DDRM
-
- createMatrixD(EigenDecomposition_F64) - Static method in class org.ejml.dense.row.EigenOps_DDRM
-
A diagonal matrix where real diagonal element contains a real eigenvalue.
- createMatrixV(EigenDecomposition_F64<DMatrixRMaj>) - Static method in class org.ejml.dense.row.EigenOps_DDRM
-
Puts all the real eigenvectors into the columns of a matrix.
- createR - Variable in class org.ejml.dense.row.decomposition.eig.watched.WatchedDoubleStepQREigen_DDRM
-
- createRandom(int, int, double, double, Random) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
- createRandom(int, int, double, double, Random, int) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
- createReflector(DMatrix1Row) - Static method in class org.ejml.dense.row.SpecializedOps_DDRM
-
Creates a reflector from the provided vector.
Q = I - γ u uT
γ = 2/||u||2
- createReflector(DMatrixRMaj, double) - Static method in class org.ejml.dense.row.SpecializedOps_DDRM
-
Creates a reflector from the provided vector and gamma.
Q = I - γ u uT
- dataLU - Variable in class org.ejml.dense.row.decomposition.lu.LUDecompositionBase_DDRM
-
- dataQR - Variable in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholder_DDRM
-
- dataQR - Variable in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholderColumn_DDRM
-
Where the Q and R matrices are stored.
- declareInternalData(int, int) - Method in class org.ejml.dense.row.decomposition.qr.QrUpdate_DDRM
-
Declares the internal data structures so that it can process matrices up to the specified size.
- decomp - Variable in class org.ejml.dense.row.linsol.lu.LinearSolverLuBase_DDRM
-
- decompose(DMatrixRBlock) - Method in class org.ejml.dense.block.decomposition.chol.CholeskyOuterForm_DDRB
-
Decomposes the provided matrix and stores the result in the same matrix.
- decompose(DMatrixRBlock) - Method in class org.ejml.dense.block.decomposition.hessenberg.TridiagonalDecompositionHouseholder_DDRB
-
- decompose(DMatrixRBlock) - Method in class org.ejml.dense.block.decomposition.qr.QRDecompositionHouseholder_DDRB
-
- decompose(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.BaseDecomposition_DDRB_to_DDRM
-
- decompose(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.bidiagonal.BidiagonalDecompositionRow_DDRM
-
Computes the decomposition of the provided matrix.
- decompose(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.bidiagonal.BidiagonalDecompositionTall_DDRM
-
- decompose(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionCommon_DDRM
-
Performs Choleksy decomposition on the provided matrix.
- decompose(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionLDL_DDRM
-
Performs Choleksy decomposition on the provided matrix.
- decompose(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.eig.SwitchingEigenDecomposition_DDRM
-
- decompose(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.eig.SymmetricQRAlgorithmDecomposition_DDRM
-
Decomposes the matrix using the QR algorithm.
- decompose(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.eig.WatchedDoubleStepQRDecomposition_DDRM
-
- decompose(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.hessenberg.HessenbergSimilarDecomposition_DDRM
-
Computes the decomposition of the provided matrix.
- decompose(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.hessenberg.TridiagonalDecompositionHouseholder_DDRM
-
Decomposes the provided symmetric matrix.
- decompose(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.hessenberg.TridiagonalDecompositionHouseholderOrig_DDRM
-
Decomposes the provided symmetric matrix.
- decompose(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.lu.LUDecompositionAlt_DDRM
-
This is a modified version of what was found in the JAMA package.
- decompose(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.qr.QRColPivDecompositionHouseholderColumn_DDRM
-
To decompose the matrix 'A' it must have full rank.
- decompose(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholder_DDRM
-
In order to decompose the matrix 'A' it must have full rank.
- decompose(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholderColumn_DDRM
-
To decompose the matrix 'A' it must have full rank.
- decompose(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholderTran_DDRM
-
To decompose the matrix 'A' it must have full rank.
- decompose(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.svd.SafeSvd_DDRM
-
- decompose(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.svd.SvdImplicitQrDecompose_DDRM
-
- decomposeCommonInit(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.lu.LUDecompositionBase_DDRM
-
- decomposeLower() - Method in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionBlock_DDRM
-
Performs Choleksy decomposition on the provided matrix.
- decomposeLower() - Method in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionCommon_DDRM
-
Performs an lower triangular decomposition.
- decomposeLower() - Method in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionInner_DDRM
-
- decomposeQR_block_col(int, DSubmatrixD1, double[]) - Static method in class org.ejml.dense.block.decomposition.qr.BlockHouseHolder_DDRB
-
Performs a standard QR decomposition on the specified submatrix that is one block wide.
- decomposer - Variable in class org.ejml.dense.block.linsol.qr.QrHouseHolderSolver_DDRB
-
- decomposeSafe(DecompositionInterface<T>, T) - Static method in class org.ejml.dense.row.factory.DecompositionFactory_DDRM
-
A simple convinience function that decomposes the matrix but automatically checks the input ti make
sure is not being modified.
- decomposeUpper() - Method in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionBlock_DDRM
-
- decomposeUpper() - Method in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionCommon_DDRM
-
Performs an upper triangular decomposition.
- decomposeUpper() - Method in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionInner_DDRM
-
- DecompositionFactory_DDRM - Class in org.ejml.dense.row.factory
-
Contains operations related to creating and evaluating the quality of common matrix decompositions.
- DecompositionFactory_DDRM() - Constructor for class org.ejml.dense.row.factory.DecompositionFactory_DDRM
-
- deleteRow(DMatrixRMaj, DMatrixRMaj, int, boolean) - Method in class org.ejml.dense.row.decomposition.qr.QrUpdate_DDRM
-
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.
- descendingOrder(DMatrixRMaj, boolean, DMatrixRMaj, DMatrixRMaj, boolean) - Static method in class org.ejml.dense.row.SingularOps_DDRM
-
Adjusts the matrices so that the singular values are in descending order.
- descendingOrder(DMatrixRMaj, boolean, double[], int, DMatrixRMaj, boolean) - Static method in class org.ejml.dense.row.SingularOps_DDRM
-
- det(DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Computes the determinant using minor matrices.
WARNING: Potentially less stable than using LU decomposition.
- det(DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Computes the determinant using minor matrices.
WARNING: Potentially less stable than using LU decomposition.
- det(DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Computes the determinant using minor matrices.
WARNING: Potentially less stable than using LU decomposition.
- det(DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Computes the determinant using minor matrices.
WARNING: Potentially less stable than using LU decomposition.
- det(DMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Returns the determinant of the matrix.
- det - Variable in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionCommon_DDRM
-
- det(DMatrix1Row) - Static method in class org.ejml.dense.row.misc.UnrolledDeterminantFromMinor_DDRM
-
- det2(DMatrix1Row) - Static method in class org.ejml.dense.row.misc.UnrolledDeterminantFromMinor_DDRM
-
- det3(DMatrix1Row) - Static method in class org.ejml.dense.row.misc.UnrolledDeterminantFromMinor_DDRM
-
- det4(DMatrix1Row) - Static method in class org.ejml.dense.row.misc.UnrolledDeterminantFromMinor_DDRM
-
- det5(DMatrix1Row) - Static method in class org.ejml.dense.row.misc.UnrolledDeterminantFromMinor_DDRM
-
- det6(DMatrix1Row) - Static method in class org.ejml.dense.row.misc.UnrolledDeterminantFromMinor_DDRM
-
- DeterminantFromMinor_DDRM - Class in org.ejml.dense.row.misc
-
Computes the determinant of a matrix using Laplace expansion.
- DeterminantFromMinor_DDRM(int) - Constructor for class org.ejml.dense.row.misc.DeterminantFromMinor_DDRM
-
- DeterminantFromMinor_DDRM(int, int) - Constructor for class org.ejml.dense.row.misc.DeterminantFromMinor_DDRM
-
- diag(DMatrix2x2, DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Extracts all diagonal elements from 'input' and places them inside the 'out' vector.
- diag(DMatrix3x3, DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Extracts all diagonal elements from 'input' and places them inside the 'out' vector.
- diag(DMatrix4x4, DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Extracts all diagonal elements from 'input' and places them inside the 'out' vector.
- diag(DMatrix5x5, DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Extracts all diagonal elements from 'input' and places them inside the 'out' vector.
- diag(DMatrix6x6, DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Extracts all diagonal elements from 'input' and places them inside the 'out' vector.
- diag(double...) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
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 = j
- diag(DMatrixRMaj, int, double...) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
- diag - Variable in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
- diag - Variable in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
- diagonal(int, double, double, Random) - Static method in class org.ejml.dense.row.RandomMatrices_DDRM
-
Creates a random diagonal matrix where the diagonal elements are selected from a uniform
distribution that goes from min to max.
- diagonal(int, int, double, double, Random) - Static method in class org.ejml.dense.row.RandomMatrices_DDRM
-
Creates a random matrix where all elements are zero but diagonal elements.
- diagProd(DMatrix1Row) - Static method in class org.ejml.dense.row.SpecializedOps_DDRM
-
Computes the product of the diagonal elements.
- diagR(int, int, double...) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
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 = j
- diffNormF(DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.SpecializedOps_DDRM
-
Computes the F norm of the difference between the two Matrices:
Sqrt{∑i=1:m ∑j=1:n ( aij - bij)2}
- diffNormF_fast(DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.SpecializedOps_DDRM
-
- diffNormP1(DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.SpecializedOps_DDRM
-
Computes the p=1 p-norm of the difference between the two Matrices:
∑i=1:m ∑j=1:n | aij - bij|
where |x| is the absolute value of x.
- div_row(int, DSubmatrixD1, int, double, DSubmatrixD1, int, int, int) - Static method in class org.ejml.dense.block.VectorOps_DDRB
-
Row vector divide:
div: bi = ai/α
where 'a' and 'b' are row vectors within the row block vector A and B.
- divide(DMatrix2x2, double) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs an in-place element by element scalar division.
- divide(DMatrix2, double) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs an in-place element by element scalar division.
- divide(DMatrix2x2, double, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs an element by element scalar division.
- divide(DMatrix2, double, DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs an element by element scalar division.
- divide(DMatrix3x3, double) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs an in-place element by element scalar division.
- divide(DMatrix3, double) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs an in-place element by element scalar division.
- divide(DMatrix3x3, double, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs an element by element scalar division.
- divide(DMatrix3, double, DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs an element by element scalar division.
- divide(DMatrix4x4, double) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs an in-place element by element scalar division.
- divide(DMatrix4, double) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs an in-place element by element scalar division.
- divide(DMatrix4x4, double, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs an element by element scalar division.
- divide(DMatrix4, double, DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs an element by element scalar division.
- divide(DMatrix5x5, double) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs an in-place element by element scalar division.
- divide(DMatrix5, double) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs an in-place element by element scalar division.
- divide(DMatrix5x5, double, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs an element by element scalar division.
- divide(DMatrix5, double, DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs an element by element scalar division.
- divide(DMatrix6x6, double) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs an in-place element by element scalar division.
- divide(DMatrix6, double) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs an in-place element by element scalar division.
- divide(DMatrix6x6, double, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs an element by element scalar division.
- divide(DMatrix6, double, DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs an element by element scalar division.
- divide(double, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs an in-place element by element scalar division with the scalar on top.
aij = α/aij
- divide(DMatrixD1, double) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs an in-place element by element scalar division with the scalar on bottom.
aij = aij/α
- divide(double, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs an element by element scalar division with the scalar on top.
bij = α/aij
- divide(DMatrixD1, double, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs an element by element scalar division with the scalar on botton.
bij = aij /α
- divideElements(int, int, double[], double) - Static method in class org.ejml.dense.row.decomposition.qr.QrHelperFunctions_DDRM
-
- divideElements(int, int, double[], int, double) - Static method in class org.ejml.dense.row.decomposition.qr.QrHelperFunctions_DDRM
-
- divideElements_Bcol(int, int, int, double[], double[], int, double) - Static method in class org.ejml.dense.row.decomposition.qr.QrHelperFunctions_DDRM
-
- divideElements_Brow(int, int, double[], double[], int, double) - Static method in class org.ejml.dense.row.decomposition.qr.QrHelperFunctions_DDRM
-
- divideElementsCol(int, DSubmatrixD1, int, double) - Static method in class org.ejml.dense.block.decomposition.qr.BlockHouseHolder_DDRB
-
Divides the elements at the specified column by 'val'.
- DMatrixComponent - Class in org.ejml.dense.row
-
Renders a matrix as an image.
- DMatrixComponent(int, int) - Constructor for class org.ejml.dense.row.DMatrixComponent
-
- DMatrixVisualization - Class in org.ejml.dense.row
-
Functions for visualizing matrices in a GUI matrices.
- DMatrixVisualization() - Constructor for class org.ejml.dense.row.DMatrixVisualization
-
- dominantEigenpair(DMatrixRMaj) - Static method in class org.ejml.dense.row.EigenOps_DDRM
-
Computes the dominant eigen vector for a matrix.
- dot(DMatrix2, DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the vector dot product:
c = a * b
c ≥ ∑k=1:n { bk * ak }
- dot(DMatrix3, DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the vector dot product:
c = a * b
c ≥ ∑k=1:n { bk * ak }
- dot(DMatrix4, DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the vector dot product:
c = a * b
c ≥ ∑k=1:n { bk * ak }
- dot(DMatrix5, DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the vector dot product:
c = a * b
c ≥ ∑k=1:n { bk * ak }
- dot(DMatrix6, DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the vector dot product:
c = a * b
c ≥ ∑k=1:n { bk * ak }
- dot(DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Computes the dot product or inner product between two vectors.
- dot_row(int, DSubmatrixD1, int, DSubmatrixD1, int, int, int) - Static method in class org.ejml.dense.block.VectorOps_DDRB
-
Row vector dot/inner product:
dot: c = sum ai*bi
where 'a' and 'b' are row vectors within the row block vector A and B, and 'c' is a scalar.
- dot_row_col(int, DSubmatrixD1, int, DSubmatrixD1, int, int, int) - Static method in class org.ejml.dense.block.VectorOps_DDRB
-
vector dot/inner product from one row vector and one column vector:
dot: c = sum ai*bi
where 'a' is a row vector 'b' is a column vectors within the row block vector A and B, and 'c' is a scalar.
- eig(int, boolean) - Static method in class org.ejml.dense.row.factory.DecompositionFactory_DDRM
-
Returns an EigenDecomposition
that has been optimized for the specified matrix size.
- eig(int, boolean, boolean) - Static method in class org.ejml.dense.row.factory.DecompositionFactory_DDRM
-
Returns an EigenDecomposition
which is specialized for symmetric matrices or the general problem.
- eigen2by2_scale(double, double, double, double) - Method in class org.ejml.dense.row.decomposition.eig.watched.WatchedDoubleStepQREigen_DDRM
-
- eigenBB_2x2(int) - Method in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
Computes the eigenvalue of the 2 by 2 matrix BTB
- EigenOps_DDRM - Class in org.ejml.dense.row
-
Additional functions related to eigenvalues and eigenvectors of a matrix.
- EigenOps_DDRM() - Constructor for class org.ejml.dense.row.EigenOps_DDRM
-
- EigenPowerMethod_DDRM - Class in org.ejml.dense.row.decomposition.eig
-
The power method is an iterative method that can be used to find dominant eigen vector in
a matrix.
- EigenPowerMethod_DDRM(int) - Constructor for class org.ejml.dense.row.decomposition.eig.EigenPowerMethod_DDRM
-
- eigenSmall - Variable in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
- eigenSmall - Variable in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
- eigenvalue2by2(int) - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
Computes the eigenvalue of the 2 by 2 matrix.
- EigenvalueExtractor_DDRM - Interface in org.ejml.dense.row.decomposition.eig
-
- EigenvalueSmall_F64 - Class in org.ejml.dense.row.decomposition.eig
-
- EigenvalueSmall_F64() - Constructor for class org.ejml.dense.row.decomposition.eig.EigenvalueSmall_F64
-
- elementDiagonalMaxAbs(DMatrixD1) - Static method in class org.ejml.dense.row.SpecializedOps_DDRM
-
Returns the absolute value of the digonal element in the matrix that has the largest absolute value.
Max{ |aij| } for all i and j
- elementDiv(DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs an element by element division operation:
aij = aij / bij
- elementDiv(DMatrix2, DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs an element by element division operation:
ai = ai / bi
- elementDiv(DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs an element by element division operation:
cij = aij / bij
- elementDiv(DMatrix2, DMatrix2, DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs an element by element division operation:
ci = ai / bi
- elementDiv(DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs an element by element division operation:
aij = aij / bij
- elementDiv(DMatrix3, DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs an element by element division operation:
ai = ai / bi
- elementDiv(DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs an element by element division operation:
cij = aij / bij
- elementDiv(DMatrix3, DMatrix3, DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs an element by element division operation:
ci = ai / bi
- elementDiv(DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs an element by element division operation:
aij = aij / bij
- elementDiv(DMatrix4, DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs an element by element division operation:
ai = ai / bi
- elementDiv(DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs an element by element division operation:
cij = aij / bij
- elementDiv(DMatrix4, DMatrix4, DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs an element by element division operation:
ci = ai / bi
- elementDiv(DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs an element by element division operation:
aij = aij / bij
- elementDiv(DMatrix5, DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs an element by element division operation:
ai = ai / bi
- elementDiv(DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs an element by element division operation:
cij = aij / bij
- elementDiv(DMatrix5, DMatrix5, DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs an element by element division operation:
ci = ai / bi
- elementDiv(DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs an element by element division operation:
aij = aij / bij
- elementDiv(DMatrix6, DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs an element by element division operation:
ai = ai / bi
- elementDiv(DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs an element by element division operation:
cij = aij / bij
- elementDiv(DMatrix6, DMatrix6, DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs an element by element division operation:
ci = ai / bi
- elementDiv(DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the an element by element division operation:
aij = aij / bij
- elementDiv(DMatrixD1, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the an element by element division operation:
cij = aij / bij
- elementExp(DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Element-wise exp operation
cij = Math.log(aij)
- elementLessThan(DMatrixRMaj, double, BMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Applies the > operator to each element in A.
- elementLessThan(DMatrixRMaj, DMatrixRMaj, BMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Applies the < operator to each element in A.
- elementLessThanOrEqual(DMatrixRMaj, double, BMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Applies the ≥ operator to each element in A.
- elementLessThanOrEqual(DMatrixRMaj, DMatrixRMaj, BMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Applies the A ≤ B operator to each element.
- elementLog(DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Element-wise log operation
cij = Math.log(aij)
- elementMax(DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Returns the value of the element in the matrix that has the largest value.
Max{ aij } for all i and j
- elementMax(DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Returns the value of the element in the vector that has the largest value.
Max{ ai } for all i
- elementMax(DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Returns the value of the element in the matrix that has the largest value.
Max{ aij } for all i and j
- elementMax(DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Returns the value of the element in the vector that has the largest value.
Max{ ai } for all i
- elementMax(DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Returns the value of the element in the matrix that has the largest value.
Max{ aij } for all i and j
- elementMax(DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Returns the value of the element in the vector that has the largest value.
Max{ ai } for all i
- elementMax(DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Returns the value of the element in the matrix that has the largest value.
Max{ aij } for all i and j
- elementMax(DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Returns the value of the element in the vector that has the largest value.
Max{ ai } for all i
- elementMax(DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Returns the value of the element in the matrix that has the largest value.
Max{ aij } for all i and j
- elementMax(DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Returns the value of the element in the vector that has the largest value.
Max{ ai } for all i
- elementMax(DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Returns the value of the element in the matrix that has the largest value.
Max{ aij } for all i and j
- elementMaxAbs(DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Returns the absolute value of the element in the matrix that has the largest absolute value.
Max{ |aij| } for all i and j
- elementMaxAbs(DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Returns the absolute value of the element in the vector that has the largest absolute value.
Max{ |ai| } for all i
- elementMaxAbs(DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Returns the absolute value of the element in the matrix that has the largest absolute value.
Max{ |aij| } for all i and j
- elementMaxAbs(DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Returns the absolute value of the element in the vector that has the largest absolute value.
Max{ |ai| } for all i
- elementMaxAbs(DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Returns the absolute value of the element in the matrix that has the largest absolute value.
Max{ |aij| } for all i and j
- elementMaxAbs(DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Returns the absolute value of the element in the vector that has the largest absolute value.
Max{ |ai| } for all i
- elementMaxAbs(DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Returns the absolute value of the element in the matrix that has the largest absolute value.
Max{ |aij| } for all i and j
- elementMaxAbs(DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Returns the absolute value of the element in the vector that has the largest absolute value.
Max{ |ai| } for all i
- elementMaxAbs(DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Returns the absolute value of the element in the matrix that has the largest absolute value.
Max{ |aij| } for all i and j
- elementMaxAbs(DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Returns the absolute value of the element in the vector that has the largest absolute value.
Max{ |ai| } for all i
- elementMaxAbs(DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Returns the absolute value of the element in the matrix that has the largest absolute value.
Max{ |aij| } for all i and j
- elementMin(DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Returns the value of the element in the matrix that has the minimum value.
Min{ aij } for all i and j
- elementMin(DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Returns the value of the element in the vector that has the minimum value.
Min{ ai } for all
- elementMin(DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Returns the value of the element in the matrix that has the minimum value.
Min{ aij } for all i and j
- elementMin(DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Returns the value of the element in the vector that has the minimum value.
Min{ ai } for all
- elementMin(DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Returns the value of the element in the matrix that has the minimum value.
Min{ aij } for all i and j
- elementMin(DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Returns the value of the element in the vector that has the minimum value.
Min{ ai } for all
- elementMin(DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Returns the value of the element in the matrix that has the minimum value.
Min{ aij } for all i and j
- elementMin(DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Returns the value of the element in the vector that has the minimum value.
Min{ ai } for all
- elementMin(DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Returns the value of the element in the matrix that has the minimum value.
Min{ aij } for all i and j
- elementMin(DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Returns the value of the element in the vector that has the minimum value.
Min{ ai } for all
- elementMin(DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Returns the value of the element in the matrix that has the minimum value.
Min{ aij } for all i and j
- elementMinAbs(DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Returns the absolute value of the element in the matrix that has the smallest absolute value.
Min{ |aij| } for all i and j
- elementMinAbs(DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Returns the absolute value of the element in the vector that has the smallest absolute value.
Min{ |ai| } for all i
- elementMinAbs(DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Returns the absolute value of the element in the matrix that has the smallest absolute value.
Min{ |aij| } for all i and j
- elementMinAbs(DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Returns the absolute value of the element in the vector that has the smallest absolute value.
Min{ |ai| } for all i
- elementMinAbs(DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Returns the absolute value of the element in the matrix that has the smallest absolute value.
Min{ |aij| } for all i and j
- elementMinAbs(DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Returns the absolute value of the element in the vector that has the smallest absolute value.
Min{ |ai| } for all i
- elementMinAbs(DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Returns the absolute value of the element in the matrix that has the smallest absolute value.
Min{ |aij| } for all i and j
- elementMinAbs(DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Returns the absolute value of the element in the vector that has the smallest absolute value.
Min{ |ai| } for all i
- elementMinAbs(DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Returns the absolute value of the element in the matrix that has the smallest absolute value.
Min{ |aij| } for all i and j
- elementMinAbs(DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Returns the absolute value of the element in the vector that has the smallest absolute value.
Min{ |ai| } for all i
- elementMinAbs(DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Returns the absolute value of the element in the matrix that has the smallest absolute value.
Min{ |aij| } for all i and j
- elementMoreThan(DMatrixRMaj, double, BMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Applies the > operator to each element in A.
- elementMoreThanOrEqual(DMatrixRMaj, double, BMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Applies the ≥ operator to each element in A.
- elementMult(DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs an element by element multiplication operation:
aij = aij * bij
- elementMult(DMatrix2, DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs an element by element multiplication operation:
ai = ai * bi
- elementMult(DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs an element by element multiplication operation:
cij = aij * bij
- elementMult(DMatrix2, DMatrix2, DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs an element by element multiplication operation:
ci = ai * bj
- elementMult(DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs an element by element multiplication operation:
aij = aij * bij
- elementMult(DMatrix3, DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs an element by element multiplication operation:
ai = ai * bi
- elementMult(DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs an element by element multiplication operation:
cij = aij * bij
- elementMult(DMatrix3, DMatrix3, DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs an element by element multiplication operation:
ci = ai * bj
- elementMult(DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs an element by element multiplication operation:
aij = aij * bij
- elementMult(DMatrix4, DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs an element by element multiplication operation:
ai = ai * bi
- elementMult(DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs an element by element multiplication operation:
cij = aij * bij
- elementMult(DMatrix4, DMatrix4, DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs an element by element multiplication operation:
ci = ai * bj
- elementMult(DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs an element by element multiplication operation:
aij = aij * bij
- elementMult(DMatrix5, DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs an element by element multiplication operation:
ai = ai * bi
- elementMult(DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs an element by element multiplication operation:
cij = aij * bij
- elementMult(DMatrix5, DMatrix5, DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs an element by element multiplication operation:
ci = ai * bj
- elementMult(DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs an element by element multiplication operation:
aij = aij * bij
- elementMult(DMatrix6, DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs an element by element multiplication operation:
ai = ai * bi
- elementMult(DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs an element by element multiplication operation:
cij = aij * bij
- elementMult(DMatrix6, DMatrix6, DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs an element by element multiplication operation:
ci = ai * bj
- elementMult(DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the an element by element multiplication operation:
aij = aij * bij
- elementMult(DMatrixD1, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the an element by element multiplication operation:
cij = aij * bij
- elementP(DMatrix1Row, double) - Static method in class org.ejml.dense.row.NormOps_DDRM
-
Element wise p-norm:
norm = {∑i=1:m ∑j=1:n { |aij|p}}1/p
- elementPower(DMatrixD1, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Element-wise power operation
cij = aij ^ bij
- elementPower(double, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Element-wise power operation
cij = a ^ bij
- elementPower(DMatrixD1, double, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Element-wise power operation
cij = aij ^ b
- elements(DMatrixRMaj, BMatrixRMaj, DMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Returns a row matrix which contains all the elements in A which are flagged as true in 'marked'
- elementSum(DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Computes the sum of all the elements in the matrix:
sum(i=1:m , j=1:n ; aij)
- elementSumAbs(DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Computes the sum of the absolute value all the elements in the matrix:
sum(i=1:m , j=1:n ; |aij|)
- elementSumSq(DMatrixD1) - Static method in class org.ejml.dense.row.SpecializedOps_DDRM
-
Sums up the square of each element in the matrix.
- error - Variable in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholder_DDRM
-
- error - Variable in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholderColumn_DDRM
-
- error - Variable in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholderTran_DDRM
-
- exceptionalShift() - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
Perform a shift in a random direction that is of the same magnitude as the elements in the matrix.
- exceptionalShift(int, int) - Method in class org.ejml.dense.row.decomposition.eig.watched.WatchedDoubleStepQREigen_DDRM
-
Perform a shift in a random direction that is of the same magnitude as the elements in the matrix.
- exceptionShift() - Method in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
It is possible for the QR algorithm to get stuck in a loop because of symmetries.
- extract(DMatrix, int, int, int, int, DMatrix, int, int) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Extracts a submatrix from 'src' and inserts it in a submatrix in 'dst'.
- extract(DMatrixRMaj, int, int, int, int) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Creates a new matrix which is the specified submatrix of 'src'
- extract(DMatrixRMaj, int[], int, int[], int, DMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Extracts out a matrix from source given a sub matrix with arbitrary rows and columns specified in
two array lists
- extract(DMatrixRMaj, int[], int, DMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Extracts the elements from the source matrix by their 1D index.
- extract(DMatrix, int, int, DMatrix, int, int, int, int) - Static method in class org.ejml.dense.row.misc.ImplCommonOps_DDMA
-
- extract(DMatrixRMaj, int, int, DMatrixRMaj, int, int, int, int) - Static method in class org.ejml.dense.row.misc.ImplCommonOps_DDRM
-
- extractAligned(DMatrixRBlock, DMatrixRBlock) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
Extracts a matrix from src into dst.
- extractColumn(DMatrix2x2, int, DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Extracts the column from the matrix a.
- extractColumn(DMatrix3x3, int, DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Extracts the column from the matrix a.
- extractColumn(DMatrix4x4, int, DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Extracts the column from the matrix a.
- extractColumn(DMatrix5x5, int, DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Extracts the column from the matrix a.
- extractColumn(DMatrix6x6, int, DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Extracts the column from the matrix a.
- extractColumn(DMatrixRMaj, int, DMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Extracts the column from a matrix.
- extractDiag(DMatrixRMaj, DMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Extracts the diagonal elements 'src' write it to the 'dst' vector.
- extractRow(DMatrix2x2, int, DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Extracts the row from the matrix a.
- extractRow(DMatrix3x3, int, DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Extracts the row from the matrix a.
- extractRow(DMatrix4x4, int, DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Extracts the row from the matrix a.
- extractRow(DMatrix5x5, int, DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Extracts the row from the matrix a.
- extractRow(DMatrix6x6, int, DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Extracts the row from the matrix a.
- extractRow(DMatrixRMaj, int, DMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Extracts the row from a matrix.
- extractVectors(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.eig.watched.WatchedDoubleStepQREigenvector_DDRM
-
- I - Variable in class org.ejml.dense.row.linsol.qr.BaseLinearSolverQrp_DDRM
-
- identity(int, int, int) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
Returns a new matrix with ones along the diagonal and zeros everywhere else.
- identity(int) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Creates an identity matrix of the specified size.
aij = 0 if i ≠ j
aij = 1 if i = j
- identity(int, int) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Creates a rectangular matrix which is zero except along the diagonals.
- ImplCommonOps_DDMA - Class in org.ejml.dense.row.misc
-
Implementations of common ops routines for DMatrixRMaj
.
- ImplCommonOps_DDMA() - Constructor for class org.ejml.dense.row.misc.ImplCommonOps_DDMA
-
- ImplCommonOps_DDRM - Class in org.ejml.dense.row.misc
-
Implementations of common ops routines for DMatrixRMaj
.
- ImplCommonOps_DDRM() - Constructor for class org.ejml.dense.row.misc.ImplCommonOps_DDRM
-
- implicitDoubleStep(int, int) - Method in class org.ejml.dense.row.decomposition.eig.watched.WatchedDoubleStepQREigen_DDRM
-
Performs an implicit double step using the values contained in the lower right hand side
of the submatrix for the estimated eigenvector values.
- improveSol(DMatrixRMaj, DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.lu.LinearSolverLuBase_DDRM
-
This attempts to improve upon the solution generated by account
for numerical imprecisions.
- incrementSteps() - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
- incrementSteps() - Method in class org.ejml.dense.row.decomposition.eig.watched.WatchedDoubleStepQREigen_DDRM
-
- incrementSteps() - Method in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
- inducedP1(DMatrixRMaj) - Static method in class org.ejml.dense.row.NormOps_DDRM
-
Computes the induced p = 1 matrix norm.
||A||1= max(j=1 to n; sum(i=1 to m; |aij|))
- inducedP2(DMatrixRMaj) - Static method in class org.ejml.dense.row.NormOps_DDRM
-
Computes the induced p = 2 matrix norm, which is the largest singular value.
- inducedPInf(DMatrixRMaj) - Static method in class org.ejml.dense.row.NormOps_DDRM
-
Induced matrix p = infinity norm.
||A||∞ = max(i=1 to m; sum(j=1 to n; |aij|))
- indx - Variable in class org.ejml.dense.row.decomposition.lu.LUDecompositionBase_DDRM
-
- init(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.bidiagonal.BidiagonalDecompositionRow_DDRM
-
Sets up internal data structures and creates a copy of the input matrix.
- init(double[], double[], int) - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
Sets up and declares internal data structures.
- init(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.hessenberg.TridiagonalDecompositionHouseholder_DDRM
-
If needed declares and sets up internal data structures.
- init(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.hessenberg.TridiagonalDecompositionHouseholderOrig_DDRM
-
If needed declares and sets up internal data structures.
- initializeQ(DMatrixRBlock, int, int, int, boolean) - Static method in class org.ejml.dense.block.decomposition.qr.QRDecompositionHouseholder_DDRB
-
Sanity checks the input or declares a new matrix.
- initializeW(int, DSubmatrixD1, DSubmatrixD1, int, double) - Static method in class org.ejml.dense.block.decomposition.qr.BlockHouseHolder_DDRB
-
Sets W to its initial value using the first column of 'y' and the value of 'b':
W = -βv
where v = Y(:,0).
- initParam(int, int) - Method in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
- inner_reorder(DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMultProduct_DDRM
-
- inner_reorder_upper(DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMultProduct_DDRM
-
- inner_small(DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMultProduct_DDRM
-
- InnerCholesky_DDRB - Class in org.ejml.dense.block.decomposition.chol
-
Performs a cholesky decomposition on an individual inner block.
- InnerCholesky_DDRB() - Constructor for class org.ejml.dense.block.decomposition.chol.InnerCholesky_DDRB
-
- InnerMultiplication_DDRB - Class in org.ejml.dense.block
-
Matrix multiplication for the inner row major blocks, typically inside of a DMatrixRBlock
.
- InnerMultiplication_DDRB() - Constructor for class org.ejml.dense.block.InnerMultiplication_DDRB
-
- innerProd(DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.mult.VectorVectorMult_DDRM
-
Computes the inner product of the two vectors.
- innerProdA(DMatrixD1, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.mult.VectorVectorMult_DDRM
-
return = xT*A*y
- innerProdCol(int, DSubmatrixD1, int, int, int, int) - Static method in class org.ejml.dense.block.decomposition.qr.BlockHouseHolder_DDRB
-
Computes the inner product of column vector 'colA' against column vector 'colB' while taking account leading zeros and one.
ret = aT*b
- innerProdRow(int, DSubmatrixD1, int, DSubmatrixD1, int, int) - Static method in class org.ejml.dense.block.decomposition.qr.BlockHouseHolder_DDRB
-
Computes the inner product of row vector 'rowA' against row vector 'rowB' while taking account leading zeros and one.
ret = aT*b
- innerProdRowSymm(int, DSubmatrixD1, int, DSubmatrixD1, int, int) - Static method in class org.ejml.dense.block.decomposition.hessenberg.TridiagonalHelper_DDRB
-
- innerProdTranA(DMatrixD1, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.mult.VectorVectorMult_DDRM
-
xTATy
- InnerRankUpdate_DDRB - Class in org.ejml.dense.block
-
Performs rank-n update operations on the inner blocks of a DMatrixRBlock
It is assumed and not checked that the submatrices are aligned along the matrix's blocks.
- InnerRankUpdate_DDRB() - Constructor for class org.ejml.dense.block.InnerRankUpdate_DDRB
-
- InnerTriangularSolver_DDRB - Class in org.ejml.dense.block
-
Contains triangular solvers for inner blocks of a DMatrixRBlock
.
- InnerTriangularSolver_DDRB() - Constructor for class org.ejml.dense.block.InnerTriangularSolver_DDRB
-
- inputModified() - Method in class org.ejml.dense.block.decomposition.chol.CholeskyOuterForm_DDRB
-
- inputModified() - Method in class org.ejml.dense.block.decomposition.hessenberg.TridiagonalDecompositionHouseholder_DDRB
-
- inputModified() - Method in class org.ejml.dense.block.decomposition.qr.QRDecompositionHouseholder_DDRB
-
The input matrix is always modified.
- inputModified() - Method in class org.ejml.dense.row.decomposition.BaseDecomposition_DDRB_to_DDRM
-
- inputModified() - Method in class org.ejml.dense.row.decomposition.bidiagonal.BidiagonalDecompositionRow_DDRM
-
- inputModified() - Method in class org.ejml.dense.row.decomposition.bidiagonal.BidiagonalDecompositionTall_DDRM
-
- inputModified() - Method in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionCommon_DDRM
-
- inputModified() - Method in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionLDL_DDRM
-
- inputModified() - Method in class org.ejml.dense.row.decomposition.eig.SwitchingEigenDecomposition_DDRM
-
- inputModified() - Method in class org.ejml.dense.row.decomposition.eig.SymmetricQRAlgorithmDecomposition_DDRM
-
- inputModified() - Method in class org.ejml.dense.row.decomposition.eig.WatchedDoubleStepQRDecomposition_DDRM
-
- inputModified() - Method in class org.ejml.dense.row.decomposition.hessenberg.HessenbergSimilarDecomposition_DDRM
-
- inputModified() - Method in class org.ejml.dense.row.decomposition.hessenberg.TridiagonalDecompositionHouseholder_DDRM
-
- inputModified() - Method in class org.ejml.dense.row.decomposition.lu.LUDecompositionBase_DDRM
-
- inputModified() - Method in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholder_DDRM
-
- inputModified() - Method in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholderColumn_DDRM
-
- inputModified() - Method in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholderTran_DDRM
-
- inputModified() - Method in class org.ejml.dense.row.decomposition.svd.SafeSvd_DDRM
-
- inputModified() - Method in class org.ejml.dense.row.decomposition.svd.SvdImplicitQrDecompose_DDRM
-
- inputModified() - Method in class org.ejml.dense.row.linsol.qr.SolveNullSpaceQR_DDRM
-
- inputModified() - Method in class org.ejml.dense.row.linsol.qr.SolveNullSpaceQRP_DDRM
-
- inputModified() - Method in class org.ejml.dense.row.linsol.svd.SolveNullSpaceSvd_DDRM
-
- insert(DMatrixRMaj, DMatrixRMaj, int[], int, int[], int) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Inserts into the specified elements of dst the source matrix.
- insert(DMatrix, DMatrix, int, int) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Inserts matrix 'src' into matrix 'dest' with the (0,0) of src at (row,col) in dest.
- insideSpan(DMatrixRMaj[], double, double, Random) - Static method in class org.ejml.dense.row.RandomMatrices_DDRM
-
Creates a random vector that is inside the specified span.
- internalSolver - Variable in class org.ejml.dense.row.linsol.qr.BaseLinearSolverQrp_DDRM
-
- inv(DMatrixRMaj, DMatrixRMaj) - Static method in class org.ejml.dense.row.misc.UnrolledInverseFromMinor_DDRM
-
- inv2(DMatrixRMaj, DMatrixRMaj, double) - Static method in class org.ejml.dense.row.misc.UnrolledInverseFromMinor_DDRM
-
- inv3(DMatrixRMaj, DMatrixRMaj, double) - Static method in class org.ejml.dense.row.misc.UnrolledInverseFromMinor_DDRM
-
- inv4(DMatrixRMaj, DMatrixRMaj, double) - Static method in class org.ejml.dense.row.misc.UnrolledInverseFromMinor_DDRM
-
- inv5(DMatrixRMaj, DMatrixRMaj, double) - Static method in class org.ejml.dense.row.misc.UnrolledInverseFromMinor_DDRM
-
- invert(DMatrixRBlock) - Method in class org.ejml.dense.block.linsol.chol.CholeskyOuterSolver_DDRB
-
- invert(DMatrixRBlock) - Method in class org.ejml.dense.block.linsol.qr.QrHouseHolderSolver_DDRB
-
Invert by solving for against an identity matrix.
- invert(int, boolean, DSubmatrixD1, DSubmatrixD1, double[]) - Static method in class org.ejml.dense.block.TriangularSolver_DDRB
-
Inverts an upper or lower triangular block submatrix.
- invert(int, boolean, DSubmatrixD1, double[]) - Static method in class org.ejml.dense.block.TriangularSolver_DDRB
-
Inverts an upper or lower triangular block submatrix.
- invert(DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Inverts matrix 'a' using minor matrices and stores the results in 'inv'.
- invert(DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Inverts matrix 'a' using minor matrices and stores the results in 'inv'.
- invert(DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Inverts matrix 'a' using minor matrices and stores the results in 'inv'.
- invert(DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Inverts matrix 'a' using minor matrices and stores the results in 'inv'.
- invert(DMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs a matrix inversion operation on the specified matrix and stores the results
in the same matrix.
a = a-1
- invert(DMatrixRMaj, DMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs a matrix inversion operation that does not modify the original
and stores the results in another matrix.
- invert(DMatrixRMaj) - Static method in class org.ejml.dense.row.CovarianceOps_DDRM
-
Performs a matrix inversion operations that takes advantage of the special
properties of a covariance matrix.
- invert(DMatrixRMaj, DMatrixRMaj) - Static method in class org.ejml.dense.row.CovarianceOps_DDRM
-
Performs a matrix inversion operations that takes advantage of the special
properties of a covariance matrix.
- invert(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.chol.LinearSolverChol_DDRM
-
Sets the matrix 'inv' equal to the inverse of the matrix that was decomposed.
- invert(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.chol.LinearSolverCholLDL_DDRM
-
Sets the matrix 'inv' equal to the inverse of the matrix that was decomposed.
- invert(LinearSolverDense<DMatrixRMaj>, DMatrix1Row, DMatrixRMaj, DMatrixRMaj) - Static method in class org.ejml.dense.row.linsol.InvertUsingSolve_DDRM
-
- invert(LinearSolverDense<DMatrixRMaj>, DMatrix1Row, DMatrixRMaj) - Static method in class org.ejml.dense.row.linsol.InvertUsingSolve_DDRM
-
- invert(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.LinearSolver_DDRB_to_DDRM
-
Creates a block matrix the same size as A_inv, inverts the matrix and copies the results back
onto A_inv.
- invert(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.LinearSolverAbstract_DDRM
-
- invert(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.LinearSolverUnrolled_DDRM
-
- invert(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.lu.LinearSolverLuBase_DDRM
-
- invert(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.qr.BaseLinearSolverQrp_DDRM
-
- invert(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.svd.SolvePseudoInverseSvd_DDRM
-
- invertLower(double[], double[], int, int, int) - Static method in class org.ejml.dense.block.InnerTriangularSolver_DDRB
-
Inverts a square lower triangular matrix: L = L-1
- invertLower(double[], int, int) - Static method in class org.ejml.dense.block.InnerTriangularSolver_DDRB
-
Inverts a square lower triangular matrix: L = L-1
- invertLower(double[], int) - Static method in class org.ejml.dense.row.decomposition.TriangularSolver_DDRM
-
Inverts a square lower triangular matrix: L = L-1
- invertLower(double[], double[], int) - Static method in class org.ejml.dense.row.decomposition.TriangularSolver_DDRM
-
- InvertUsingSolve_DDRM - Class in org.ejml.dense.row.linsol
-
A matrix can be easily inverted by solving a system with an identify matrix.
- InvertUsingSolve_DDRM() - Constructor for class org.ejml.dense.row.linsol.InvertUsingSolve_DDRM
-
- isCompact() - Method in class org.ejml.dense.row.decomposition.svd.SafeSvd_DDRM
-
- isCompact() - Method in class org.ejml.dense.row.decomposition.svd.SvdImplicitQrDecompose_DDRM
-
- isConstantVal(DMatrixRMaj, double, double) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if every value in the matrix is the specified value.
- isDiagonalPositive(DMatrixRMaj) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if all the diagonal elements in the matrix are positive.
- isDiagonalZero(int) - Method in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
- isEquals(DMatrixRBlock, DMatrixRBlock) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
- isEquals(DMatrixRBlock, DMatrixRBlock, double) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
- isEquals(DMatrixD1, DMatrixD1, double) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if each element in the two matrices are within tolerance of
each other: tol ≥ |aij - bij|.
- isEquals(DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if each element in the two matrices are equal:
aij == bij
- isEquals(BMatrixRMaj, BMatrixRMaj) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if each element in the two matrices are equal:
aij == bij
- isEqualsTriangle(DMatrix, DMatrix, boolean, double) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if each element in the upper or lower triangular portion of the two matrices are within tolerance of
each other: tol ≥ |aij - bij|.
- isEquivalent(DMatrix, DMatrix, double) - Static method in class org.ejml.generic.GenericMatrixOps_F64
-
- isEquivalentTriangle(boolean, DMatrix, DMatrix, double) - Static method in class org.ejml.generic.GenericMatrixOps_F64
-
- isFullRank(DMatrixRMaj) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
- isIdentical(DMatrix2x2, DMatrix2x2, double) - Static method in class org.ejml.dense.fixed.MatrixFeatures_DDF2
-
- isIdentical(DMatrix2, DMatrix2, double) - Static method in class org.ejml.dense.fixed.MatrixFeatures_DDF2
-
- isIdentical(DMatrix3x3, DMatrix3x3, double) - Static method in class org.ejml.dense.fixed.MatrixFeatures_DDF3
-
- isIdentical(DMatrix3, DMatrix3, double) - Static method in class org.ejml.dense.fixed.MatrixFeatures_DDF3
-
- isIdentical(DMatrix4x4, DMatrix4x4, double) - Static method in class org.ejml.dense.fixed.MatrixFeatures_DDF4
-
- isIdentical(DMatrix4, DMatrix4, double) - Static method in class org.ejml.dense.fixed.MatrixFeatures_DDF4
-
- isIdentical(DMatrix5x5, DMatrix5x5, double) - Static method in class org.ejml.dense.fixed.MatrixFeatures_DDF5
-
- isIdentical(DMatrix5, DMatrix5, double) - Static method in class org.ejml.dense.fixed.MatrixFeatures_DDF5
-
- isIdentical(DMatrix6x6, DMatrix6x6, double) - Static method in class org.ejml.dense.fixed.MatrixFeatures_DDF6
-
- isIdentical(DMatrix6, DMatrix6, double) - Static method in class org.ejml.dense.fixed.MatrixFeatures_DDF6
-
- isIdentical(DMatrixD1, DMatrixD1, double) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if each corresponding element in the two matrices are
within tolerance of each other or have the some symbolic meaning.
- isIdentity(DMatrixRMaj, double) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if the provided matrix is within tolerance to an identity matrix.
- isIdentity(DMatrix, double) - Static method in class org.ejml.generic.GenericMatrixOps_F64
-
Returns true if the provided matrix is has a value of 1 along the diagonal
elements and zero along all the other elements.
- isInverse(DMatrixRMaj, DMatrixRMaj, double) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if the two matrices are inverses of each other.
- isLower() - Method in class org.ejml.dense.block.decomposition.chol.CholeskyOuterForm_DDRB
-
- isLower() - Method in class org.ejml.dense.row.decomposition.chol.CholeskyDecomposition_DDRB_to_DDRM
-
- isLower() - Method in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionCommon_DDRM
-
If true the decomposition was for a lower triangular matrix.
- isLowerTriangle(DMatrixRMaj, int, double) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if a matrix is lower triangular or Hessenberg.
- isNegative(DMatrixD1, DMatrixD1, double) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if the two matrices are the negative of each other:
aij = -bij
- isOffZero(int) - Method in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
- isOrthogonal(DMatrixRMaj, double) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if a matrix is orthogonal or isometric.
- isPositiveDefinite(DMatrixRMaj) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if the matrix is positive definite.
- isPositiveSemidefinite(DMatrixRMaj) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if the matrix is positive semidefinite:
- isReal2x2(int, int) - Method in class org.ejml.dense.row.decomposition.eig.watched.WatchedDoubleStepQREigen_DDRM
-
- isRowsLinearIndependent(DMatrixRMaj) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if the rows of the provided matrix are linearly independent.
- isSingular() - Method in class org.ejml.dense.row.decomposition.lu.LUDecompositionBase_DDRM
-
Determines if the decomposed matrix is singular.
- isSkewSymmetric(DMatrixRMaj, double) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if a matrix is skew symmetric with in tolerance:
-A = AT
or
|aij + aji| ≤ tol
- isSquare(DMatrixD1) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if it is a square matrix.
- isSymmetric(DMatrixRMaj, double) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Returns true if the matrix is symmetric within the tolerance.
- isSymmetric(DMatrixRMaj) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Returns true if the matrix is perfectly symmetric.
- isUpperTriangle(DMatrixRMaj, int, double) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if a matrix is upper triangular or Hessenberg.
- isValid(DMatrixRMaj) - Static method in class org.ejml.dense.row.CovarianceOps_DDRM
-
Performs a variety of tests to see if the provided matrix is a valid
covariance matrix.
- isValidFast(DMatrixRMaj) - Static method in class org.ejml.dense.row.CovarianceOps_DDRM
-
This is a fairly light weight check to see of a covariance matrix is valid.
- isVector(Matrix) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see if the matrix is a vector or not.
- isZero(int) - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
Checks to see if the specified off diagonal element is zero using a relative metric.
- isZero(int, int) - Method in class org.ejml.dense.row.decomposition.eig.watched.WatchedDoubleStepQREigen_DDRM
-
- isZeros(DMatrixD1, double) - Static method in class org.ejml.dense.row.MatrixFeatures_DDRM
-
Checks to see all the elements in the matrix are zeros
- m - Variable in class org.ejml.dense.row.decomposition.lu.LUDecompositionBase_DDRM
-
- MatrixFeatures_DDF2 - Class in org.ejml.dense.fixed
-
Matrix features for fixed sized matrices which are 2 x 2 or 2 element vectors.
- MatrixFeatures_DDF2() - Constructor for class org.ejml.dense.fixed.MatrixFeatures_DDF2
-
- MatrixFeatures_DDF3 - Class in org.ejml.dense.fixed
-
Matrix features for fixed sized matrices which are 3 x 3 or 3 element vectors.
- MatrixFeatures_DDF3() - Constructor for class org.ejml.dense.fixed.MatrixFeatures_DDF3
-
- MatrixFeatures_DDF4 - Class in org.ejml.dense.fixed
-
Matrix features for fixed sized matrices which are 4 x 4 or 4 element vectors.
- MatrixFeatures_DDF4() - Constructor for class org.ejml.dense.fixed.MatrixFeatures_DDF4
-
- MatrixFeatures_DDF5 - Class in org.ejml.dense.fixed
-
Matrix features for fixed sized matrices which are 5 x 5 or 5 element vectors.
- MatrixFeatures_DDF5() - Constructor for class org.ejml.dense.fixed.MatrixFeatures_DDF5
-
- MatrixFeatures_DDF6 - Class in org.ejml.dense.fixed
-
Matrix features for fixed sized matrices which are 6 x 6 or 6 element vectors.
- MatrixFeatures_DDF6() - Constructor for class org.ejml.dense.fixed.MatrixFeatures_DDF6
-
- MatrixFeatures_DDRM - Class in org.ejml.dense.row
-
Used to compute features that describe the structure of a matrix.
- MatrixFeatures_DDRM() - Constructor for class org.ejml.dense.row.MatrixFeatures_DDRM
-
- MatrixMatrixMult_DDRM - Class in org.ejml.dense.row.mult
-
This class contains various types of matrix matrix multiplication operations for DMatrix1Row
.
- MatrixMatrixMult_DDRM() - Constructor for class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- MatrixMult_DDRB - Class in org.ejml.dense.block
-
Matrix multiplication for DMatrixRBlock
.
- MatrixMult_DDRB() - Constructor for class org.ejml.dense.block.MatrixMult_DDRB
-
- MatrixMultProduct_DDRM - Class in org.ejml.dense.row.mult
-
Specialized operations for performing inner and outer products for matrices.
- MatrixMultProduct_DDRM() - Constructor for class org.ejml.dense.row.mult.MatrixMultProduct_DDRM
-
- MatrixOps_DDRB - Class in org.ejml.dense.block
-
Various operations on DMatrixRBlock
.
- MatrixOps_DDRB() - Constructor for class org.ejml.dense.block.MatrixOps_DDRB
-
- MatrixVectorMult_DDRM - Class in org.ejml.dense.row.mult
-
This class contains various types of matrix vector multiplcation operations for DMatrixRMaj
.
- MatrixVectorMult_DDRM() - Constructor for class org.ejml.dense.row.mult.MatrixVectorMult_DDRM
-
- MAX - Static variable in class org.ejml.dense.row.misc.UnrolledDeterminantFromMinor_DDRM
-
- MAX - Static variable in class org.ejml.dense.row.misc.UnrolledInverseFromMinor_DDRM
-
- maxCols(DMatrixRMaj, DMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
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)
- maxCols - Variable in class org.ejml.dense.row.linsol.qr.LinearSolverQr_DDRM
-
- maxCols - Variable in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouseCol_DDRM
-
- maxCols - Variable in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouseTran_DDRM
-
- maxRows(DMatrixRMaj, DMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
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)
- maxRows - Variable in class org.ejml.dense.row.linsol.qr.LinearSolverQr_DDRM
-
- maxRows - Variable in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouseCol_DDRM
-
- maxRows - Variable in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouseTran_DDRM
-
- maxValue - Variable in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
- maxWidth - Variable in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionCommon_DDRM
-
- maxWidth - Variable in class org.ejml.dense.row.decomposition.lu.LUDecompositionBase_DDRM
-
- minCols(DMatrixRMaj, DMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
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)
- minLength - Variable in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholder_DDRM
-
- minLength - Variable in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholderColumn_DDRM
-
- minLength - Variable in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholderTran_DDRM
-
- minRows(DMatrixRMaj, DMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
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)
- modifiesA() - Method in class org.ejml.dense.block.linsol.chol.CholeskyOuterSolver_DDRB
-
- modifiesA() - Method in class org.ejml.dense.block.linsol.qr.QrHouseHolderSolver_DDRB
-
- modifiesA() - Method in class org.ejml.dense.row.linsol.chol.LinearSolverChol_DDRM
-
- modifiesA() - Method in class org.ejml.dense.row.linsol.chol.LinearSolverCholLDL_DDRM
-
- modifiesA() - Method in class org.ejml.dense.row.linsol.LinearSolver_DDRB_to_DDRM
-
- modifiesA() - Method in class org.ejml.dense.row.linsol.LinearSolverUnrolled_DDRM
-
- modifiesA() - Method in class org.ejml.dense.row.linsol.lu.LinearSolverLuBase_DDRM
-
- modifiesA() - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQr_DDRM
-
- modifiesA() - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouse_DDRM
-
- modifiesA() - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouseCol_DDRM
-
- modifiesA() - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouseTran_DDRM
-
- modifiesA() - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQrpHouseCol_DDRM
-
- modifiesA() - Method in class org.ejml.dense.row.linsol.qr.SolvePseudoInverseQrp_DDRM
-
- modifiesA() - Method in class org.ejml.dense.row.linsol.svd.SolvePseudoInverseSvd_DDRM
-
- modifiesB() - Method in class org.ejml.dense.block.linsol.chol.CholeskyOuterSolver_DDRB
-
- modifiesB() - Method in class org.ejml.dense.block.linsol.qr.QrHouseHolderSolver_DDRB
-
- modifiesB() - Method in class org.ejml.dense.row.linsol.chol.LinearSolverChol_DDRM
-
- modifiesB() - Method in class org.ejml.dense.row.linsol.chol.LinearSolverCholLDL_DDRM
-
- modifiesB() - Method in class org.ejml.dense.row.linsol.LinearSolver_DDRB_to_DDRM
-
- modifiesB() - Method in class org.ejml.dense.row.linsol.LinearSolverUnrolled_DDRM
-
- modifiesB() - Method in class org.ejml.dense.row.linsol.lu.LinearSolverLuBase_DDRM
-
- modifiesB() - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQr_DDRM
-
- modifiesB() - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouse_DDRM
-
- modifiesB() - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouseCol_DDRM
-
- modifiesB() - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouseTran_DDRM
-
- modifiesB() - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQrpHouseCol_DDRM
-
- modifiesB() - Method in class org.ejml.dense.row.linsol.qr.SolvePseudoInverseQrp_DDRM
-
- modifiesB() - Method in class org.ejml.dense.row.linsol.svd.SolvePseudoInverseSvd_DDRM
-
- mult(int, DSubmatrixD1, DSubmatrixD1, DSubmatrixD1) - Static method in class org.ejml.dense.block.MatrixMult_DDRB
-
Performs a matrix multiplication on DMatrixRBlock
submatrices.
c = a * b
- mult(DMatrixRBlock, DMatrixRBlock, DMatrixRBlock) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
- mult(DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c = a * b
cij = ∑k=1:n { aik * bkj}
- mult(double, DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c = α * a * b
cij = α ∑k=1:n { aik * bkj}
- mult(DMatrix2x2, DMatrix2, DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs matrix to vector multiplication:
c = a * b
ci = ∑k=1:n { aik * bk}
- mult(DMatrix2, DMatrix2x2, DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs vector to matrix multiplication:
c = a * b
cj = ∑k=1:n { bk * akj }
- mult(DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c = a * b
cij = ∑k=1:n { aik * bkj}
- mult(double, DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c = α * a * b
cij = α ∑k=1:n { aik * bkj}
- mult(DMatrix3x3, DMatrix3, DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs matrix to vector multiplication:
c = a * b
ci = ∑k=1:n { aik * bk}
- mult(DMatrix3, DMatrix3x3, DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs vector to matrix multiplication:
c = a * b
cj = ∑k=1:n { bk * akj }
- mult(DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c = a * b
cij = ∑k=1:n { aik * bkj}
- mult(double, DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c = α * a * b
cij = α ∑k=1:n { aik * bkj}
- mult(DMatrix4x4, DMatrix4, DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs matrix to vector multiplication:
c = a * b
ci = ∑k=1:n { aik * bk}
- mult(DMatrix4, DMatrix4x4, DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs vector to matrix multiplication:
c = a * b
cj = ∑k=1:n { bk * akj }
- mult(DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c = a * b
cij = ∑k=1:n { aik * bkj}
- mult(double, DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c = α * a * b
cij = α ∑k=1:n { aik * bkj}
- mult(DMatrix5x5, DMatrix5, DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs matrix to vector multiplication:
c = a * b
ci = ∑k=1:n { aik * bk}
- mult(DMatrix5, DMatrix5x5, DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs vector to matrix multiplication:
c = a * b
cj = ∑k=1:n { bk * akj }
- mult(DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c = a * b
cij = ∑k=1:n { aik * bkj}
- mult(double, DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c = α * a * b
cij = α ∑k=1:n { aik * bkj}
- mult(DMatrix6x6, DMatrix6, DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs matrix to vector multiplication:
c = a * b
ci = ∑k=1:n { aik * bk}
- mult(DMatrix6, DMatrix6x6, DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs vector to matrix multiplication:
c = a * b
cj = ∑k=1:n { bk * akj }
- mult(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = a * b
cij = ∑k=1:n { aik * bkj}
- mult(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = α * a * b
cij = α ∑k=1:n { * aik * bkj}
- mult(DMatrix1Row, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.mult.MatrixVectorMult_DDRM
-
Performs a matrix vector multiply.
c = A * b
and
c = A * bT
ci = Sum{ j=1:n, aij * bj}
where A is a matrix, b is a column or transposed row vector, and c is a column vector.
- mult_aux(DMatrix1Row, DMatrix1Row, DMatrix1Row, double[]) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- mult_aux(double, DMatrix1Row, DMatrix1Row, DMatrix1Row, double[]) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- mult_reorder(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- mult_reorder(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- mult_small(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- mult_small(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multA_u(int, DSubmatrixD1, DSubmatrixD1, int) - Static method in class org.ejml.dense.block.decomposition.hessenberg.TridiagonalHelper_DDRB
-
Multiples the appropriate submatrix of A by the specified reflector and stores
the result ('y') in V.
y = A*u
- multAdd(DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c += a * b
cij += ∑k=1:n { aik * bkj}
- multAdd(double, DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c += α * a * b
cij += α ∑k=1:n { aik * bkj}
- multAdd(DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c += a * b
cij += ∑k=1:n { aik * bkj}
- multAdd(double, DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c += α * a * b
cij += α ∑k=1:n { aik * bkj}
- multAdd(DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c += a * b
cij += ∑k=1:n { aik * bkj}
- multAdd(double, DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c += α * a * b
cij += α ∑k=1:n { aik * bkj}
- multAdd(DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c += a * b
cij += ∑k=1:n { aik * bkj}
- multAdd(double, DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c += α * a * b
cij += α ∑k=1:n { aik * bkj}
- multAdd(DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c += a * b
cij += ∑k=1:n { aik * bkj}
- multAdd(double, DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c += α * a * b
cij += α ∑k=1:n { aik * bkj}
- multAdd(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = c + a * b
cij = cij + ∑k=1:n { aik * bkj}
- multAdd(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = c + α * a * b
cij = cij + α * ∑k=1:n { aik * bkj}
- multAdd(DMatrix1Row, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.mult.MatrixVectorMult_DDRM
-
Performs a matrix vector multiply.
C = C + A * B
or
C = C + A * BT
ci = Sum{ j=1:n, ci + aij * bj}
where A is a matrix, B is a column or transposed row vector, and C is a column vector.
- multAdd_aux(DMatrix1Row, DMatrix1Row, DMatrix1Row, double[]) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multAdd_aux(double, DMatrix1Row, DMatrix1Row, DMatrix1Row, double[]) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multAdd_reorder(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multAdd_reorder(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multAdd_small(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multAdd_small(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multAdd_zeros(int, DSubmatrixD1, DSubmatrixD1, DSubmatrixD1) - Static method in class org.ejml.dense.block.decomposition.qr.BlockHouseHolder_DDRB
-
Special multiplication that takes in account the zeros and one in Y, which
is the matrix that stores the householder vectors.
- multAddTransA(DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c += aT * b
cij += ∑k=1:n { aki * bkj}
- multAddTransA(double, DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c += α * aT * b
cij += α * ∑k=1:n { aki * bkj}
- multAddTransA(DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c += aT * b
cij += ∑k=1:n { aki * bkj}
- multAddTransA(double, DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c += α * aT * b
cij += α * ∑k=1:n { aki * bkj}
- multAddTransA(DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c += aT * b
cij += ∑k=1:n { aki * bkj}
- multAddTransA(double, DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c += α * aT * b
cij += α * ∑k=1:n { aki * bkj}
- multAddTransA(DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c += aT * b
cij += ∑k=1:n { aki * bkj}
- multAddTransA(double, DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c += α * aT * b
cij += α * ∑k=1:n { aki * bkj}
- multAddTransA(DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c += aT * b
cij += ∑k=1:n { aki * bkj}
- multAddTransA(double, DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c += α * aT * b
cij += α * ∑k=1:n { aki * bkj}
- multAddTransA(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = c + aT * b
cij = cij + ∑k=1:n { aki * bkj}
- multAddTransA(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = c + α * aT * b
cij =cij + α * ∑k=1:n { aki * bkj}
- multAddTransA_reorder(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multAddTransA_reorder(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multAddTransA_reorder(DMatrix1Row, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.mult.MatrixVectorMult_DDRM
-
- multAddTransA_small(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multAddTransA_small(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multAddTransA_small(DMatrix1Row, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.mult.MatrixVectorMult_DDRM
-
Performs a matrix vector multiply.
C = C + AT * B
or
C = CT + AT * BT
ci = Sum{ j=1:n, ci + aji * bj}
where A is a matrix, B is a column or transposed row vector, and C is a column vector.
- multAddTransAB(DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c += aT * bT
cij += ∑k=1:n { aki * bjk}
- multAddTransAB(double, DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c += α*aT * bT
cij += α*∑k=1:n { aki * bjk}
- multAddTransAB(DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c += aT * bT
cij += ∑k=1:n { aki * bjk}
- multAddTransAB(double, DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c += α*aT * bT
cij += α*∑k=1:n { aki * bjk}
- multAddTransAB(DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c += aT * bT
cij += ∑k=1:n { aki * bjk}
- multAddTransAB(double, DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c += α*aT * bT
cij += α*∑k=1:n { aki * bjk}
- multAddTransAB(DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c += aT * bT
cij += ∑k=1:n { aki * bjk}
- multAddTransAB(double, DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c += α*aT * bT
cij += α*∑k=1:n { aki * bjk}
- multAddTransAB(DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c += aT * bT
cij += ∑k=1:n { aki * bjk}
- multAddTransAB(double, DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c += α*aT * bT
cij += α*∑k=1:n { aki * bjk}
- multAddTransAB(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = c + aT * bT
cij = cij + ∑k=1:n { aki * bjk}
- multAddTransAB(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = c + α * aT * bT
cij = cij + α * ∑k=1:n { aki * bjk}
- multAddTransAB(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multAddTransAB(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multAddTransAB_aux(DMatrix1Row, DMatrix1Row, DMatrix1Row, double[]) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multAddTransAB_aux(double, DMatrix1Row, DMatrix1Row, DMatrix1Row, double[]) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multAddTransB(DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c += a * bT
cij += ∑k=1:n { aik * bjk}
- multAddTransB(double, DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c += α * a * bT
cij += α*∑k=1:n { aik * bjk}
- multAddTransB(DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c += a * bT
cij += ∑k=1:n { aik * bjk}
- multAddTransB(double, DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c += α * a * bT
cij += α*∑k=1:n { aik * bjk}
- multAddTransB(DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c += a * bT
cij += ∑k=1:n { aik * bjk}
- multAddTransB(double, DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c += α * a * bT
cij += α*∑k=1:n { aik * bjk}
- multAddTransB(DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c += a * bT
cij += ∑k=1:n { aik * bjk}
- multAddTransB(double, DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c += α * a * bT
cij += α*∑k=1:n { aik * bjk}
- multAddTransB(DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c += a * bT
cij += ∑k=1:n { aik * bjk}
- multAddTransB(double, DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c += α * a * bT
cij += α*∑k=1:n { aik * bjk}
- multAddTransB(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = c + a * bT
cij = cij + ∑k=1:n { aik * bjk}
- multAddTransB(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = c + α * a * bT
cij = cij + α * ∑k=1:n { aik * bjk}
- multAddTransB(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multAddTransB(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multBlockAdd_zerosone(double[], double[], double[], int, int, int, int, int, int) - Static method in class org.ejml.dense.block.decomposition.qr.BlockHouseHolder_DDRB
-
Inner block mult add operation that takes in account the zeros and on in dataA,
which is the top part of the Y block vector that has the householder vectors.
C = C + A * B
- multInner(DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Computes the matrix multiplication inner product:
c = aT * a
cij = ∑k=1:n { aki * akj}
- multMinus(int, DSubmatrixD1, DSubmatrixD1, DSubmatrixD1) - Static method in class org.ejml.dense.block.MatrixMult_DDRB
-
Performs a matrix multiplication on DMatrixRBlock
submatrices.
c = c - a * b
- multMinusTransA(int, DSubmatrixD1, DSubmatrixD1, DSubmatrixD1) - Static method in class org.ejml.dense.block.MatrixMult_DDRB
-
- multOuter(DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Computes the matrix multiplication outer product:
c = a * aT
cij = ∑k=1:m { aik * ajk}
- multPlus(int, DSubmatrixD1, DSubmatrixD1, DSubmatrixD1) - Static method in class org.ejml.dense.block.MatrixMult_DDRB
-
Performs a matrix multiplication on DMatrixRBlock
submatrices.
c = c + a * b
- multPlusTransA(int, DSubmatrixD1, DSubmatrixD1, DSubmatrixD1) - Static method in class org.ejml.dense.block.decomposition.hessenberg.TridiagonalDecompositionHouseholder_DDRB
-
C = C + A^T*B
- multPlusTransA(int, DSubmatrixD1, DSubmatrixD1, DSubmatrixD1) - Static method in class org.ejml.dense.block.MatrixMult_DDRB
-
- multTransA(int, DSubmatrixD1, DSubmatrixD1, DSubmatrixD1) - Static method in class org.ejml.dense.block.MatrixMult_DDRB
-
Performs a matrix multiplication with a transpose on DMatrixRBlock
submatrices.
c = aT * b
- multTransA(DMatrixRBlock, DMatrixRBlock, DMatrixRBlock) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
- multTransA(DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c = aT * b
cij = ∑k=1:n { aki * bkj}
- multTransA(double, DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c = α * aT * b
cij = α * ∑k=1:n { aki * bkj}
- multTransA(DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c = aT * b
cij = ∑k=1:n { aki * bkj}
- multTransA(double, DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c = α * aT * b
cij = α * ∑k=1:n { aki * bkj}
- multTransA(DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c = aT * b
cij = ∑k=1:n { aki * bkj}
- multTransA(double, DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c = α * aT * b
cij = α * ∑k=1:n { aki * bkj}
- multTransA(DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c = aT * b
cij = ∑k=1:n { aki * bkj}
- multTransA(double, DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c = α * aT * b
cij = α * ∑k=1:n { aki * bkj}
- multTransA(DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c = aT * b
cij = ∑k=1:n { aki * bkj}
- multTransA(double, DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c = α * aT * b
cij = α * ∑k=1:n { aki * bkj}
- multTransA(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = aT * b
cij = ∑k=1:n { aki * bkj}
- multTransA(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = α * aT * b
cij = α ∑k=1:n { aki * bkj}
- multTransA_reorder(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multTransA_reorder(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multTransA_reorder(DMatrix1Row, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.mult.MatrixVectorMult_DDRM
-
- multTransA_small(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multTransA_small(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multTransA_small(DMatrix1Row, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.mult.MatrixVectorMult_DDRM
-
Performs a matrix vector multiply.
C = AT * B
where B is a column vector.
or
C = AT * BT
where B is a row vector.
- multTransA_vecCol(int, DSubmatrixD1, DSubmatrixD1, DSubmatrixD1) - Static method in class org.ejml.dense.block.decomposition.qr.BlockHouseHolder_DDRB
-
Performs a matrix multiplication on the block aligned submatrices.
- multTransAB(DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c = aT * bT
cij = ∑k=1:n { aki * bjk}
- multTransAB(double, DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c = α*aT * bT
cij = α*∑k=1:n { aki * bjk}
- multTransAB(DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c = aT * bT
cij = ∑k=1:n { aki * bjk}
- multTransAB(double, DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c = α*aT * bT
cij = α*∑k=1:n { aki * bjk}
- multTransAB(DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c = aT * bT
cij = ∑k=1:n { aki * bjk}
- multTransAB(double, DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c = α*aT * bT
cij = α*∑k=1:n { aki * bjk}
- multTransAB(DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c = aT * bT
cij = ∑k=1:n { aki * bjk}
- multTransAB(double, DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c = α*aT * bT
cij = α*∑k=1:n { aki * bjk}
- multTransAB(DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c = aT * bT
cij = ∑k=1:n { aki * bjk}
- multTransAB(double, DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c = α*aT * bT
cij = α*∑k=1:n { aki * bjk}
- multTransAB(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = aT * bT
cij = ∑k=1:n { aki * bjk}
- multTransAB(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = α * aT * bT
cij = α ∑k=1:n { aki * bjk}
- multTransAB(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multTransAB(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multTransAB_aux(DMatrix1Row, DMatrix1Row, DMatrix1Row, double[]) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multTransAB_aux(double, DMatrix1Row, DMatrix1Row, DMatrix1Row, double[]) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multTransABlockMinus(double[], double[], int, int, int, int, int, int) - Static method in class org.ejml.dense.block.InnerRankUpdate_DDRB
-
Performs the following operation on a block:
c = c - aTa
- multTransABlockMinus_U(double[], double[], int, int, int, int, int, int) - Static method in class org.ejml.dense.block.InnerRankUpdate_DDRB
-
Performs the following operation on the upper triangular portion of a block:
c = c - aTa
- multTransABlockSet_lowerTriag(double[], double[], double[], int, int, int, int, int, int) - Static method in class org.ejml.dense.block.decomposition.qr.BlockHouseHolder_DDRB
-
Performs a matrix multiplication on an single inner block where A is assumed to be lower triangular with diagonal
elements equal to 1.
C = A^T * B
- multTransB(int, DSubmatrixD1, DSubmatrixD1, DSubmatrixD1) - Static method in class org.ejml.dense.block.MatrixMult_DDRB
-
Performs a matrix multiplication with a transpose on DMatrixRBlock
submatrices.
c = a * b T
- multTransB(DMatrixRBlock, DMatrixRBlock, DMatrixRBlock) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
- multTransB(DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c = a * bT
cij = ∑k=1:n { aik * bjk}
- multTransB(double, DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c = α * a * bT
cij = α*∑k=1:n { aik * bjk}
- multTransB(DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c = a * bT
cij = ∑k=1:n { aik * bjk}
- multTransB(double, DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c = α * a * bT
cij = α*∑k=1:n { aik * bjk}
- multTransB(DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c = a * bT
cij = ∑k=1:n { aik * bjk}
- multTransB(double, DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c = α * a * bT
cij = α*∑k=1:n { aik * bjk}
- multTransB(DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c = a * bT
cij = ∑k=1:n { aik * bjk}
- multTransB(double, DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c = α * a * bT
cij = α*∑k=1:n { aik * bjk}
- multTransB(DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c = a * bT
cij = ∑k=1:n { aik * bjk}
- multTransB(double, DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c = α * a * bT
cij = α*∑k=1:n { aik * bjk}
- multTransB(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = a * bT
cij = ∑k=1:n { aik * bjk}
- multTransB(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following operation:
c = α * a * bT
cij = α ∑k=1:n { aik * bjk}
- multTransB(DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multTransB(double, DMatrix1Row, DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.mult.MatrixMatrixMult_DDRM
-
- multTransBBlockMinus(double[], double[], int, int, int, int, int, int) - Static method in class org.ejml.dense.block.InnerRankUpdate_DDRB
-
Performs the following operation on a block:
c = c - a*aT
- multTransBBlockMinus_L(double[], double[], int, int, int, int, int, int) - Static method in class org.ejml.dense.block.InnerRankUpdate_DDRB
-
Performs the following operation on the lower triangular portion of a block:
c = c - a*aT
- SafeSvd_DDRM - Class in org.ejml.dense.row.decomposition.svd
-
Wraps around a SingularValueDecomposition
and ensures that the input is not modified.
- SafeSvd_DDRM(SingularValueDecomposition_F64<DMatrixRMaj>) - Constructor for class org.ejml.dense.row.decomposition.svd.SafeSvd_DDRM
-
- scale(double, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs an in-place element by element scalar multiplication.
aij = α*aij
- scale(double, DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs an in-place element by element scalar multiplication.
aij = α*aij
- scale(double, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs an element by element scalar multiplication.
bij = α*aij
- scale(double, DMatrix2, DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs an element by element scalar multiplication.
bi = α*ai
- scale(double, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs an in-place element by element scalar multiplication.
aij = α*aij
- scale(double, DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs an in-place element by element scalar multiplication.
aij = α*aij
- scale(double, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs an element by element scalar multiplication.
bij = α*aij
- scale(double, DMatrix3, DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs an element by element scalar multiplication.
bi = α*ai
- scale(double, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs an in-place element by element scalar multiplication.
aij = α*aij
- scale(double, DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs an in-place element by element scalar multiplication.
aij = α*aij
- scale(double, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs an element by element scalar multiplication.
bij = α*aij
- scale(double, DMatrix4, DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs an element by element scalar multiplication.
bi = α*ai
- scale(double, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs an in-place element by element scalar multiplication.
aij = α*aij
- scale(double, DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs an in-place element by element scalar multiplication.
aij = α*aij
- scale(double, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs an element by element scalar multiplication.
bij = α*aij
- scale(double, DMatrix5, DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs an element by element scalar multiplication.
bi = α*ai
- scale(double, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs an in-place element by element scalar multiplication.
aij = α*aij
- scale(double, DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs an in-place element by element scalar multiplication.
aij = α*aij
- scale(double, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs an element by element scalar multiplication.
bij = α*aij
- scale(double, DMatrix6, DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs an element by element scalar multiplication.
bi = α*ai
- scale(double, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs an in-place element by element scalar multiplication.
aij = α*aij
- scale(double, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs an element by element scalar multiplication.
bij = α*aij
- scale_row(int, DSubmatrixD1, DSubmatrixD1, int, int, double) - Static method in class org.ejml.dense.block.decomposition.qr.BlockHouseHolder_DDRB
-
Scales the elements in the specified row starting at element colStart by 'val'.
W = val*Y
Takes in account zeros and leading one automatically.
- scale_row(int, DSubmatrixD1, int, double, DSubmatrixD1, int, int, int) - Static method in class org.ejml.dense.block.VectorOps_DDRB
-
Row vector scale:
scale: bi = α*ai
where 'a' and 'b' are row vectors within the row block vector A and B.
- selectWilkinsonShift(double) - Method in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
Selects the Wilkinson's shift for BTB.
- set(DMatrixRBlock, double) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
Sets every element in the matrix to the specified value.
aij = value
- setA(DMatrixRBlock) - Method in class org.ejml.dense.block.linsol.chol.CholeskyOuterSolver_DDRB
-
Decomposes and overwrites the input matrix.
- setA(DMatrixRBlock) - Method in class org.ejml.dense.block.linsol.qr.QrHouseHolderSolver_DDRB
-
Computes the QR decomposition of A and store the results in A.
- setA(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.chol.LinearSolverChol_DDRM
-
- setA(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.chol.LinearSolverCholLDL_DDRM
-
- setA(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.LinearSolver_DDRB_to_DDRM
-
Converts 'A' into a block matrix and call setA() on the block matrix solver.
- setA(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.LinearSolverUnrolled_DDRM
-
- setA(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.lu.LinearSolverLuBase_DDRM
-
- setA(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.lu.LinearSolverLuKJI_DDRM
-
- setA(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.qr.BaseLinearSolverQrp_DDRM
-
- setA(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQr_DDRM
-
Performs QR decomposition on A
- setA(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouse_DDRM
-
Performs QR decomposition on A
- setA(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouseCol_DDRM
-
Performs QR decomposition on A
- setA(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouseTran_DDRM
-
Performs QR decomposition on A
- setA(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.qr.SolvePseudoInverseQrp_DDRM
-
- setA(DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.svd.SolvePseudoInverseSvd_DDRM
-
- setChecks(boolean, boolean, boolean) - Method in class org.ejml.dense.row.decomposition.eig.watched.WatchedDoubleStepQREigen_DDRM
-
- setComputeVectorsWithValues(boolean) - Method in class org.ejml.dense.row.decomposition.eig.SymmetricQRAlgorithmDecomposition_DDRM
-
- setExpectedMaxSize(int, int) - Method in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionBlock_DDRM
-
Declares additional internal data structures.
- setExpectedMaxSize(int, int) - Method in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionCommon_DDRM
-
- setExpectedMaxSize(int, int) - Method in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionLDL_DDRM
-
- setExpectedMaxSize(int, int) - Method in class org.ejml.dense.row.decomposition.lu.LUDecompositionBase_DDRM
-
- setExpectedMaxSize(int, int) - Method in class org.ejml.dense.row.decomposition.qr.QRColPivDecompositionHouseholderColumn_DDRM
-
- setExpectedMaxSize(int, int) - Method in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholder_DDRM
-
- setExpectedMaxSize(int, int) - Method in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholderColumn_DDRM
-
- setExpectedMaxSize(int, int) - Method in class org.ejml.dense.row.decomposition.qr.QRDecompositionHouseholderTran_DDRM
-
- setFastEigenvalues(boolean) - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQrAlgorithm_DDRM
-
- setFastValues(boolean) - Method in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
- setIdentity(DMatrixRBlock) - Static method in class org.ejml.dense.block.MatrixOps_DDRB
-
Sets the value of A to all zeros except along the diagonal.
- setIdentity(DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Sets all the diagonal elements equal to one and everything else equal to zero.
- setIdentity(DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Sets all the diagonal elements equal to one and everything else equal to zero.
- setIdentity(DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Sets all the diagonal elements equal to one and everything else equal to zero.
- setIdentity(DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Sets all the diagonal elements equal to one and everything else equal to zero.
- setIdentity(DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Sets all the diagonal elements equal to one and everything else equal to zero.
- setIdentity(DMatrix1Row) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Sets all the diagonal elements equal to one and everything else equal to zero.
- setMatrix(int, int, double[], double[]) - Method in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
- setMatrix(DMatrixD1) - Method in class org.ejml.dense.row.DMatrixComponent
-
- setMaxIterations(int) - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQrAlgorithm_DDRM
-
- setMaxIterations(int) - Method in class org.ejml.dense.row.decomposition.eig.SymmetricQRAlgorithmDecomposition_DDRM
-
Used to limit the number of internal QR iterations that the QR algorithm performs.
- setMaxSize(int, int) - Method in class org.ejml.dense.row.linsol.qr.AdjLinearSolverQr_DDRM
-
- setMaxSize(int, int) - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQr_DDRM
-
Changes the size of the matrix it can solve for
- setMaxSize(int) - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouse_DDRM
-
- setMaxSize(int, int) - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouseCol_DDRM
-
- setMaxSize(int, int) - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouseTran_DDRM
-
- setMaxValue(double) - Method in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
- setOptions(int, double) - Method in class org.ejml.dense.row.decomposition.eig.EigenPowerMethod_DDRM
-
- setQ(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQrAlgorithm_DDRM
-
- setQ(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
- setQ(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.eig.watched.WatchedDoubleStepQREigen_DDRM
-
- setRandom(DMatrix, double, double, Random) - Static method in class org.ejml.generic.GenericMatrixOps_F64
-
- setRandomB(BMatrixRMaj, Random) - Static method in class org.ejml.dense.row.RandomMatrices_DDRM
-
Sets each element in the boolean matrix to true or false with equal probability
- setSaveW(boolean) - Method in class org.ejml.dense.block.decomposition.qr.QRDecompositionHouseholder_DDRB
-
Sets if it should internally save the W matrix before performing the decomposition.
- setSeed(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.eig.EigenPowerMethod_DDRM
-
Sets the value of the vector to use in the start of the iterations.
- setSingularThreshold(double) - Method in class org.ejml.dense.row.decomposition.qr.QRColPivDecompositionHouseholderColumn_DDRM
-
- setSubmatrix(int, int) - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
Sets which submatrix is being processed.
- setSubmatrix(int, int) - Method in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
- setSubMatrix(DMatrix1Row, DMatrix1Row, int, int, int, int, int, int) - Static method in class org.ejml.dense.row.mult.SubmatrixOps_DDRM
-
- setThreshold(double) - Method in class org.ejml.dense.row.linsol.svd.SolvePseudoInverseSvd_DDRM
-
Specify the relative threshold used to select singular values.
- setToInverseL(double[]) - Method in class org.ejml.dense.row.linsol.chol.LinearSolverChol_DDRM
-
Sets the matrix to the inverse using a lower triangular matrix.
- setTolerance(double) - Method in class org.ejml.dense.row.misc.RrefGaussJordanRowPivot_DDRM
-
- setup(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.eig.watched.WatchedDoubleStepQREigen_DDRM
-
- setup(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.eig.watched.WatchedDoubleStepQREigenvalue_DDRM
-
- setupPivotInfo() - Method in class org.ejml.dense.row.decomposition.qr.QRColPivDecompositionHouseholderColumn_DDRM
-
Sets the initial pivot ordering and compute the F-norm squared for each column
- setUt(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
- setVt(DMatrixRMaj) - Method in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
- show(DMatrixD1, String) - Static method in class org.ejml.dense.row.DMatrixVisualization
-
Creates a window visually showing the matrix's state.
- singular(int, int, Random, double...) - Static method in class org.ejml.dense.row.RandomMatrices_DDRM
-
Creates a random matrix which will have the provided singular values.
- SingularOps_DDRM - Class in org.ejml.dense.row
-
Operations related to singular value decomposition.
- SingularOps_DDRM() - Constructor for class org.ejml.dense.row.SingularOps_DDRM
-
- singularThreshold - Variable in class org.ejml.dense.row.decomposition.qr.QRColPivDecompositionHouseholderColumn_DDRM
-
- singularThreshold(SingularValueDecomposition_F64) - Static method in class org.ejml.dense.row.SingularOps_DDRM
-
Returns a reasonable threshold for singular values.
tol = max (size (A)) * largest sigma * eps;
- solve(DMatrixRBlock, DMatrixRBlock) - Method in class org.ejml.dense.block.linsol.chol.CholeskyOuterSolver_DDRB
-
If X == null then the solution is written into B.
- solve(DMatrixRBlock, DMatrixRBlock) - Method in class org.ejml.dense.block.linsol.qr.QrHouseHolderSolver_DDRB
-
- solve(int, boolean, DSubmatrixD1, DSubmatrixD1, boolean) - Static method in class org.ejml.dense.block.TriangularSolver_DDRB
-
Performs an in-place solve operation on the provided block aligned sub-matrices.
B = T-1 B
where T is a triangular matrix.
- solve(DMatrixRMaj, DMatrixRMaj, DMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Solves for x in the following equation:
A*x = b
- solve(DMatrixRMaj, DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.chol.LinearSolverChol_DDRB
-
Only converts the B matrix and passes that onto solve.
- solve(DMatrixRMaj, DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.chol.LinearSolverChol_DDRM
-
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.
- solve(DMatrixRMaj, DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.chol.LinearSolverCholLDL_DDRM
-
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.
- solve(DMatrixRMaj, DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.LinearSolver_DDRB_to_DDRM
-
Converts B and X into block matrices and calls the block matrix solve routine.
- solve(DMatrixRMaj, DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.LinearSolverUnrolled_DDRM
-
- solve(DMatrixRMaj, DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.lu.LinearSolverLu_DDRM
-
- solve(DMatrixRMaj, DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.lu.LinearSolverLuKJI_DDRM
-
An other implementation of solve() that processes the matrices in a different order.
- solve(DMatrixRMaj, DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQr_DDRM
-
Solves for X using the QR decomposition.
- solve(DMatrixRMaj, DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouse_DDRM
-
Solves for X using the QR decomposition.
- solve(DMatrixRMaj, DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouseCol_DDRM
-
Solves for X using the QR decomposition.
- solve(DMatrixRMaj, DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQrHouseTran_DDRM
-
Solves for X using the QR decomposition.
- solve(DMatrixRMaj, DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.qr.LinearSolverQrpHouseCol_DDRM
-
- solve(DMatrixRMaj, DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.qr.SolvePseudoInverseQrp_DDRM
-
- solve(DMatrixRMaj, DMatrixRMaj) - Method in class org.ejml.dense.row.linsol.svd.SolvePseudoInverseSvd_DDRM
-
- solveBlock(int, boolean, DSubmatrixD1, DSubmatrixD1, boolean, boolean) - Static method in class org.ejml.dense.block.TriangularSolver_DDRB
-
Performs an in-place solve operation where T is contained in a single block.
B = T-1 B
where T is a triangular matrix contained in an inner block.
- solveL(double[], double[], int, int, int, int, int) - Static method in class org.ejml.dense.block.InnerTriangularSolver_DDRB
-
Solves for non-singular lower triangular matrices using forward substitution.
- solveL(int, DSubmatrixD1, DSubmatrixD1, boolean) - Static method in class org.ejml.dense.block.TriangularSolver_DDRB
-
Solves lower triangular systems:
B = L-1 B
- solveL(double[], double[], int) - Static method in class org.ejml.dense.row.decomposition.TriangularSolver_DDRM
-
Solves for non-singular lower triangular matrices using forward substitution.
- solveL(double[], double[], int, int) - Static method in class org.ejml.dense.row.decomposition.TriangularSolver_DDRM
-
L is a m by m matrix
B is a m by n matrix
- solveL_special(double[], DMatrixRMaj, int, int, DMatrixRMaj) - Static method in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionBlock_DDRM
-
- solveLTransB(double[], double[], int, int, int, int, int) - Static method in class org.ejml.dense.block.InnerTriangularSolver_DDRB
-
Solves for non-singular lower triangular matrices using forward substitution.
- SolveNullSpaceQR_DDRM - Class in org.ejml.dense.row.linsol.qr
-
Uses QR decomposition to find the null-space for a matrix of any shape if the number of
singular values is known.
- SolveNullSpaceQR_DDRM() - Constructor for class org.ejml.dense.row.linsol.qr.SolveNullSpaceQR_DDRM
-
- SolveNullSpaceQRP_DDRM - Class in org.ejml.dense.row.linsol.qr
-
Uses QR decomposition to find the null-space for a matrix of any shape if the number of
singular values is known.=
- SolveNullSpaceQRP_DDRM() - Constructor for class org.ejml.dense.row.linsol.qr.SolveNullSpaceQRP_DDRM
-
- SolveNullSpaceSvd_DDRM - Class in org.ejml.dense.row.linsol.svd
-
- SolveNullSpaceSvd_DDRM() - Constructor for class org.ejml.dense.row.linsol.svd.SolveNullSpaceSvd_DDRM
-
- SolvePseudoInverseQrp_DDRM - Class in org.ejml.dense.row.linsol.qr
-
A pseudo inverse solver for a generic QR column pivot decomposition algorithm.
- SolvePseudoInverseQrp_DDRM(QRPDecomposition_F64<DMatrixRMaj>, boolean) - Constructor for class org.ejml.dense.row.linsol.qr.SolvePseudoInverseQrp_DDRM
-
Configure and provide decomposition
- SolvePseudoInverseSvd_DDRM - Class in org.ejml.dense.row.linsol.svd
-
The pseudo-inverse is typically used to solve over determined system for which there is no unique solution.
x=inv(ATA)ATb
where A ∈ ℜ m × n and m ≥ n.
- SolvePseudoInverseSvd_DDRM(int, int) - Constructor for class org.ejml.dense.row.linsol.svd.SolvePseudoInverseSvd_DDRM
-
Creates a new solver targeted at the specified matrix size.
- SolvePseudoInverseSvd_DDRM() - Constructor for class org.ejml.dense.row.linsol.svd.SolvePseudoInverseSvd_DDRM
-
Creates a solver targeted at matrices around 100x100
- solveR(int, DSubmatrixD1, DSubmatrixD1, boolean) - Static method in class org.ejml.dense.block.TriangularSolver_DDRB
-
Solves upper triangular systems:
B = R-1 B
- solveTranL(double[], double[], int) - Static method in class org.ejml.dense.row.decomposition.TriangularSolver_DDRM
-
This is a forward substitution solver for non-singular lower triangular matrices.
- solveTransL(double[], double[], int, int, int, int, int) - Static method in class org.ejml.dense.block.InnerTriangularSolver_DDRB
-
Solves for non-singular transposed lower triangular matrices using backwards substitution:
B = L-TB
where B is a (m by n) matrix, L is a lower triangular (m by m) matrix.
- solveTransU(double[], double[], int, int, int, int, int) - Static method in class org.ejml.dense.block.InnerTriangularSolver_DDRB
-
Solves for non-singular upper triangular matrices using forward substitution.
- solveU(double[], double[], int, int, int, int, int) - Static method in class org.ejml.dense.block.InnerTriangularSolver_DDRB
-
Solves for non-singular upper triangular matrices using backwards substitution.
- solveU(double[], double[], int) - Static method in class org.ejml.dense.row.decomposition.TriangularSolver_DDRM
-
This is a forward substitution solver for non-singular upper triangular matrices.
- solveU(double[], double[], int, int, int) - Static method in class org.ejml.dense.row.decomposition.TriangularSolver_DDRM
-
- solveU(double[], int, int, int, double[], int, int, int) - Static method in class org.ejml.dense.row.decomposition.TriangularSolver_DDRM
-
This is a forward substitution solver for non-singular upper triangular matrices which are
a sub-matrix inside a larger.
- span(int, int, Random) - Static method in class org.ejml.dense.row.RandomMatrices_DDRM
-
Creates a randomly generated set of orthonormal vectors.
- SpecializedOps_DDRM - Class in org.ejml.dense.row
-
This contains less common or more specialized matrix operations.
- SpecializedOps_DDRM() - Constructor for class org.ejml.dense.row.SpecializedOps_DDRM
-
- splitIntoVectors(DMatrix1Row, boolean) - Static method in class org.ejml.dense.row.SpecializedOps_DDRM
-
Takes a matrix and splits it into a set of row or column vectors.
- splits - Variable in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
- splits - Variable in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
- square(DMatrix1Row) - Static method in class org.ejml.dense.row.misc.TransposeAlgs_DDRM
-
In-place transpose for a square matrix.
- standard(DMatrix1Row, DMatrix1Row) - Static method in class org.ejml.dense.row.misc.TransposeAlgs_DDRM
-
A straight forward transpose.
- steps - Variable in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
- SubmatrixOps_DDRM - Class in org.ejml.dense.row.mult
-
Operations that are performed on a submatrix inside a larger matrix.
- SubmatrixOps_DDRM() - Constructor for class org.ejml.dense.row.mult.SubmatrixOps_DDRM
-
- subtract(DMatrix2x2, DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c = a - b
cij = aij - bij
- subtract(DMatrix2, DMatrix2, DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
c = a - b
ci = ai - bi
- subtract(DMatrix3x3, DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c = a - b
cij = aij - bij
- subtract(DMatrix3, DMatrix3, DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
c = a - b
ci = ai - bi
- subtract(DMatrix4x4, DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c = a - b
cij = aij - bij
- subtract(DMatrix4, DMatrix4, DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
c = a - b
ci = ai - bi
- subtract(DMatrix5x5, DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c = a - b
cij = aij - bij
- subtract(DMatrix5, DMatrix5, DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
c = a - b
ci = ai - bi
- subtract(DMatrix6x6, DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c = a - b
cij = aij - bij
- subtract(DMatrix6, DMatrix6, DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
c = a - b
ci = ai - bi
- subtract(DMatrixD1, double, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs matrix scalar subtraction:
c = a - val
cij = aij - val
- subtract(double, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs matrix scalar subtraction:
c = val - a
cij = val - aij
- subtract(DMatrixD1, DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following subtraction operation:
c = a - b
cij = aij - bij
- subtractEquals(DMatrix2x2, DMatrix2x2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
a = a - b
aij = aij - bij
- subtractEquals(DMatrix2, DMatrix2) - Static method in class org.ejml.dense.fixed.CommonOps_DDF2
-
Performs the following operation:
a = a - b
ai = ai - bi
- subtractEquals(DMatrix3x3, DMatrix3x3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
a = a - b
aij = aij - bij
- subtractEquals(DMatrix3, DMatrix3) - Static method in class org.ejml.dense.fixed.CommonOps_DDF3
-
Performs the following operation:
a = a - b
ai = ai - bi
- subtractEquals(DMatrix4x4, DMatrix4x4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
a = a - b
aij = aij - bij
- subtractEquals(DMatrix4, DMatrix4) - Static method in class org.ejml.dense.fixed.CommonOps_DDF4
-
Performs the following operation:
a = a - b
ai = ai - bi
- subtractEquals(DMatrix5x5, DMatrix5x5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
a = a - b
aij = aij - bij
- subtractEquals(DMatrix5, DMatrix5) - Static method in class org.ejml.dense.fixed.CommonOps_DDF5
-
Performs the following operation:
a = a - b
ai = ai - bi
- subtractEquals(DMatrix6x6, DMatrix6x6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
a = a - b
aij = aij - bij
- subtractEquals(DMatrix6, DMatrix6) - Static method in class org.ejml.dense.fixed.CommonOps_DDF6
-
Performs the following operation:
a = a - b
ai = ai - bi
- subtractEquals(DMatrixD1, DMatrixD1) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Performs the following subtraction operation:
a = a - b
aij = aij - bij
- subvector(DMatrix1Row, int, int, int, boolean, int, DMatrix1Row) - Static method in class org.ejml.dense.row.SpecializedOps_DDRM
-
Extracts a row or column vector from matrix A.
- sumCols(DMatrixRMaj, DMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Computes the sum of each column in the input matrix and returns the results in a vector:
bj = min(i=1:m ; aij)
- sumRows(DMatrixRMaj, DMatrixRMaj) - Static method in class org.ejml.dense.row.CommonOps_DDRM
-
Computes the sum of each row in the input matrix and returns the results in a vector:
bj = sum(i=1:n ; aji)
- svd(int, int, boolean, boolean, boolean) - Static method in class org.ejml.dense.row.factory.DecompositionFactory_DDRM
-
Returns a SingularValueDecomposition
that has been optimized for the specified matrix size.
- SvdImplicitQrAlgorithm_DDRM - Class in org.ejml.dense.row.decomposition.svd.implicitqr
-
Computes the QR decomposition of a bidiagonal matrix.
- SvdImplicitQrAlgorithm_DDRM(boolean) - Constructor for class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
- SvdImplicitQrAlgorithm_DDRM() - Constructor for class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
- SvdImplicitQrDecompose_DDRM - Class in org.ejml.dense.row.decomposition.svd
-
Computes the Singular value decomposition of a matrix using the implicit QR algorithm
for singular value decomposition.
- SvdImplicitQrDecompose_DDRM(boolean, boolean, boolean, boolean) - Constructor for class org.ejml.dense.row.decomposition.svd.SvdImplicitQrDecompose_DDRM
-
Configures the class
- swapColumns(int) - Method in class org.ejml.dense.row.decomposition.qr.QRColPivDecompositionHouseholderColumn_DDRM
-
Finds the column with the largest normal and makes that the first column
- swapDiag(double[]) - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
Exchanges the internal array of the diagonal elements for the provided one.
- swapDiag(double[]) - Method in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
- swapOff(double[]) - Method in class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
Exchanges the internal array of the off diagonal elements for the provided one.
- swapOff(double[]) - Method in class org.ejml.dense.row.decomposition.svd.implicitqr.SvdImplicitQrAlgorithm_DDRM
-
- swapRows(DMatrixRMaj, int, int) - Static method in class org.ejml.dense.row.misc.RrefGaussJordanRowPivot_DDRM
-
- SwitchingEigenDecomposition_DDRM - Class in org.ejml.dense.row.decomposition.eig
-
Checks to see what type of matrix is being decomposed and calls different eigenvalue decomposition
algorithms depending on the results.
- SwitchingEigenDecomposition_DDRM(int, boolean, double) - Constructor for class org.ejml.dense.row.decomposition.eig.SwitchingEigenDecomposition_DDRM
-
- SwitchingEigenDecomposition_DDRM(int) - Constructor for class org.ejml.dense.row.decomposition.eig.SwitchingEigenDecomposition_DDRM
-
- symm2x2_fast(double, double, double) - Method in class org.ejml.dense.row.decomposition.eig.EigenvalueSmall_F64
-
Compute the symmetric eigenvalue using a slightly safer technique
- symmetric(int, double, double, Random) - Static method in class org.ejml.dense.row.RandomMatrices_DDRM
-
Creates a random symmetric matrix whose values are selected from an uniform distribution
from min to max, inclusive.
- symmetric(DMatrixRMaj, double, double, Random) - Static method in class org.ejml.dense.row.RandomMatrices_DDRM
-
Sets the provided square matrix to be a random symmetric matrix whose values are selected from an uniform distribution
from min to max, inclusive.
- symmetricPosDef(int, Random) - Static method in class org.ejml.dense.row.RandomMatrices_DDRM
-
Creates a random symmetric positive definite matrix.
- SymmetricQrAlgorithm_DDRM - Class in org.ejml.dense.row.decomposition.eig.symm
-
Computes the eigenvalues and eigenvectors of a symmetric tridiagonal matrix using the symmetric QR algorithm.
- SymmetricQrAlgorithm_DDRM(SymmetricQREigenHelper_DDRM) - Constructor for class org.ejml.dense.row.decomposition.eig.symm.SymmetricQrAlgorithm_DDRM
-
- SymmetricQrAlgorithm_DDRM() - Constructor for class org.ejml.dense.row.decomposition.eig.symm.SymmetricQrAlgorithm_DDRM
-
Creates a new SymmetricQREigenvalue class that declares its own SymmetricQREigenHelper.
- SymmetricQRAlgorithmDecomposition_DDRM - Class in org.ejml.dense.row.decomposition.eig
-
Computes the eigenvalues and eigenvectors of a real symmetric matrix using the symmetric implicit QR algorithm.
- SymmetricQRAlgorithmDecomposition_DDRM(TridiagonalSimilarDecomposition_F64<DMatrixRMaj>, boolean) - Constructor for class org.ejml.dense.row.decomposition.eig.SymmetricQRAlgorithmDecomposition_DDRM
-
- SymmetricQRAlgorithmDecomposition_DDRM(boolean) - Constructor for class org.ejml.dense.row.decomposition.eig.SymmetricQRAlgorithmDecomposition_DDRM
-
- SymmetricQREigenHelper_DDRM - Class in org.ejml.dense.row.decomposition.eig.symm
-
A helper class for the symmetric matrix implicit QR algorithm for eigenvalue decomposition.
- SymmetricQREigenHelper_DDRM() - Constructor for class org.ejml.dense.row.decomposition.eig.symm.SymmetricQREigenHelper_DDRM
-
- symmetricWithEigenvalues(int, Random, double...) - Static method in class org.ejml.dense.row.RandomMatrices_DDRM
-
Creates a new random symmetric matrix that will have the specified real eigenvalues.
- symmPosDef(int) - Static method in class org.ejml.dense.row.factory.LinearSolverFactory_DDRM
-
Creates a solver for symmetric positive definite matrices.
- symmRankNMinus_L(int, DSubmatrixD1, DSubmatrixD1) - Static method in class org.ejml.dense.block.InnerRankUpdate_DDRB
-
Rank N update function for a symmetric inner submatrix and only operates on the lower
triangular portion of the submatrix.
A = A - B*BT
- symmRankNMinus_U(int, DSubmatrixD1, DSubmatrixD1) - Static method in class org.ejml.dense.block.InnerRankUpdate_DDRB
-
Rank N update function for a symmetric inner submatrix and only operates on the upper
triangular portion of the submatrix.
A = A - B TB
- symmRankTranA_sub(DMatrixRMaj, DMatrixRMaj, int) - Static method in class org.ejml.dense.row.decomposition.chol.CholeskyDecompositionBlock_DDRM
-
Performs this operation:
c = c - aTa
where c is a submatrix.