Index
All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form
G
- generalEquals(CTensor, DenseTensorBase<?, ?, ?, ?, ?>) - Static method in class org.flag4j.operations.common.TensorEquals
-
Checks if a real dense tensor is equal to any sparse tensor (including
CooMatrix
,CsrMatrix
,CooCMatrix
,CsrCMatrix
,CooVector
, etc.). - generalEquals(CTensor, SparseTensorBase<?, ?, ?, ?, ?, ?, ?>) - Static method in class org.flag4j.operations.common.TensorEquals
-
Checks if a complex dense tensor is equal to any sparse tensor (including
CooMatrix
,CsrMatrix
,CooCMatrix
,CsrCMatrix
,CooVector
, etc.). - generalEquals(Tensor, DenseTensorBase<?, ?, ?, ?, ?>) - Static method in class org.flag4j.operations.common.TensorEquals
- generalEquals(Tensor, SparseTensorBase<?, ?, ?, ?, ?, ?, ?>) - Static method in class org.flag4j.operations.common.TensorEquals
-
Checks if a real dense tensor is equal to any sparse tensor (including
CooMatrix
,CsrMatrix
,CooCMatrix
,CsrCMatrix
,CooVector
, etc.). - generalEquals(CooCTensor, SparseTensorBase<?, ?, ?, ?, ?, ?, ?>) - Static method in class org.flag4j.operations.common.TensorEquals
-
Checks if a real dense tensor is equal to any sparse tensor (including
CooMatrix
,CsrMatrix
,CooCMatrix
,CsrCMatrix
,CooVector
, etc.). - generalEquals(CooTensor, SparseTensorBase<?, ?, ?, ?, ?, ?, ?>) - Static method in class org.flag4j.operations.common.TensorEquals
-
Checks if a real dense tensor is equal to any sparse tensor (including
CooMatrix
,CsrMatrix
,CooCMatrix
,CsrCMatrix
,CooVector
, etc.). - generalEquals(DenseTensorBase<?, ?, ?, ?, ?>, SparseTensorBase<?, ?, ?, ?, ?, ?, ?>) - Static method in class org.flag4j.operations.common.TensorEquals
-
Checks if a dense tensor is equal to any sparse tensor (including
CooMatrix
,CsrMatrix
,CooCMatrix
,CsrCMatrix
,CooVector
, etc.). - generalEquals(TensorBase<?, ?, ?, ?, ?, ?, ?>, TensorBase<?, ?, ?, ?, ?, ?, ?>) - Static method in class org.flag4j.operations.common.TensorEquals
-
Checks if two arbitrary tensors are equal regardless implementation (e.g.
- genNormalComplexArray(int) - Method in class org.flag4j.rng.RandomArray
-
Generates an array of
complex numbers
with pseudorandom normally distributed magnitudes with a mean of 0.0 and a magnitude of 1.0. - genNormalComplexArray(int, double, double) - Method in class org.flag4j.rng.RandomArray
-
Generates an array of
complex numbers
with pseudorandom normally distributed magnitudes with specified mean and standard deviation. - genNormalRealArray(int) - Method in class org.flag4j.rng.RandomArray
-
Generates an array of doubles filled with normally pseudorandom values with a mean of 0 and standard deviation of 1.
- genNormalRealArray(int, double, double) - Method in class org.flag4j.rng.RandomArray
-
Generates an array of doubles filled with normally distributed pseudorandom values with a specified mean and standard deviation.
- genRandomRows(int, int, int, int) - Method in class org.flag4j.rng.RandomArray
-
Helper function to generate random row indices for use in
RandomArray.randomUniqueIndices2D(int, int, int, int, int)
. - genUniformComplexArray(int) - Method in class org.flag4j.rng.RandomArray
-
Generates an array of
complex numbers
with pseudorandom uniformly distributed magnitudes in[0.0, 1.0)
. - genUniformComplexArray(int, double, double) - Method in class org.flag4j.rng.RandomArray
-
Generates an array of pseudorandom
complex numbers
with uniformly distributed magnitudes in[min, max)
. - genUniformRealArray(int) - Method in class org.flag4j.rng.RandomArray
-
Generates an array of doubles filled with uniformly distributed pseudorandom values in
[0.0, 1.0)
. - genUniformRealArray(int, double, double) - Method in class org.flag4j.rng.RandomArray
-
Generates an array of doubles filled with uniformly distributed pseudorandom values in
[min, max)
. - genUniformRealIntArray(int) - Method in class org.flag4j.rng.RandomArray
-
Generates an array of integers filled with uniformly distributed pseudorandom int values in [
Integer.MAX_VALUE
,Integer.MAX_VALUE
). - genUniformRealIntArray(int, int, int) - Method in class org.flag4j.rng.RandomArray
-
Generates an array of integers filled with uniformly distributed pseudorandom values in
[min, max)
. - geRandomTrilMatrix(int, int, int) - Method in class org.flag4j.rng.RandomTensor
-
Gets a pseudorandom lower triangular matrix of the specified size.
- get(int) - Method in class org.flag4j.core.Shape
-
Get the size of the shape object in the specified dimension.
- get(int) - Static method in enum class org.flag4j.linalg.decompositions.lu.LU.Pivoting
-
Converts an ordinal to the corresponding pivot flag.
- get(int...) - Method in class org.flag4j.arrays.dense.CMatrix
- get(int...) - Method in class org.flag4j.arrays.dense.Matrix
- get(int...) - Method in class org.flag4j.arrays.sparse.CooCMatrix
-
Gets the element in this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.sparse.CooCTensor
-
Gets the element in this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.sparse.CooCVector
-
Gets the element in this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.sparse.CooMatrix
-
Gets the element in this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.sparse.CooTensor
-
Gets the element in this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.sparse.CooVector
-
Gets the element in this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.sparse.CsrCMatrix
-
Gets the element in this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.sparse.CsrMatrix
-
Gets the element in this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.core.dense_base.ComplexDenseTensorBase
-
Gets the element in this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.core.dense_base.RealDenseTensorBase
-
Gets the element in this tensor at the specified indices.
- get(int...) - Method in interface org.flag4j.core.MatrixMixin
-
Gets the element of this matrix at the specified indices.
- get(int...) - Method in interface org.flag4j.core.TensorOperationsMixin
-
Gets the element in this tensor at the specified indices.
- get(int, int) - Method in class org.flag4j.arrays.sparse.SymmTriDiagonal
-
Gets the entry within this symmetric tri-diagonal matrix at the specified indices.
- get2x2EigenValues(double, double, double, double) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvalues of a 2x2 matrix explicitly.
- get2x2EigenValues(CMatrix) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvalues of a 2x2 matrix explicitly.
- get2x2EigenValues(Matrix) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvalues of a 2x2 matrix explicitly.
- get2x2EigenValues(CNumber, CNumber, CNumber, CNumber) - Static method in class org.flag4j.linalg.Eigen
- get2x2Rotator(double, double) - Static method in class org.flag4j.linalg.transformations.Givens
-
Constructs a Givens rotator
G
of size 2 such that for a vectorv = [a, b]
we haveGv = [r, 0]
. - get2x2Rotator(CVector) - Static method in class org.flag4j.linalg.transformations.Givens
-
Constructs a Givens rotator
G
of size 2 such that for a vectorv = [a, b]
we haveGv = [r, 0]
. - get2x2Rotator(Vector) - Static method in class org.flag4j.linalg.transformations.Givens
-
Constructs a Givens rotator
G
of size 2 such that for a vectorv = [a, b]
we haveGv = [r, 0]
. - get2x2Rotator(CNumber, CNumber) - Static method in class org.flag4j.linalg.transformations.Givens
-
Constructs a Givens rotator
G
of size 2 such that for a vectorv = [a, b]
we haveGv = [r, 0]
. - getArrayLengthsMismatchErr(int...) - Static method in class org.flag4j.util.ErrorMessages
-
Gets an error message for arrays which were expected to be the same length.
- getAxisErr(int) - Static method in class org.flag4j.util.ErrorMessages
-
Gets an error message for a disallowed axis.
- getAxisErr(int, int...) - Static method in class org.flag4j.util.ErrorMessages
-
Gets an error message for a disallowed axis.
- getBlockSize() - Static method in class org.flag4j.concurrency.Configurations
-
Gets the current block size used in blocked algorithms.
- getCol(int) - Method in class org.flag4j.arrays.dense.CMatrix
-
Get the column of this matrix at the specified index.
- getCol(int) - Method in class org.flag4j.arrays.dense.Matrix
-
Get the column of this matrix at the specified index.
- getCol(int) - Method in class org.flag4j.arrays.sparse.CooCMatrix
-
Get the column of this matrix at the specified index.
- getCol(int) - Method in class org.flag4j.arrays.sparse.CooMatrix
-
Get the column of this matrix at the specified index.
- getCol(int) - Method in class org.flag4j.arrays.sparse.CsrCMatrix
-
Get the column of this matrix at the specified index.
- getCol(int) - Method in class org.flag4j.arrays.sparse.CsrMatrix
-
Get the column of this matrix at the specified index.
- getCol(int) - Method in interface org.flag4j.core.MatrixOperationsMixin
-
Get the column of this matrix at the specified index.
- getCol(int, int, int) - Method in class org.flag4j.arrays.dense.CMatrix
-
Gets a specified column of this matrix between
rowStart
(inclusive) androwEnd
(exclusive). - getCol(int, int, int) - Method in class org.flag4j.arrays.dense.Matrix
-
Gets a specified column of this matrix between
rowStart
(inclusive) androwEnd
(exclusive). - getCol(int, int, int) - Method in class org.flag4j.arrays.sparse.CooCMatrix
-
Gets a specified column of this matrix between
rowStart
(inclusive) androwEnd
(exclusive). - getCol(int, int, int) - Method in class org.flag4j.arrays.sparse.CooMatrix
-
Gets a specified column of this matrix between
rowStart
(inclusive) androwEnd
(exclusive). - getCol(int, int, int) - Method in class org.flag4j.arrays.sparse.CsrCMatrix
-
Gets a specified column of this matrix between
rowStart
(inclusive) androwEnd
(exclusive). - getCol(int, int, int) - Method in class org.flag4j.arrays.sparse.CsrMatrix
-
Gets a specified column of this matrix between
rowStart
(inclusive) androwEnd
(exclusive). - getCol(int, int, int) - Method in interface org.flag4j.core.MatrixOperationsMixin
-
Gets a specified column of this matrix between
rowStart
(inclusive) androwEnd
(exclusive). - getCol(CooCMatrix, int) - Static method in class org.flag4j.operations.sparse.coo.complex.ComplexSparseMatrixGetSet
-
Gets a specified column from this sparse matrix.
- getCol(CooCMatrix, int, int, int) - Static method in class org.flag4j.operations.sparse.coo.complex.ComplexSparseMatrixGetSet
-
Gets a specified column range from this sparse matrix.
- getCol(CooMatrix, int) - Static method in class org.flag4j.operations.sparse.coo.real.RealSparseMatrixGetSet
-
Gets a specified column from this sparse matrix.
- getCol(CooMatrix, int, int, int) - Static method in class org.flag4j.operations.sparse.coo.real.RealSparseMatrixGetSet
-
Gets a specified column range from this sparse matrix.
- getColAsVector(int) - Method in class org.flag4j.arrays.dense.CMatrix
-
Get the column of this matrix at the specified index.
- getColAsVector(int) - Method in class org.flag4j.arrays.dense.Matrix
-
Get the column of this matrix at the specified index.
- getColBelow(int, int) - Method in class org.flag4j.arrays.dense.CMatrix
-
Get a specified column of this matrix at and below a specified row.
- getColBelow(int, int) - Method in class org.flag4j.arrays.dense.Matrix
-
Get a specified column of this matrix at and below a specified row.
- getColBelow(int, int) - Method in class org.flag4j.arrays.sparse.CooCMatrix
-
Get a specified column of this matrix at and below a specified row.
- getColBelow(int, int) - Method in class org.flag4j.arrays.sparse.CooMatrix
-
Get a specified column of this matrix at and below a specified row.
- getColBelow(int, int) - Method in class org.flag4j.arrays.sparse.CsrCMatrix
-
Get a specified column of this matrix at and below a specified row.
- getColBelow(int, int) - Method in class org.flag4j.arrays.sparse.CsrMatrix
-
Get a specified column of this matrix at and below a specified row.
- getColBelow(int, int) - Method in interface org.flag4j.core.MatrixOperationsMixin
-
Get a specified column of this matrix at and below a specified row.
- getColSpace(CMatrix) - Static method in class org.flag4j.linalg.SubSpace
-
Computes an orthonormal basis of the column space of a specified matrix.
- getColSpace(Matrix) - Static method in class org.flag4j.linalg.SubSpace
-
Computes an orthonormal basis of the column space of a specified matrix.
- getContent() - Method in class org.flag4j.complex_numbers.CNumberLexer
-
Gets the content of this Lexer.
- getDet() - Method in class org.flag4j.linalg.solvers.exact.triangular.ComplexBackSolver
-
Gets the determinant computed during the last solve.
- getDet() - Method in class org.flag4j.linalg.solvers.exact.triangular.ComplexForwardSolver
-
Gets the determinant computed during the last solve.
- getDet() - Method in class org.flag4j.linalg.solvers.exact.triangular.RealBackSolver
-
Gets the determinant computed during the last solve.
- getDet() - Method in class org.flag4j.linalg.solvers.exact.triangular.RealForwardSolver
-
Gets the determinant computed during the last solve.
- getDetails() - Method in class org.flag4j.complex_numbers.CNumberToken
-
Gets the details of this token.
- getDiag() - Method in class org.flag4j.arrays.dense.CMatrix
-
Extracts the diagonal elements of this matrix and returns them as a vector.
- getDiag() - Method in class org.flag4j.arrays.dense.Matrix
-
Extracts the diagonal elements of this matrix and returns them as a vector.
- getDiag() - Method in class org.flag4j.arrays.sparse.CooCMatrix
-
Extracts the diagonal elements of this matrix and returns them as a vector.
- getDiag() - Method in class org.flag4j.arrays.sparse.CooMatrix
-
Extracts the diagonal elements of this matrix and returns them as a vector.
- getDiag() - Method in class org.flag4j.arrays.sparse.CsrCMatrix
-
Extracts the diagonal elements of this matrix and returns them as a vector.
- getDiag() - Method in class org.flag4j.arrays.sparse.CsrMatrix
-
Extracts the diagonal elements of this matrix and returns them as a vector.
- getDiag() - Method in interface org.flag4j.core.MatrixOperationsMixin
-
Extracts the diagonal elements of this matrix and returns them as a vector.
- getDims() - Method in class org.flag4j.core.Shape
-
Gets the shape of a tensor as an array.
- getEigenPairs(CMatrix) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvalues and eigenvectors of a square real matrix.
- getEigenPairs(Matrix) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvalues and eigenvectors of a square real matrix.
- getEigenValues(CMatrix) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvalues of a square complex dense matrix.
- getEigenValues(CMatrix, long) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvalues of a square complex dense matrix.
- getEigenValues(CMatrix, long, int) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvalues of a square complex dense matrix.
- getEigenValues(CMatrix, ComplexSchur) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvalues of a square complex dense matrix.
- getEigenValues(Matrix) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvalues of a square real dense matrix.
- getEigenValues(Matrix, long) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvalues of a square real dense matrix.
- getEigenValues(Matrix, long, int) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvalues of a square real dense matrix.
- getEigenValues(Matrix, RealSchur) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvalues of a real dense square matrix.
- getEigenVectors(CMatrix) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvectors of a square real dense matrix.
- getEigenVectors(CMatrix, long) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvectors of a square real dense matrix.
- getEigenVectors(CMatrix, long, int) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvectors of a square real dense matrix.
- getEigenVectors(CMatrix, ComplexSchur) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvectors of a square complex dense matrix.
- getEigenVectors(Matrix) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvectors of a square real dense matrix.
- getEigenVectors(Matrix, long) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvectors of a square real dense matrix.
- getEigenVectors(Matrix, long, int) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvectors of a square real dense matrix.
- getEigenVectors(Matrix, RealSchur) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvectors of a square real dense matrix.
- getEigenVectorsTriu(CMatrix) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvectors of an upper triangular matrix.
- getEigenVectorsTriu(Matrix) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvectors of an upper triangular matrix.
- getEmpty(int) - Static method in class org.flag4j.arrays.dense.CVector
-
Constructs an empty complex dense vector whose entries are
null
. - getEmpty(int, int) - Static method in class org.flag4j.arrays.dense.CMatrix
-
Constructs an empty complex dense matrix.
- getEntries() - Method in class org.flag4j.core.TensorBase
-
Gets the entries of this tensor as a 1D array.
- getGeneralRotator(int, int, int, double) - Static method in class org.flag4j.linalg.transformations.Givens
-
Constructs a general Givens rotation matrix.
- getGreaterEqErr(double, double) - Static method in class org.flag4j.util.ErrorMessages
-
Gets an error message for a value which was expected to be greater than of equal to a specified threshold but wasn't.
- getH() - Method in class org.flag4j.linalg.decompositions.hess.ComplexHess
-
Gets the upper Hessenburg matrix
H
from the Hessenburg decomposition. - getH() - Method in class org.flag4j.linalg.decompositions.hess.RealHess
-
Gets the upper Hessenburg matrix
H
from the Hessenburg decomposition. - getH() - Method in class org.flag4j.linalg.decompositions.hess.SymmHess
-
Gets the Hessenberg matrix from the decomposition.
- getIndices(int) - Method in class org.flag4j.core.Shape
-
Computes the nD tensor indices based on an index from the internal 1D data array.
- getIndicesRankErr(int, int) - Static method in class org.flag4j.util.ErrorMessages
-
Gets an error message for a tensor being indexed with a number of indices not equal to the rank of the tensor.
- getInstance() - Static method in class org.flag4j.operations.RealDenseMatrixMultiplyDispatcher
-
Gets the singleton instance of this class.
- getInvShape(Shape, int) - Static method in class org.flag4j.linalg.TensorInvert
-
Computes the shape of the 'inverse' tensor given the original shape and the number of indices.
- getKind() - Method in class org.flag4j.complex_numbers.CNumberToken
-
Gets the kind of this token.
- getL() - Method in class org.flag4j.linalg.decompositions.chol.Cholesky
-
Gets the
L
matrix computed by the Cholesky decompositionA=LL<sup>*</sup>
. - getL() - Method in class org.flag4j.linalg.decompositions.lu.ComplexLU
-
Gets the unit lower triangular matrix of the decomposition.
- getL() - Method in class org.flag4j.linalg.decompositions.lu.LU
-
Gets the unit lower triangular matrix of the decomposition.
- getL() - Method in class org.flag4j.linalg.decompositions.lu.RealLU
-
Gets the unit lower triangular matrix of the decomposition.
- getLeftNullSpace(CMatrix) - Static method in class org.flag4j.linalg.SubSpace
-
Computes an orthonormal basis of the left null space of a specified matrix.
- getLeftNullSpace(Matrix) - Static method in class org.flag4j.linalg.SubSpace
-
Computes an orthonormal basis of the left null space of a specified matrix.
- getLessEqErr(double, double) - Static method in class org.flag4j.util.ErrorMessages
-
Gets an error message for a value which was expected to be less than of equal to a specified threshold but wasn't.
- getLH() - Method in class org.flag4j.linalg.decompositions.chol.Cholesky
-
Gets the
L
matrix computed by the Cholesky decompositionA=LL<sup>*</sup>
. - getLU() - Method in class org.flag4j.linalg.decompositions.lu.LU
-
Gets the
L
andU
matrices of the decomposition combined in a single matrix. - getMaxColumns() - Static method in class org.flag4j.io.PrintOptions
-
Gets the current maximum number of columns to print.
- getMaxRows() - Static method in class org.flag4j.io.PrintOptions
-
Gets the maximum number of rows to print.
- getNamedGreaterEqErr(double, double, String) - Static method in class org.flag4j.util.ErrorMessages
-
Gets an error message for a value which was expected to be greater than of equal to a specified threshold but wasn't.
- getNamedLessEqErr(double, double, String) - Static method in class org.flag4j.util.ErrorMessages
-
Gets an error message for a value which was expected to be less than of equal to a specified threshold but wasn't.
- getNamedLessEqErr(BigInteger, double, String) - Static method in class org.flag4j.util.ErrorMessages
-
Gets an error message for a value which was expected to be less than of equal to a specified threshold but wasn't.
- getNegValueErr(double) - Static method in class org.flag4j.util.ErrorMessages
-
Gets an error message for a negative value when a non-negative was expected.
- getNextIndices(int[], int) - Method in class org.flag4j.core.Shape
-
Gets the next indices for a tensor with this shape.
- getNextSymbol() - Method in class org.flag4j.complex_numbers.CNumberLexer
-
Produces individual symbols from content, left to right, as ascii values.
- getNextToken() - Method in class org.flag4j.complex_numbers.CNumberLexer
-
Produces next
CNumberToken
from complex number string. - getNonPosErr(double) - Static method in class org.flag4j.util.ErrorMessages
-
Gets an error message for a non-positive value when a positive, non-zero value was expected.
- getNullSpace(CMatrix) - Static method in class org.flag4j.linalg.SubSpace
-
Computes an orthonormal basis of the null space of a specified matrix.
- getNullSpace(Matrix) - Static method in class org.flag4j.linalg.SubSpace
-
Computes an orthonormal basis of the null space of a specified matrix.
- getNumColSwaps() - Method in class org.flag4j.linalg.decompositions.lu.LU
-
Gets the number of column swaps used in the last decomposition.
- getNumRowSwaps() - Method in class org.flag4j.linalg.decompositions.lu.LU
-
Gets the number of row swaps used in the last decomposition.
- getNumThreads() - Static method in class org.flag4j.concurrency.Configurations
-
Gets the current number of threads to be used.
- getOrthogonal(double, double, double, double) - Static method in class org.flag4j.linalg.transformations.Projection
-
Creates a
4x4
orthogonal projection matrix to project a 3D point in homogeneous coordinates onto the specified 2D coordinate grid (i.e. - getOrthogonal(double, double, double, double, double, double) - Static method in class org.flag4j.linalg.transformations.Projection
-
Creates a
4x4
orthogonal projection matrix to project a 3D point in homogeneous coordinates onto the specified 2D coordinate grid (i.e. - getOrthogonal2D(double, double) - Static method in class org.flag4j.linalg.transformations.Projection
-
Creates a
4x4
orthogonal projection matrix to project a 2D point in an orthographic viewing region. - getOrthogonal2D(double, double, double, double) - Static method in class org.flag4j.linalg.transformations.Projection
-
Creates a
4x4
orthogonal projection matrix to project a 2D point in an orthographic viewing region. - getOutputShape(T, T, int) - Method in class org.flag4j.linalg.solvers.exact.ExactTensorSolver
-
Constructs the shape of the output.
- getP() - Method in class org.flag4j.linalg.decompositions.lu.LU
-
Gets the row permutation matrix of the decomposition.
- getPadding() - Static method in class org.flag4j.io.PrintOptions
-
Gets the current padding amount for columns.
- getParallelismLevel() - Static method in class org.flag4j.concurrency.ThreadManager
-
Gets the current parallelism level for the ThreadManager.
- getPerspective(double, double, double, double) - Static method in class org.flag4j.linalg.transformations.Projection
-
Creates a
4x4
perspective projection matrix to transform a 3D point represented in homogeneous coordinates. - getPerspective(double, double, double, double, double) - Static method in class org.flag4j.linalg.transformations.Projection
-
Creates a
4x4
perspective projection matrix to transform a 3D point represented in homogeneous coordinates. - getPrecision() - Static method in class org.flag4j.io.PrintOptions
-
Gets the current printing precision.
- getProduct(int[], int) - Static method in class org.flag4j.linalg.TensorInvert
-
Computes the total number of entries in the last
numIndices
dimensions of a tensor with dimensions specified bydims
. - getQ() - Method in class org.flag4j.linalg.decompositions.lu.LU
-
Gets the column permutation matrix of the decomposition.
- getQ() - Method in class org.flag4j.linalg.decompositions.unitary.ComplexUnitaryDecomposition
-
Gets the unitary
Q
matrix from theQR
decomposition. - getQ() - Method in class org.flag4j.linalg.decompositions.unitary.RealUnitaryDecomposition
-
Gets the unitary
Q
matrix from the unitary decomposition. - getQ() - Method in class org.flag4j.linalg.decompositions.unitary.UnitaryDecomposition
-
Gets the unitary
Q
matrix from the decomposition. - getR() - Method in class org.flag4j.linalg.decompositions.qr.ComplexQR
-
Gets the upper triangular matrix
R
from theQR
decomposition. - getR() - Method in class org.flag4j.linalg.decompositions.qr.RealQR
-
Gets the upper triangular matrix
R
from theQR
decomposition. - getRangeErr(double, double, double, String) - Static method in class org.flag4j.util.ErrorMessages
-
Gets an error message for a value which is not within the expected range.
- getRank() - Method in class org.flag4j.core.Shape
-
Gets the rank of a tensor with this shape.
- getRank() - Method in class org.flag4j.core.TensorBase
-
Gets the rank of this tensor.
- getRank() - Method in interface org.flag4j.core.TensorExclusiveMixin
-
Gets the rank of this tensor.
- getRank() - Method in class org.flag4j.linalg.decompositions.svd.SVD
-
Gets the rank of the last matrix decomposed.
- getRatio(Shape) - Static method in class org.flag4j.operations.MatrixMultiplyDispatcher
-
Computes the squareness ratio of a matrix.
- getRatio(Shape) - Static method in class org.flag4j.operations.RealDenseMatrixMultiplyDispatcher
-
Computes the squareness ratio of a matrix.
- getReflector(CVector) - Static method in class org.flag4j.linalg.transformations.Householder
-
Computes the Householder reflector which describes a reflection through a hyperplane containing the origin which is normal to the specified
normal
vector. - getReflector(Vector) - Static method in class org.flag4j.linalg.transformations.Householder
-
Computes the Householder reflector which describes a reflection through a hyperplane containing the origin which is normal to the specified
normal
vector. - getRotator(double[], int) - Static method in class org.flag4j.linalg.transformations.Givens
-
Constructs a Givens rotator
G
such that for a vectorv
,Gv = [r<sub>1</sub> ... r<sub>i</sub> ... r<sub>n</sub>]
where ri=0. - getRotator(CVector, int) - Static method in class org.flag4j.linalg.transformations.Givens
-
Constructs a Givens rotator
G
such that for a vectorv
,Gv = [r<sub>1</sub> ... r<sub>i</sub> ... r<sub>n</sub>]
where ri=0. - getRotator(Vector, int) - Static method in class org.flag4j.linalg.transformations.Givens
-
Constructs a Givens rotator
G
such that for a vectorv
,Gv = [r<sub>1</sub> ... r<sub>i</sub> ... r<sub>n</sub>]
where ri=0. - getRow(int) - Method in class org.flag4j.arrays.dense.CMatrix
-
Get the row of this matrix at the specified index.
- getRow(int) - Method in class org.flag4j.arrays.dense.Matrix
-
Get the row of this matrix at the specified index.
- getRow(int) - Method in class org.flag4j.arrays.sparse.CooCMatrix
-
Get the row of this matrix at the specified index.
- getRow(int) - Method in class org.flag4j.arrays.sparse.CooMatrix
-
Get the row of this matrix at the specified index.
- getRow(int) - Method in class org.flag4j.arrays.sparse.CsrCMatrix
-
Get the row of this matrix at the specified index.
- getRow(int) - Method in class org.flag4j.arrays.sparse.CsrMatrix
-
Get the row of this matrix at the specified index.
- getRow(int) - Method in interface org.flag4j.core.MatrixOperationsMixin
-
Get the row of this matrix at the specified index.
- getRow(CooCMatrix, int) - Static method in class org.flag4j.operations.sparse.coo.complex.ComplexSparseMatrixGetSet
-
Gets a specified row from this sparse matrix.
- getRow(CooCMatrix, int, int, int) - Static method in class org.flag4j.operations.sparse.coo.complex.ComplexSparseMatrixGetSet
-
Gets a specified row range from this sparse matrix.
- getRow(CooMatrix, int) - Static method in class org.flag4j.operations.sparse.coo.real.RealSparseMatrixGetSet
-
Gets a specified row from this sparse matrix.
- getRow(CooMatrix, int, int, int) - Static method in class org.flag4j.operations.sparse.coo.real.RealSparseMatrixGetSet
-
Gets a specified row range from this sparse matrix.
- getRowAfter(int, int) - Method in class org.flag4j.arrays.dense.CMatrix
-
Get a specified row of this matrix at and after a specified column.
- getRowAfter(int, int) - Method in class org.flag4j.arrays.dense.Matrix
-
Get a specified row of this matrix at and after a specified column.
- getRowAfter(int, int) - Method in class org.flag4j.arrays.sparse.CooCMatrix
-
Get a specified row of this matrix at and after a specified column.
- getRowAfter(int, int) - Method in class org.flag4j.arrays.sparse.CooMatrix
-
Get a specified row of this matrix at and after a specified column.
- getRowAfter(int, int) - Method in class org.flag4j.arrays.sparse.CsrCMatrix
-
Get a specified row of this matrix at and after a specified column.
- getRowAfter(int, int) - Method in class org.flag4j.arrays.sparse.CsrMatrix
-
Get a specified row of this matrix at and after a specified column.
- getRowAfter(int, int) - Method in interface org.flag4j.core.MatrixOperationsMixin
-
Get a specified row of this matrix at and after a specified column.
- getRowAsVector(int) - Method in class org.flag4j.arrays.dense.CMatrix
-
Get the row of this matrix at the specified index.
- getRowAsVector(int) - Method in class org.flag4j.arrays.dense.Matrix
-
Get the row of this matrix at the specified index.
- getRowSpace(CMatrix) - Static method in class org.flag4j.linalg.SubSpace
-
Computes an orthonormal basis of the row space of a specified matrix.
- getRowSpace(Matrix) - Static method in class org.flag4j.linalg.SubSpace
-
Computes an orthonormal basis of the row space of a specified matrix.
- getS() - Method in class org.flag4j.linalg.decompositions.svd.SVD
-
Gets the diagonal matrix
S
corresponding toM=USV
H in the SVD. - getSelf() - Method in class org.flag4j.arrays.dense.CMatrix
-
Simply returns a reference of this tensor.
- getSelf() - Method in class org.flag4j.arrays.dense.CTensor
-
Simply returns a reference of this tensor.
- getSelf() - Method in class org.flag4j.arrays.dense.CVector
-
Simply returns a reference of this tensor.
- getSelf() - Method in class org.flag4j.arrays.dense.Matrix
-
Simply returns this tensor.
- getSelf() - Method in class org.flag4j.arrays.dense.Tensor
-
Simply returns this tensor.
- getSelf() - Method in class org.flag4j.arrays.dense.Vector
-
Simply returns this tensor.
- getSelf() - Method in class org.flag4j.arrays.sparse.CooCMatrix
-
Simply returns a reference of this tensor.
- getSelf() - Method in class org.flag4j.arrays.sparse.CooCTensor
-
Simply returns a reference of this tensor.
- getSelf() - Method in class org.flag4j.arrays.sparse.CooCVector
-
Simply returns a reference of this tensor.
- getSelf() - Method in class org.flag4j.arrays.sparse.CooMatrix
-
Simply returns a reference of this tensor.
- getSelf() - Method in class org.flag4j.arrays.sparse.CooTensor
-
Simply returns a reference of this tensor.
- getSelf() - Method in class org.flag4j.arrays.sparse.CooVector
-
Simply returns a reference of this tensor.
- getSelf() - Method in class org.flag4j.arrays.sparse.CsrCMatrix
-
Simply returns a reference of this tensor.
- getSelf() - Method in class org.flag4j.arrays.sparse.CsrMatrix
-
Simply returns a reference of this tensor.
- getSelf() - Method in class org.flag4j.core.TensorBase
-
Simply returns a reference of this tensor.
- getShape() - Method in class org.flag4j.core.TensorBase
-
Gets the shape of this tensor.
- getShapeBroadcastErr(Shape, Shape) - Static method in class org.flag4j.util.ErrorMessages
-
Gets an error message for two shapes which cannot be broadcast together.
- getSlice(int, int, int, int) - Method in class org.flag4j.arrays.dense.CMatrix
-
Gets a specified slice of this matrix.
- getSlice(int, int, int, int) - Method in class org.flag4j.arrays.dense.Matrix
-
Gets a specified slice of this matrix.
- getSlice(int, int, int, int) - Method in class org.flag4j.arrays.sparse.CooCMatrix
-
Gets a specified slice of this matrix.
- getSlice(int, int, int, int) - Method in class org.flag4j.arrays.sparse.CooMatrix
-
Gets a specified slice of this matrix.
- getSlice(int, int, int, int) - Method in class org.flag4j.arrays.sparse.CsrCMatrix
-
Gets a specified slice of this matrix.
- getSlice(int, int, int, int) - Method in class org.flag4j.arrays.sparse.CsrMatrix
-
Gets a specified slice of this matrix.
- getSlice(int, int, int, int) - Method in interface org.flag4j.core.MatrixOperationsMixin
-
Gets a specified slice of this matrix.
- getSlice(CooCMatrix, int, int, int, int) - Static method in class org.flag4j.operations.sparse.coo.complex.ComplexSparseMatrixGetSet
-
Gets a specified rectangular slice of a sparse matrix.
- getSlice(CooMatrix, int, int, int, int) - Static method in class org.flag4j.operations.sparse.coo.real.RealSparseMatrixGetSet
-
Gets a specified rectangular slice of a sparse matrix.
- getSlice(CsrCMatrix, int, int, int, int) - Static method in class org.flag4j.operations.sparse.csr.complex.ComplexCsrOperations
-
Gets a specified slice of a CSR matrix.
- getSlice(CsrMatrix, int, int, int, int) - Static method in class org.flag4j.operations.sparse.csr.real.RealCsrOperations
-
Gets a specified slice of a CSR matrix.
- getSquareShapeErr(Shape) - Static method in class org.flag4j.util.ErrorMessages
-
Gets an error message for a shape which was expected to be square but was not
- getStrides() - Method in class org.flag4j.core.Shape
-
Gets the shape of a tensor as an array.
- getT() - Method in class org.flag4j.linalg.decompositions.schur.Schur
-
Gets the upper, or possibly block-upper, triangular Schur matrix
T
from the Schur decomposition - getTotalEntriesErr() - Static method in class org.flag4j.util.ErrorMessages
-
Gets an error message for arrays which do not have the same total number of entries.
- getU() - Method in class org.flag4j.linalg.decompositions.lu.ComplexLU
-
Gets the upper triangular matrix of the decomposition.
- getU() - Method in class org.flag4j.linalg.decompositions.lu.LU
-
Gets the upper triangular matrix of the decomposition.
- getU() - Method in class org.flag4j.linalg.decompositions.lu.RealLU
-
Gets the upper triangular matrix of the decomposition.
- getU() - Method in class org.flag4j.linalg.decompositions.schur.Schur
-
Gets the unitary matrix
U
from the Schur decomposition containing the Schur vectors as its columns. - getU() - Method in class org.flag4j.linalg.decompositions.svd.SVD
-
Gets the unitary matrix
U
corresponding toM=USV
H in the SVD. - getUpper() - Method in class org.flag4j.linalg.decompositions.hess.ComplexHess
-
Gets the upper Hessenburg matrix from the last decomposition.
- getUpper() - Method in class org.flag4j.linalg.decompositions.hess.RealHess
-
Gets the upper Hessenburg matrix from the last decomposition.
- getUpper() - Method in class org.flag4j.linalg.decompositions.qr.ComplexQR
-
Gets the upper triangular matrix
R
from the last decomposition. - getUpper() - Method in class org.flag4j.linalg.decompositions.qr.RealQR
-
Gets the upper triangular matrix
R
from the last decomposition. - getUpper() - Method in class org.flag4j.linalg.decompositions.unitary.UnitaryDecomposition
-
Gets the upper triangular/Hessenburg matrix from the last decomposition.
- getUpper(CMatrix) - Method in class org.flag4j.linalg.decompositions.unitary.ComplexUnitaryDecomposition
-
Gets the upper triangular/Hessenburg matrix from the last decomposition.
- getUpper(Matrix) - Method in class org.flag4j.linalg.decompositions.unitary.RealUnitaryDecomposition
-
Gets the upper triangular/Hessenburg matrix from the last decomposition.
- getUpper(T) - Method in class org.flag4j.linalg.decompositions.unitary.UnitaryDecomposition
-
Gets the upper triangular/Hessenburg matrix from the last decomposition.
- getUtilityClassErrMsg() - Static method in class org.flag4j.util.ErrorMessages
-
Gets an error message for an attempted instantiation of a utility class.
- getV() - Method in class org.flag4j.linalg.decompositions.svd.SVD
-
Gets the unitary matrix
V
corresponding toM=USV
H in the SVD. - getVector(Vector) - Static method in class org.flag4j.linalg.transformations.Householder
-
Computes the vector
v
in of a Householder matrixH=I-2vv
T whereH
is a transformation matrix which reflects a vector across the plane normal tonormal
. - Givens - Class in org.flag4j.linalg.transformations
-
This class contains methods for computing real or complex Givens' rotation matrices.
- Givens() - Constructor for class org.flag4j.linalg.transformations.Givens
- GREATER_EQ_ERR - Static variable in class org.flag4j.util.ErrorMessages
-
Error message for parameters which are expected to be greater than or equal to some threshold.
All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form