Index
All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form
G
- genNormalComplex128Array(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. - genNormalComplex128Array(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. - genNormalComplex64Array(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. - genNormalComplex64Array(int, float, float) - 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)
. - genUniformComplex128Array(int) - Method in class org.flag4j.rng.RandomArray
-
Generates an array of
complex numbers
with pseudorandom uniformly distributed magnitudes in[0.0, 1.0)
. - genUniformComplex128Array(int, double, double) - Method in class org.flag4j.rng.RandomArray
-
Generates an array of pseudorandom
complex numbers
with uniformly distributed magnitudes in[min, max)
. - genUniformComplex64Array(int) - Method in class org.flag4j.rng.RandomArray
-
Generates an array of
complex numbers
with pseudorandom uniformly distributed magnitudes in[0.0, 1.0)
. - genUniformComplex64Array(int, float, float) - 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.RandomDenseTensor
-
Gets a pseudorandom lower triangular matrix of the specified size.
- get(int) - Method in class org.flag4j.arrays.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.backend.field.AbstractDenseFieldTensor
-
Gets the element of this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.backend.ring.AbstractDenseRingTensor
-
Gets the element of this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringMatrix
-
Gets the element of this tensor at the specified index.
- get(int...) - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringTensor
-
Gets the element of this tensor at the specified target.
- get(int...) - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringVector
-
Gets the element of this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.backend.semiring.AbstractDenseSemiringTensor
-
Gets the element of this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.backend.semiring.CsrSemiRingMatrixBase
-
Gets the element of this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.backend.AbstractTensor
-
Gets the element of this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.backend.CooFieldMatrixBase
-
Gets the element of this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.backend.CooFieldTensorBase
-
Gets the element of this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.backend.CooFieldVectorBase
-
Gets the element of this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.backend.FieldTensorBase
-
Gets the element of this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.backend.PrimitiveDoubleTensorBase
-
Gets the element of this tensor at the specified indices.
- get(int...) - Method in interface org.flag4j.arrays.backend.TensorMixin
-
Gets the element of this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.sparse.CooMatrix
-
Gets the element of this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.sparse.CooTensor
-
Gets the element of this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.sparse.CooVector
-
Gets the element of this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.sparse.CsrCMatrix
-
Gets the element of this tensor at the specified indices.
- get(int...) - Method in class org.flag4j.arrays.sparse.CsrMatrix
-
Gets the element of this tensor at the specified indices.
- get(int, int) - Method in class org.flag4j.arrays.sparse.SymmTriDiag
-
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(Field<Complex128>, Field<Complex128>, Field<Complex128>, Field<Complex128>) - Static method in class org.flag4j.linalg.Eigen
-
Computes the eigenvalues of a 2-by-2 complex matrix (assumed to be row major).
- 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.
- get2x2Rotator(double, double) - Static method in class org.flag4j.linalg.transformations.Givens
-
Constructs a Givens rotator G of size 2 such that for a vector v = [a, b] nwe have Gv = [r, 0].
- get2x2Rotator(Complex128, Complex128) - Static method in class org.flag4j.linalg.transformations.Givens
-
Constructs a Givens rotator G of size 2 such that for a vector v = [a, b] we have Gv = [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 vector v = [a, b] we have Gv = [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 vector v = [a, b] we have Gv = [r, 0].
- getArrayLengthsMismatchErr(int...) - Static method in class org.flag4j.util.ErrorMessages
-
Gets an error message for arrays_old 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.backend.CooFieldMatrixBase
-
Get the column of this matrix at the specified index.
- getCol(int) - Method in class org.flag4j.arrays.backend.DenseFieldMatrixBase
-
Get the column of this matrix at the specified index.
- getCol(int) - Method in interface org.flag4j.arrays.backend.MatrixVectorOpsMixin
-
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.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.CsrFieldMatrix
-
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, int, int) - Method in class org.flag4j.arrays.backend.CooFieldMatrixBase
-
Gets a specified column of this matrix between
rowStart
(inclusive) androwEnd
(exclusive). - getCol(int, int, int) - Method in class org.flag4j.arrays.backend.DenseFieldMatrixBase
-
Gets a specified column of this matrix between
rowStart
(inclusive) androwEnd
(exclusive). - getCol(int, int, int) - Method in interface org.flag4j.arrays.backend.MatrixVectorOpsMixin
-
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.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.CsrFieldMatrix
-
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(CooFieldMatrixBase<?, ?, ?, ?, T>, int) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatrixGetSet
-
Gets a specified column from this sparse matrix.
- getCol(CooFieldMatrixBase<?, ?, ?, ?, T>, int, int, int) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatrixGetSet
-
Gets a specified column range from this sparse matrix.
- getCol(CooMatrix, int) - Static method in class org.flag4j.linalg.ops.sparse.coo.real.RealSparseMatrixGetSet
-
Gets a specified column from this sparse matrix.
- getCol(CooMatrix, int, int, int) - Static method in class org.flag4j.linalg.ops.sparse.coo.real.RealSparseMatrixGetSet
-
Gets a specified column range from this sparse matrix.
- 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.
- getComponents(String) - Static method in class org.flag4j.io.parsing.ComplexNumberParser
-
Parses a complex number in the form of a string into its real and imaginary parts.
- getContent() - Method in class org.flag4j.io.parsing.ComplexNumberLexer
-
Gets the content of this Lexer.
- getCoo(double[], int[][], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.CooGetSet
-
Gets an element of a sparse COO tensor at the specified index.
- getCoo(float[], int[][], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.CooGetSet
-
Gets an element of a sparse COO tensor at the specified index.
- getCoo(int[], int[][], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.CooGetSet
-
Gets an element of a sparse COO tensor at the specified index.
- getCoo(T[], int[][], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.CooGetSet
-
Gets an element of a sparse COO tensor at the specified index.
- getCoo(V[], int[], int) - Static method in class org.flag4j.linalg.ops.sparse.coo.CooGetSet
-
Gets the specified element from a sparse COO vector.
- getCoo(V[], int[], int[], int, int) - Static method in class org.flag4j.linalg.ops.sparse.coo.CooGetSet
-
Gets the specified element from a sparse COO matrix.
- 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.io.parsing.ComplexNumberToken
-
Gets the details of this token.
- getDiag() - Method in class org.flag4j.arrays.backend.CooFieldMatrixBase
-
Extracts the diagonal elements of this matrix and returns them as a vector.
- getDiag() - Method in class org.flag4j.arrays.backend.DenseFieldMatrixBase
-
Extracts the diagonal elements of this matrix and returns them as a vector.
- getDiag() - Method in interface org.flag4j.arrays.backend.MatrixVectorOpsMixin
-
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.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.CsrFieldMatrix
-
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.
- getDims() - Method in class org.flag4j.arrays.Shape
-
Gets the shape of a tensor as an array of dimensions.
- 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 vector with the specified
size
. - getEmpty(int, int) - Static method in class org.flag4j.arrays.dense.CMatrix
-
Constructs an empty complex matrix with the specified shape.
- getEntries() - Method in interface org.flag4j.arrays.backend.semiring.TensorOverSemiRing
-
Gets the entries of this tensor.
- getEntries() - Method in class org.flag4j.arrays.backend.AbstractTensor
-
Gets the entry data of this tensor as a 1D array.
- getEntries() - Method in interface org.flag4j.arrays.backend.TensorMixin
-
Gets the entries of this tensor.
- 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.HermHess
-
Gets the Hessenberg matrix from the 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.arrays.Shape
-
Efficiently 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.linalg.ops.dense.field_ops.DenseFieldMatMultDispatcher
-
Gets the singleton instance of this class.
- getInstance() - Static method in class org.flag4j.linalg.ops.dense.semiring_ops.DenseSemiRingMatMultDispatcher
-
Gets the singleton instance of this class.
- getInstance() - Static method in class org.flag4j.linalg.ops.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.io.parsing.ComplexNumberToken
-
Gets the kind of this token.
- getL() - Method in class org.flag4j.linalg.decompositions.chol.Cholesky
-
Gets the L matrix computed by the Cholesky decomposition A=LLH.
- 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.FieldLU
-
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 LH matrix computed by the Cholesky decomposition A=LLH.
- 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.arrays.Shape
-
Gets the next indices for a tensor with this shape.
- getNextSymbol() - Method in class org.flag4j.io.parsing.ComplexNumberLexer
-
Produces individual symbols from content, left to right, as ascii values.
- getNextToken() - Method in class org.flag4j.io.parsing.ComplexNumberLexer
-
Produces next
ComplexNumberToken
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.
- getOne() - Method in class org.flag4j.algebraic_structures.fields.Complex128
-
Gets the multiplicative identity for this semi-ring.
- getOne() - Method in class org.flag4j.algebraic_structures.fields.Complex64
-
Gets the multiplicative identity for this semi-ring.
- getOne() - Method in class org.flag4j.algebraic_structures.fields.RealFloat32
-
Gets the multiplicative identity for this semi-ring.
- getOne() - Method in class org.flag4j.algebraic_structures.fields.RealFloat64
-
Gets the multiplicative identity for this semi-ring.
- getOne() - Method in class org.flag4j.algebraic_structures.rings.RealInt16
-
Gets the multiplicative identity for this semi-ring.
- getOne() - Method in class org.flag4j.algebraic_structures.rings.RealInt32
-
Gets the multiplicitive identity for this semi-ring.
- getOne() - Method in class org.flag4j.algebraic_structures.semirings.BooleanRing
-
Gets the multiplicitive identity for this semi-ring.
- getOne() - Method in interface org.flag4j.algebraic_structures.semirings.Semiring
-
Gets the multiplicative identity for this semi-ring.
- 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 interface org.flag4j.arrays.backend.semiring.TensorOverSemiRing
-
Gets the rank of this tensor.
- getRank() - Method in class org.flag4j.arrays.backend.AbstractTensor
-
Gets the rank of this tensor.
- getRank() - Method in interface org.flag4j.arrays.backend.TensorMixin
-
Gets the rank of this tensor.
- getRank() - Method in class org.flag4j.arrays.Shape
-
Gets the rank of a tensor with this shape.
- 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.linalg.ops.dense.field_ops.DenseFieldMatMultDispatcher
-
Computes the squareness ratio of a matrix.
- getRatio(Shape) - Static method in class org.flag4j.linalg.ops.dense.semiring_ops.DenseSemiRingMatMultDispatcher
-
Computes the squareness ratio of a matrix.
- getRatio(Shape) - Static method in class org.flag4j.linalg.ops.MatrixMultiplyDispatcher
-
Computes the squareness ratio of a matrix.
- getRatio(Shape) - Static method in class org.flag4j.linalg.ops.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 vector v, Gv = [r1 ...
- getRotator(CVector, int) - Static method in class org.flag4j.linalg.transformations.Givens
-
Constructs a Givens rotator G such that for a vector v, Gv = [r1 ...
- getRotator(Vector, int) - Static method in class org.flag4j.linalg.transformations.Givens
-
Constructs a Givens rotator G such that for a vector v, Gv = [r1 ...
- getRow(int) - Method in class org.flag4j.arrays.backend.CooFieldMatrixBase
-
Get the row of this matrix at the specified index.
- getRow(int) - Method in class org.flag4j.arrays.backend.DenseFieldMatrixBase
-
Get the row of this matrix at the specified index.
- getRow(int) - Method in interface org.flag4j.arrays.backend.MatrixVectorOpsMixin
-
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.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.CsrFieldMatrix
-
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, int, int) - Method in class org.flag4j.arrays.backend.CooFieldMatrixBase
-
Gets a specified row of this matrix between
colStart
(inclusive) andcolEnd
(exclusive). - getRow(int, int, int) - Method in class org.flag4j.arrays.backend.DenseFieldMatrixBase
-
Gets a specified row of this matrix between
colStart
(inclusive) andcolEnd
(exclusive). - getRow(int, int, int) - Method in interface org.flag4j.arrays.backend.MatrixVectorOpsMixin
-
Gets a specified row of this matrix between
colStart
(inclusive) andcolEnd
(exclusive). - getRow(int, int, int) - Method in class org.flag4j.arrays.dense.Matrix
-
Gets a specified row of this matrix between
colStart
(inclusive) andcolEnd
(exclusive). - getRow(int, int, int) - Method in class org.flag4j.arrays.sparse.CooMatrix
-
Gets a specified row of this matrix between
colStart
(inclusive) andcolEnd
(exclusive). - getRow(int, int, int) - Method in class org.flag4j.arrays.sparse.CsrCMatrix
-
Gets a specified row of this matrix between
colStart
(inclusive) andcolEnd
(exclusive). - getRow(int, int, int) - Method in class org.flag4j.arrays.sparse.CsrFieldMatrix
-
Gets a specified row of this matrix between
colStart
(inclusive) andcolEnd
(exclusive). - getRow(int, int, int) - Method in class org.flag4j.arrays.sparse.CsrMatrix
-
Gets a specified row of this matrix between
colStart
(inclusive) andcolEnd
(exclusive). - getRow(CooFieldMatrixBase<?, ?, ?, ?, T>, int) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatrixGetSet
-
Gets a specified row from this sparse matrix.
- getRow(CooFieldMatrixBase<?, ?, ?, ?, T>, int, int, int) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatrixGetSet
-
Gets a specified row range from this sparse matrix.
- getRow(CooMatrix, int) - Static method in class org.flag4j.linalg.ops.sparse.coo.real.RealSparseMatrixGetSet
-
Gets a specified row from this sparse matrix.
- getRow(CooMatrix, int, int, int) - Static method in class org.flag4j.linalg.ops.sparse.coo.real.RealSparseMatrixGetSet
-
Gets a specified row range from this sparse matrix.
- 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 to M=USVH in the SVD.
- getShape() - Method in interface org.flag4j.arrays.backend.MatrixMixin
-
Gets the shape of this matrix.
- getShape() - Method in class org.flag4j.arrays.backend.ring.AbstractDenseRingTensor
-
Gets the shape of this tensor.
- getShape() - Method in interface org.flag4j.arrays.backend.semiring.TensorOverSemiRing
-
Gets the shape of this tensor.
- getShape() - Method in class org.flag4j.arrays.backend.AbstractTensor
-
Gets the shape of this tensor.
- getShape() - Method in interface org.flag4j.arrays.backend.TensorMixin
-
Gets the shape of this tensor.
- getShape() - Method in class org.flag4j.arrays.sparse.SymmTriDiag
-
Gets the shape of this symmetric tri-diagonal matrix.
- 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 interface org.flag4j.arrays.backend.MatrixMixin
-
Gets a specified slice of this matrix.
- getSlice(int, int, int, int) - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringMatrix
-
Gets a specified slice of this matrix.
- getSlice(int, int, int, int) - Method in class org.flag4j.arrays.backend.semiring.AbstractDenseSemiringMatrix
-
Gets a specified slice of this matrix.
- getSlice(int, int, int, int) - Method in class org.flag4j.arrays.backend.semiring.CsrSemiRingMatrixBase
-
Gets a specified slice of this matrix.
- getSlice(int, int, int, int) - Method in class org.flag4j.arrays.backend.CooFieldMatrixBase
-
Gets a specified slice of this matrix.
- getSlice(int, int, int, int) - Method in class org.flag4j.arrays.backend.CsrFieldMatrixBase
-
Gets a specified slice of this matrix.
- getSlice(int, int, int, int) - Method in class org.flag4j.arrays.backend.DenseFieldMatrixBase
-
Gets a specified slice of this matrix.
- getSlice(int, int, int, int) - Method in interface org.flag4j.arrays.backend.MatrixMixinOld
-
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.CooMatrix
-
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(CooFieldMatrixBase<?, ?, ?, ?, V>, int, int, int, int) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatrixGetSet
-
Gets a specified rectangular slice of a sparse matrix.
- getSlice(Shape, T[], int[], int[], int, int, int, int) - Static method in class org.flag4j.linalg.ops.sparse.coo.CooGetSet
-
Extracts a specified slice from a sparse COO matrix.
- getSlice(CooMatrix, int, int, int, int) - Static method in class org.flag4j.linalg.ops.sparse.coo.real.RealSparseMatrixGetSet
-
Gets a specified rectangular slice of a sparse matrix.
- getSlice(CsrMatrix, int, int, int, int) - Static method in class org.flag4j.linalg.ops.sparse.csr.real.RealCsrOperations
-
Gets a specified slice of a CSR matrix.
- getSlice(T, int, int, int, int) - Static method in class org.flag4j.linalg.ops.sparse.csr.field_ops.CsrFieldMatrixOperations
-
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.arrays.Shape
-
Gets the strides of this shape 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_old which do not have the same total number of entries.
- getTriL() - Method in interface org.flag4j.arrays.backend.MatrixMixin
-
Extracts the lower-triangular portion of this matrix.
- getTriL() - Method in interface org.flag4j.arrays.backend.MatrixMixinOld
-
Extracts the lower-triangular portion of this matrix.
- getTriL(int) - Method in interface org.flag4j.arrays.backend.MatrixMixin
-
Extracts the lower-triangular portion of this matrix with a specified diagonal offset.
- getTriL(int) - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringMatrix
-
Extracts the lower-triangular portion of this matrix with a specified diagonal offset.
- getTriL(int) - Method in class org.flag4j.arrays.backend.semiring.AbstractDenseSemiringMatrix
-
Extracts the lower-triangular portion of this matrix with a specified diagonal offset.
- getTriL(int) - Method in class org.flag4j.arrays.backend.semiring.CsrSemiRingMatrixBase
-
Extracts the lower-triangular portion of this matrix with a specified diagonal offset.
- getTriL(int) - Method in class org.flag4j.arrays.backend.CooFieldMatrixBase
-
Extracts the lower-triangular portion of this matrix with a specified diagonal offset.
- getTriL(int) - Method in class org.flag4j.arrays.backend.CsrFieldMatrixBase
-
Extracts the lower-triangular portion of this matrix with a specified diagonal offset.
- getTriL(int) - Method in class org.flag4j.arrays.backend.DenseFieldMatrixBase
-
Extracts the lower-triangular portion of this matrix with a specified diagonal offset.
- getTriL(int) - Method in interface org.flag4j.arrays.backend.MatrixMixinOld
-
Extracts the lower-triangular portion of this matrix with a specified diagonal offset.
- getTriL(int) - Method in class org.flag4j.arrays.dense.Matrix
-
Extracts the lower-triangular portion of this matrix with a specified diagonal offset.
- getTriL(int) - Method in class org.flag4j.arrays.sparse.CooMatrix
-
Extracts the lower-triangular portion of this matrix with a specified diagonal offset.
- getTriL(int) - Method in class org.flag4j.arrays.sparse.CsrMatrix
-
Extracts the lower-triangular portion of this matrix with a specified diagonal offset.
- getTriL(int, T[], int[], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.CooGetSet
-
Gets the lower-triangular portion of a sparse COO matrix with a possible diagonal offset.
- getTriU() - Method in interface org.flag4j.arrays.backend.MatrixMixin
-
Extracts the upper-triangular portion of this matrix.
- getTriU() - Method in interface org.flag4j.arrays.backend.MatrixMixinOld
-
Extracts the upper-triangular portion of this matrix.
- getTriU(int) - Method in interface org.flag4j.arrays.backend.MatrixMixin
-
Extracts the upper-triangular portion of this matrix with a specified diagonal offset.
- getTriU(int) - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringMatrix
-
Extracts the upper-triangular portion of this matrix with a specified diagonal offset.
- getTriU(int) - Method in class org.flag4j.arrays.backend.semiring.AbstractDenseSemiringMatrix
-
Extracts the upper-triangular portion of this matrix with a specified diagonal offset.
- getTriU(int) - Method in class org.flag4j.arrays.backend.semiring.CsrSemiRingMatrixBase
-
Extracts the upper-triangular portion of this matrix with a specified diagonal offset.
- getTriU(int) - Method in class org.flag4j.arrays.backend.CooFieldMatrixBase
-
Extracts the upper-triangular portion of this matrix with a specified diagonal offset.
- getTriU(int) - Method in class org.flag4j.arrays.backend.CsrFieldMatrixBase
-
Extracts the upper-triangular portion of this matrix with a specified diagonal offset.
- getTriU(int) - Method in class org.flag4j.arrays.backend.DenseFieldMatrixBase
-
Extracts the upper-triangular portion of this matrix with a specified diagonal offset.
- getTriU(int) - Method in interface org.flag4j.arrays.backend.MatrixMixinOld
-
Extracts the upper-triangular portion of this matrix with a specified diagonal offset.
- getTriU(int) - Method in class org.flag4j.arrays.dense.Matrix
-
Extracts the upper-triangular portion of this matrix with a specified diagonal offset.
- getTriU(int) - Method in class org.flag4j.arrays.sparse.CooMatrix
-
Extracts the upper-triangular portion of this matrix with a specified diagonal offset.
- getTriU(int) - Method in class org.flag4j.arrays.sparse.CsrMatrix
-
Extracts the upper-triangular portion of this matrix with a specified diagonal offset.
- getTriU(int, T[], int[], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.CooGetSet
-
Gets the upper-triangular portion of a sparse COO matrix with a possible diagonal offset.
- getTrShape(Shape, int, int) - Static method in class org.flag4j.linalg.ops.dense.semiring_ops.DenseSemiRingOperations
-
Computes the shape of the tensor resulting from the generalized tensor trace along the specified axes for a tensor with the specified shape.
- 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.FieldLU
-
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 to M=USVH 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.
- getUtilityClassErrMsg(Class) - 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 to M=USVH in the SVD.
- getValue() - Method in class org.flag4j.algebraic_structures.fields.RealFloat32
-
Gets the value of this field element.
- getValue() - Method in class org.flag4j.algebraic_structures.fields.RealFloat64
-
Gets the value of this field element.
- getValue() - Method in class org.flag4j.algebraic_structures.rings.RealInt16
-
Gets the value of this field element.
- getValue() - Method in class org.flag4j.algebraic_structures.rings.RealInt32
-
Gets the value of this field element.
- 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
. - getZero() - Method in class org.flag4j.algebraic_structures.fields.Complex128
-
Gets the additive identity for this semi-ring.
- getZero() - Method in class org.flag4j.algebraic_structures.fields.Complex64
-
Gets the additive identity for this semi-ring.
- getZero() - Method in class org.flag4j.algebraic_structures.fields.RealFloat32
-
Gets the additive identity for this semi-ring.
- getZero() - Method in class org.flag4j.algebraic_structures.fields.RealFloat64
-
Gets the additive identity for this semi-ring.
- getZero() - Method in class org.flag4j.algebraic_structures.rings.RealInt16
-
Gets the additive identity for this semi-ring.
- getZero() - Method in class org.flag4j.algebraic_structures.rings.RealInt32
-
Gets the additive identity for this semi-ring.
- getZero() - Method in class org.flag4j.algebraic_structures.semirings.BooleanRing
-
Gets the additive identity for this semi-ring.
- getZero() - Method in interface org.flag4j.algebraic_structures.semirings.Semiring
-
Gets the additive identity for this semi-ring.
- getZeroElement() - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringMatrix
-
Gets the zero element for the semiring of this tensor.
- getZeroElement() - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringTensor
-
Gets the zero element for the field of this tensor.
- getZeroElement() - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringVector
-
Gets the zero element for the field of this vector.
- getZeroElement() - Method in class org.flag4j.arrays.backend.FieldTensorBase
-
Gets the zero element for the field of this tensor.
- getZeroMatrix(int, int, Y) - Method in class org.flag4j.arrays.backend.DenseFieldMatrixBase
-
Constructs the zero matrix with specified shape and zero value defined with respect to a field element.
- 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