Index

A B C D E F G H I J K L M N O P Q R S T U V W X Z 
All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form

I

I(int) - Static method in class org.flag4j.arrays.dense.CMatrix
Constructs an identity matrix of the specified size.
I(int) - Static method in class org.flag4j.arrays.dense.Matrix
Constructs an identity matrix of the specified size.
I(int, int) - Static method in class org.flag4j.arrays.dense.CMatrix
Constructs an identity matrix with the specified shape.
I(int, int) - Static method in class org.flag4j.arrays.dense.Matrix
Constructs an identity-like matrix of the specified shape.
I(int, int, Field) - Static method in class org.flag4j.arrays.dense.FieldMatrix
Constructs an identity-like matrix of the specified shape.
I(int, Field) - Static method in class org.flag4j.arrays.dense.FieldMatrix
Constructs an identity matrix of the specified size.
I(Shape) - Static method in class org.flag4j.arrays.dense.CMatrix
Constructs an identity matrix with the specified shape.
I(Shape) - Static method in class org.flag4j.arrays.dense.Matrix
Constructs an identity-like matrix of the specified shape.
I(Shape, Field) - Static method in class org.flag4j.arrays.dense.FieldMatrix
Constructs an identity-like matrix of the specified shape.
im - Variable in class org.flag4j.algebraic_structures.fields.Complex128
Imaginary component of the complex number.
im - Variable in class org.flag4j.algebraic_structures.fields.Complex64
Imaginary component of the complex number.
im() - Method in class org.flag4j.algebraic_structures.fields.Complex128
Gets the imaginary component of this complex number.
im() - Method in class org.flag4j.algebraic_structures.fields.Complex64
Gets the imaginary component of this complex number.
IMAGINARY_UNIT - Static variable in class org.flag4j.algebraic_structures.fields.Complex128
The imaginary unit i.
IMAGINARY_UNIT - Static variable in class org.flag4j.algebraic_structures.fields.Complex64
The imaginary unit i.
indexOf(int[], int) - Static method in class org.flag4j.util.ArrayUtils
Finds the fist index of the specified key within an array.
indices - Variable in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringTensor
The non-zero indices of this sparse tensor.
indices - Variable in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringVector
Indices of the non-zero values of this sparse COO vector.
indices - Variable in record class org.flag4j.arrays.backend.SparseVectorData
The field for the indices record component.
indices - Variable in class org.flag4j.arrays.backend.CooFieldTensorBase
The non-zero indices of this sparse tensor.
indices - Variable in class org.flag4j.arrays.backend.CooFieldVectorBase
Indices of the non-zero values of this sparse COO vector.
indices - Variable in class org.flag4j.arrays.sparse.CooTensor
The non-zero indices of this tensor.
indices - Variable in class org.flag4j.arrays.sparse.CooVector
The indices of the non-zero entries in this sparse COO vector.
indices() - Method in record class org.flag4j.arrays.backend.SparseVectorData
Returns the value of the indices record component.
INDICES_RANK_ERR - Static variable in class org.flag4j.util.ErrorMessages
Error message for a number of indices which does not match the rank of the tensor being indexed.
infNorm(CMatrix) - Static method in class org.flag4j.linalg.MatrixNorms
Computes the maximum/infinite norm of this tensor.
infNorm(CTensor) - Method in class org.flag4j.linalg.TensorNorms
Computes the maximum/infinite norm of this tensor.
infNorm(Matrix) - Static method in class org.flag4j.linalg.MatrixNorms
Computes the infinite norm of this matrix.
INFO - Static variable in exception class org.flag4j.util.exceptions.SingularMatrixException
 
initLU(CMatrix) - Method in class org.flag4j.linalg.decompositions.lu.ComplexLU
Initializes the LU matrix by copying the source matrix to decompose.
initLU(FieldMatrix<T>) - Method in class org.flag4j.linalg.decompositions.lu.FieldLU
Initializes the LU matrix by copying the source matrix to decompose.
initLU(Matrix) - Method in class org.flag4j.linalg.decompositions.lu.RealLU
Initializes the LU matrix by copying the source matrix to decompose.
initLU(T) - Method in class org.flag4j.linalg.decompositions.lu.LU
Initializes the LU matrix by copying the source matrix to decompose.
initMatrix(CTensor, int) - Method in class org.flag4j.linalg.solvers.exact.ComplexExactTensorSolver
Initializes matrix for equivalent linear matrix equation.
initMatrix(Tensor, int) - Method in class org.flag4j.linalg.solvers.exact.RealExactTensorSolver
Initializes matrix for equivalent linear matrix equation.
initMatrix(T, int) - Method in class org.flag4j.linalg.solvers.exact.ExactTensorSolver
Initializes matrix for equivalent linear matrix equation.
initQ() - Method in class org.flag4j.linalg.decompositions.hess.ComplexHess
Creates and initializes Q to the appropriately sized identity matrix.
initQ() - Method in class org.flag4j.linalg.decompositions.hess.RealHess
Creates and initializes Q to the appropriately sized identity matrix.
initQ() - Method in class org.flag4j.linalg.decompositions.qr.ComplexQR
Creates and initializes Q to the appropriately sized identity matrix.
initQ() - Method in class org.flag4j.linalg.decompositions.qr.RealQR
Creates and initializes Q to the appropriately sized identity matrix.
initQ() - Method in class org.flag4j.linalg.decompositions.unitary.UnitaryDecomposition
Creates and initializes Q to the appropriately sized identity matrix.
initUV(Shape, int) - Method in class org.flag4j.linalg.decompositions.svd.ComplexSVD
Initializes the unitary U and V matrices for the SVD.
initUV(Shape, int) - Method in class org.flag4j.linalg.decompositions.svd.RealSVD
Initializes the unitary U and V matrices for the SVD.
initUV(Shape, int) - Method in class org.flag4j.linalg.decompositions.svd.SVD
Initializes the unitary U and V matrices for the SVD.
initVector(CTensor) - Method in class org.flag4j.linalg.solvers.exact.ComplexExactTensorSolver
Initializes vector for equivalent linear matrix equation.
initVector(Tensor) - Method in class org.flag4j.linalg.solvers.exact.RealExactTensorSolver
Initializes vector for equivalent linear matrix equation.
initVector(T) - Method in class org.flag4j.linalg.solvers.exact.ExactTensorSolver
Initializes vector for equivalent linear matrix equation.
initWorkArrays(int) - Method in class org.flag4j.linalg.decompositions.unitary.ComplexUnitaryDecomposition
Initialized any work arrays_old to be used in computing the decomposition with the proper size.
initWorkArrays(int) - Method in class org.flag4j.linalg.decompositions.unitary.RealUnitaryDecomposition
Initialized any work arrays_old to be used in computing the decomposition with the proper size.
initWorkArrays(int) - Method in class org.flag4j.linalg.decompositions.unitary.UnitaryDecomposition
Initialized any work arrays_old to be used in computing the decomposition with the proper size.
inner(double[], double[], int[], int) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real.RealDenseSparseVectorOperations
Computes the vector inner product between a real dense vector and a real sparse vector.
inner(double[], int[], int, Field<T>[]) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real_field_ops.RealFieldDenseCooVectorOperations
Computes the vector inner product between a complex dense vector and a real sparse vector.
inner(double[], Field<T>[]) - Static method in class org.flag4j.linalg.ops.dense.real_field_ops.RealFieldDenseVectorOperations
Computes the vector inner product for a real dense vector and a complex dense vector.
inner(double[], Field<T>[], int[], int) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real_field_ops.RealFieldDenseCooVectorOperations
Computes the vector inner product between a real dense vector and a complex sparse vector.
inner(Field<T>[], double[]) - Static method in class org.flag4j.linalg.ops.dense.real_field_ops.RealFieldDenseVectorOperations
Computes the vector inner product for a complex dense vector and a real dense vector.
inner(Field<T>[], double[], int[], int) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real_field_ops.RealFieldDenseCooVectorOperations
Computes the vector inner product between a complex dense vector and a real sparse vector.
inner(CooFieldVectorBase<?, ?, ?, ?, T>, CooFieldVectorBase<?, ?, ?, ?, T>) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldVectorOperations
Computes the inner product of two complex sparse vectors.
inner(Vector) - Method in class org.flag4j.arrays.dense.Vector
Computes the inner product between two vectors.
inner(CooCVector, CooVector) - Static method in class org.flag4j.linalg.ops.sparse.coo.real_complex.RealComplexSparseVectorOperations
Computes the inner product of a real and complex sparse vector.
inner(CooVector) - Method in class org.flag4j.arrays.sparse.CooVector
Computes the inner product between two vectors.
inner(CooVector, CooCVector) - Static method in class org.flag4j.linalg.ops.sparse.coo.real_complex.RealComplexSparseVectorOperations
Computes the inner product of a real and complex sparse vector.
inner(CooVector, CooVector) - Static method in class org.flag4j.linalg.ops.sparse.coo.real.RealCooVectorOperations
Computes the inner product of two real sparse vectors.
inner(T) - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringVector
Computes the inner product between two vectors.
inner(T) - Method in class org.flag4j.arrays.backend.semiring.AbstractDenseSemiringVector
Computes the inner product between two vectors.
inner(T) - Method in interface org.flag4j.arrays.backend.VectorMixin
Computes the inner product between two vectors.
inner(T) - Method in class org.flag4j.arrays.backend.CooFieldVectorBase
Computes the inner product between two vectors.
inner(T) - Method in class org.flag4j.arrays.backend.DenseFieldVectorBase
Computes the inner product between two vectors.
inner(T) - Method in interface org.flag4j.arrays.backend.VectorMixinOld
Computes the inner product between two vectors.
innerProduct(double[], double[]) - Static method in class org.flag4j.linalg.ops.dense.real.RealDenseVectorOperations
Computes the vector inner product for two real dense vectors.
innerProduct(Field<T>[], int[], int, Field<T>[]) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.field_ops.DenseCooFieldVectorOperations
Computes the vector inner product between a complex dense vector and a complex sparse vector.
innerProduct(Field<T>[], Field<T>[]) - Static method in class org.flag4j.linalg.ops.dense.field_ops.DenseFieldVectorOperations
Computes the vector inner product for two vectors.
innerProduct(Field<T>[], Field<T>[], int[], int) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.field_ops.DenseCooFieldVectorOperations
Computes the vector inner product between a complex dense vector and a complex sparse vector.
innerProduct(Ring<T>[], Ring<T>[]) - Static method in class org.flag4j.linalg.ops.dense.ring_ops.DenseRingVectorOps
Computes the vector inner product for two vectors.
innerSelf() - Method in class org.flag4j.arrays.dense.CVector
Computes the inner product between this vector and itself.
inSlice(int, int, int, int, int, int) - Static method in class org.flag4j.linalg.ops.sparse.coo.CooGetSet
Checks if an index is in the specified slice.
inSlice(int, int, int, int, int, int) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatrixGetSet
Checks if an index is in the specified slice.
inSlice(int, int, int, int, int, int) - Static method in class org.flag4j.linalg.ops.sparse.coo.real.RealSparseMatrixGetSet
Checks if an index is in the specified slice.
intRange(int, int) - Static method in class org.flag4j.util.ArrayUtils
Gets an array filled with integers from start (inclusive) to end (exclusive)
intRange(int, int, int) - Static method in class org.flag4j.util.ArrayUtils
Gets an array filled with integers from start (inclusive) to end (exclusive) where each int is repeated stride times.
inv() - Method in class org.flag4j.arrays.dense.Tensor
Computes the 'inverse' of this tensor.
inv() - Method in class org.flag4j.arrays.sparse.PermutationMatrix
Computes the inverse/transpose of this permutation matrix.
inv(int) - Method in class org.flag4j.arrays.dense.Tensor
Computes the 'inverse' of this tensor.
inv(PrimitiveDoubleTensorBase<T, T>, int) - Static method in class org.flag4j.linalg.TensorInvert
Computes the 'inverse' of a tensor.
inv(CMatrix) - Static method in class org.flag4j.linalg.Invert
Computes the inverse of this matrix.
inv(CTensor, int) - Static method in class org.flag4j.linalg.TensorInvert
Deprecated.
inv(Matrix) - Static method in class org.flag4j.linalg.Invert
Computes the inverse of this matrix.
inv(Tensor, int) - Static method in class org.flag4j.linalg.TensorInvert
Deprecated.
INV_IMAGINARY_UNIT - Static variable in class org.flag4j.algebraic_structures.fields.Complex128
The additive inverse of the imaginary unit, -i.
INV_IMAGINARY_UNIT - Static variable in class org.flag4j.algebraic_structures.fields.Complex64
The additive inverse of the imaginary unit, -i.
invDiag(CMatrix) - Static method in class org.flag4j.linalg.Invert
Inverts a diagonal matrix.
invDiag(Matrix) - Static method in class org.flag4j.linalg.Invert
Inverts a diagonal matrix.
invDirectSum(CMatrix) - Method in class org.flag4j.linalg.decompositions.svd.ComplexSVD
Computes the inverse direct sum of a matrix and its hermitian transpose.
invDirectSum(CMatrix, CMatrix) - Static method in class org.flag4j.linalg.DirectSum
Computes direct sum from bottom left to top right of two matrices.
invDirectSum(CMatrix, Matrix) - Static method in class org.flag4j.linalg.DirectSum
Computes direct sum from bottom left to top right of two matrices.
invDirectSum(CMatrix, CooCMatrix) - Static method in class org.flag4j.linalg.DirectSum
Computes direct sum from bottom left to top right of two matrices.
invDirectSum(CMatrix, CooMatrix) - Static method in class org.flag4j.linalg.DirectSum
Computes direct sum from bottom left to top right of two matrices.
invDirectSum(Matrix) - Method in class org.flag4j.linalg.decompositions.svd.RealSVD
Computes the inverse direct sum of a matrix and its hermitian transpose.
invDirectSum(Matrix, CMatrix) - Static method in class org.flag4j.linalg.DirectSum
Computes direct sum from bottom left to top right of two matrices.
invDirectSum(Matrix, Matrix) - Static method in class org.flag4j.linalg.DirectSum
Computes direct sum from bottom left to top right of two matrices.
invDirectSum(Matrix, CooCMatrix) - Static method in class org.flag4j.linalg.DirectSum
Computes direct sum from bottom left to top right of two matrices.
invDirectSum(Matrix, CooMatrix) - Static method in class org.flag4j.linalg.DirectSum
Computes direct sum from bottom left to top right of two matrices.
invDirectSum(CooCMatrix, CMatrix) - Static method in class org.flag4j.linalg.DirectSum
Computes direct sum from bottom left to top right of two matrices.
invDirectSum(CooCMatrix, Matrix) - Static method in class org.flag4j.linalg.DirectSum
Computes direct sum from bottom left to top right of two matrices.
invDirectSum(CooCMatrix, CooCMatrix) - Static method in class org.flag4j.linalg.DirectSum
Computes direct sum from bottom left to top right of two matrices.
invDirectSum(CooCMatrix, CooMatrix) - Static method in class org.flag4j.linalg.DirectSum
Computes direct sum from bottom left to top right of two matrices.
invDirectSum(CooMatrix, CMatrix) - Static method in class org.flag4j.linalg.DirectSum
Computes direct sum from bottom left to top right of two matrices.
invDirectSum(CooMatrix, Matrix) - Static method in class org.flag4j.linalg.DirectSum
Computes direct sum from bottom left to top right of two matrices.
invDirectSum(CooMatrix, CooCMatrix) - Static method in class org.flag4j.linalg.DirectSum
Computes direct sum from bottom left to top right of two matrices.
invDirectSum(CooMatrix, CooMatrix) - Static method in class org.flag4j.linalg.DirectSum
Computes direct sum from bottom left to top right of two matrices.
invDirectSum(T) - Method in class org.flag4j.linalg.decompositions.svd.SVD
Computes the inverse direct sum of a matrix and its hermitian transpose.
Invert - Class in org.flag4j.linalg
This class provides methods for computing the inverse of a matrix.
Invert() - Constructor for class org.flag4j.linalg.Invert
 
invHermPosDef(CMatrix) - Static method in class org.flag4j.linalg.Invert
Inverts a hermitian positive definite matrix.
invHermPosDef(CMatrix, boolean) - Static method in class org.flag4j.linalg.Invert
Inverts a hermitian positive definite matrix.
invSymPosDef(Matrix) - Static method in class org.flag4j.linalg.Invert
Inverts a symmetric positive definite matrix.
invSymPosDef(Matrix, boolean) - Static method in class org.flag4j.linalg.Invert
Inverts a symmetric positive definite matrix.
invTriL(CMatrix) - Static method in class org.flag4j.linalg.Invert
Inverts a lower triangular matrix.
invTriL(Matrix) - Static method in class org.flag4j.linalg.Invert
Inverts a lower triangular matrix.
invTriU(CMatrix) - Static method in class org.flag4j.linalg.Invert
Inverts an upper triangular matrix.
invTriU(Matrix) - Static method in class org.flag4j.linalg.Invert
Inverts an upper triangular matrix.
isAntiHermitian(Field<T>[], Shape) - Static method in class org.flag4j.linalg.ops.dense.field_ops.DenseFieldProperties
Checks if a real dense matrix is anti-hermitian.
isAntiHermitian(CooFieldMatrixBase<?, ?, ?, ?, V>) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatrixProperties
Checks if a sparse matrix is anti-hermitian.
isAntiHermitian(CsrFieldMatrixBase<?, ?, ?, ?, T>) - Static method in class org.flag4j.linalg.ops.sparse.csr.field_ops.CsrFieldMatrixProperties
Checks if the src matrix is anti-Hermitian.
isAntiSymmetric() - Method in class org.flag4j.arrays.backend.CooFieldMatrixBase
Checks if a matrix is anti-symmetric.
isAntiSymmetric() - Method in class org.flag4j.arrays.backend.CsrFieldMatrixBase
Checks if a matrix is anti-symmetric.
isAntiSymmetric() - Method in class org.flag4j.arrays.backend.DenseFieldMatrixBase
Checks if a matrix is anti-symmetric.
isAntiSymmetric() - Method in interface org.flag4j.arrays.backend.MatrixMixinOld
Checks if a matrix is anti-symmetric.
isAntiSymmetric() - Method in class org.flag4j.arrays.dense.Matrix
Checks if a matrix is anti-symmetric.
isAntiSymmetric() - Method in class org.flag4j.arrays.sparse.CooMatrix
Checks if a matrix is anti-symmetric.
isAntiSymmetric() - Method in class org.flag4j.arrays.sparse.CsrMatrix
Checks if a matrix is anti-symmetric.
isAntiSymmetric(double[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real.RealDenseProperties
Checks if a real dense matrix is anti-symmetric.
isAntiSymmetric(CsrFieldMatrixBase<?, ?, ?, ?, T>) - Static method in class org.flag4j.linalg.ops.sparse.csr.field_ops.CsrFieldMatrixProperties
Checks if the src matrix is anti-symmetric.
isAntiSymmetric(CooMatrix) - Static method in class org.flag4j.linalg.ops.sparse.coo.real.RealSparseMatrixProperties
Checks if a real sparse matrix is anti-symmetric.
isAntiSymmetric(CsrMatrix) - Static method in class org.flag4j.linalg.ops.sparse.csr.real.RealCsrProperties
Checks if the src matrix is anti-symmetric.
isCloseToI() - Method in class org.flag4j.arrays.backend.CooFieldMatrixBase
Checks that this matrix is close to the identity matrix.
isCloseToI() - Method in class org.flag4j.arrays.backend.CsrFieldMatrixBase
Checks that this matrix is close to the identity matrix.
isCloseToI() - Method in class org.flag4j.arrays.backend.DenseFieldMatrixBase
Checks that this matrix is close to the identity matrix.
isCloseToI() - Method in interface org.flag4j.arrays.backend.MatrixMixinOld
Checks that this matrix is close to the identity matrix.
isCloseToI() - Method in class org.flag4j.arrays.dense.Matrix
Checks that this matrix is close to the identity matrix.
isCloseToI() - Method in class org.flag4j.arrays.sparse.CooMatrix
Checks that this matrix is close to the identity matrix.
isCloseToI() - Method in class org.flag4j.arrays.sparse.CsrMatrix
Checks that this matrix is close to the identity matrix.
isCloseToIdentity(CooFieldMatrixBase<?, ?, ?, ?, V>) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatrixProperties
Checks if a real sparse matrix is close to the identity matrix.
isCloseToIdentity(CsrFieldMatrixBase<?, ?, ?, ?, T>) - Static method in class org.flag4j.linalg.ops.sparse.csr.field_ops.CsrFieldMatrixProperties
Checks if the src matrix is close to the identity matrix.
isCloseToIdentity(DenseFieldMatrixBase<?, ?, ?, ?, T>) - Static method in class org.flag4j.linalg.ops.dense.field_ops.DenseFieldProperties
Checks if a matrix is the identity matrix approximately.
isCloseToIdentity(Matrix) - Static method in class org.flag4j.linalg.ops.dense.real.RealDenseProperties
Checks if a matrix is the identity matrix approximately.
isCloseToIdentity(CooMatrix) - Static method in class org.flag4j.linalg.ops.sparse.coo.real.RealSparseMatrixProperties
Checks if a real sparse matrix is close to the identity matrix.
isCloseToIdentity(CsrMatrix) - Static method in class org.flag4j.linalg.ops.sparse.csr.real.RealCsrProperties
Checks if the src matrix is close to the identity matrix.
isComplex() - Method in class org.flag4j.algebraic_structures.fields.Complex128
Checks if this complex number has non-zero imaginary part.
isComplex() - Method in class org.flag4j.algebraic_structures.fields.Complex64
Checks if this complex number has non-zero imaginary part.
isComplex() - Method in class org.flag4j.arrays.dense.CMatrix
Checks if this complex matrix contains at least one non-real value.
isComplex(Field<Complex128>[]) - Static method in class org.flag4j.linalg.ops.common.complex.Complex128Properties
Checks whether a tensor contains at least one non-real value.
isComplex(Field<Complex64>[]) - Static method in class org.flag4j.linalg.ops.common.complex.Complex64Properties
Checks whether a tensor contains at least one non-real value.
isDiag() - Method in interface org.flag4j.arrays.backend.MatrixMixin
Checks if this matrix is diagonal.
isDiag() - Method in interface org.flag4j.arrays.backend.MatrixMixinOld
Checks if this matrix is diagonal.
isDouble() - Method in class org.flag4j.algebraic_structures.fields.Complex128
Checks if this complex number is a real valued double.
isFinite() - Method in class org.flag4j.algebraic_structures.fields.Complex128
Checks if this field element is finite in magnitude.
isFinite() - Method in class org.flag4j.algebraic_structures.fields.Complex64
Checks if this field element is finite in magnitude.
isFinite() - Method in interface org.flag4j.algebraic_structures.fields.Field
Checks if this field element is finite in magnitude.
isFinite() - Method in class org.flag4j.algebraic_structures.fields.RealFloat32
Checks if this field element is finite in magnitude.
isFinite() - Method in class org.flag4j.algebraic_structures.fields.RealFloat64
Checks if this field element is finite in magnitude.
isFinite() - Method in class org.flag4j.arrays.backend.field.AbstractDenseFieldTensor
Checks if this tensor only contains finite values.
isFinite() - Method in interface org.flag4j.arrays.backend.field.TensorOverField
Checks if this tensor only contains finite values.
isFinite(Field<V>[]) - Static method in class org.flag4j.linalg.ops.common.field_ops.FieldOps
Checks if all elements of a tensor are finite.
isFloat() - Method in class org.flag4j.algebraic_structures.fields.Complex64
Checks if this complex number is a real valued float.
isFullRank() - Method in interface org.flag4j.arrays.backend.DenseMatrixMixinOld
Checks if a matrix has full rank.
isHermitian() - Method in interface org.flag4j.arrays.backend.MatrixMixin
Checks if a matrix is Hermitian.
isHermitian() - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringMatrix
Checks if a matrix is Hermitian.
isHermitian() - Method in class org.flag4j.arrays.backend.semiring.AbstractDenseSemiringMatrix
Checks if a matrix is Hermitian.
isHermitian() - Method in class org.flag4j.arrays.backend.semiring.CsrSemiRingMatrixBase
Checks if a matrix is Hermitian.
isHermitian() - Method in class org.flag4j.arrays.backend.CooFieldMatrixBase
Checks if a matrix is Hermitian.
isHermitian() - Method in class org.flag4j.arrays.backend.CsrFieldMatrixBase
Checks if a matrix is Hermitian.
isHermitian() - Method in class org.flag4j.arrays.backend.DenseFieldMatrixBase
Checks if a matrix is Hermitian.
isHermitian() - Method in interface org.flag4j.arrays.backend.MatrixMixinOld
Checks if a matrix is Hermitian.
isHermitian() - Method in class org.flag4j.arrays.dense.Matrix
Checks if a matrix is Hermitian.
isHermitian() - Method in class org.flag4j.arrays.sparse.CooMatrix
Checks if a matrix is Hermitian.
isHermitian() - Method in class org.flag4j.arrays.sparse.CsrMatrix
Checks if a matrix is Hermitian.
isHermitian(Field<T>[], Shape) - Static method in class org.flag4j.linalg.ops.dense.field_ops.DenseFieldProperties
Checks if a complex dense matrix is hermitian.
isHermitian(CooFieldMatrixBase<?, ?, ?, ?, V>) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatrixProperties
Checks if a sparse matrix is hermitian.
isHermitian(CsrFieldMatrixBase<?, ?, ?, ?, T>) - Static method in class org.flag4j.linalg.ops.sparse.csr.field_ops.CsrFieldMatrixProperties
Checks if the src matrix is Hermitian.
isI() - Method in interface org.flag4j.arrays.backend.MatrixMixin
Checks if this matrix is the identity matrix.
isI() - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringMatrix
Checks if this matrix is the identity matrix.
isI() - Method in class org.flag4j.arrays.backend.semiring.AbstractDenseSemiringMatrix
Checks if this matrix is the identity matrix.
isI() - Method in class org.flag4j.arrays.backend.semiring.CsrSemiRingMatrixBase
Checks if this matrix is the identity matrix.
isI() - Method in class org.flag4j.arrays.backend.CooFieldMatrixBase
Checks if this matrix is the identity matrix.
isI() - Method in class org.flag4j.arrays.backend.CsrFieldMatrixBase
Checks if this matrix is the identity matrix.
isI() - Method in class org.flag4j.arrays.backend.DenseFieldMatrixBase
Checks if this matrix is the identity matrix.
isI() - Method in interface org.flag4j.arrays.backend.MatrixMixinOld
Checks if this matrix is the identity matrix.
isI() - Method in class org.flag4j.arrays.dense.Matrix
Checks if this matrix is the identity matrix.
isI() - Method in class org.flag4j.arrays.sparse.CooMatrix
Checks if this matrix is the identity matrix.
isI() - Method in class org.flag4j.arrays.sparse.CsrMatrix
Checks if this matrix is the identity matrix.
isIdentity(CooFieldMatrixBase<?, ?, ?, ?, V>) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatrixProperties
Checks if a complex sparse matrix is the identity matrix.
isIdentity(CsrFieldMatrixBase<?, ?, ?, ?, T>) - Static method in class org.flag4j.linalg.ops.sparse.csr.field_ops.CsrFieldMatrixProperties
Checks if the src matrix is the identity matrix.
isIdentity(Matrix) - Static method in class org.flag4j.linalg.ops.dense.real.RealDenseProperties
Checks if a matrix is the identity matrix exactly.
isIdentity(Shape, Semiring<T>[], int[], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.semiring_ops.CooSemiringMatrixProperties
Checks if a complex sparse COO matrix is the identity matrix.
isIdentity(CooMatrix) - Static method in class org.flag4j.linalg.ops.sparse.coo.real.RealSparseMatrixProperties
Checks if a real sparse matrix is the identity matrix.
isIdentity(CsrMatrix) - Static method in class org.flag4j.linalg.ops.sparse.csr.real.RealCsrProperties
Checks if the src matrix is the identity matrix.
isImaginary() - Method in class org.flag4j.algebraic_structures.fields.Complex128
Checks if this complex number has zero real part.
isImaginary() - Method in class org.flag4j.algebraic_structures.fields.Complex64
Checks if this complex number has zero real part.
isInfinite() - Method in class org.flag4j.algebraic_structures.fields.Complex128
Checks if this field element is infinite in magnitude.
isInfinite() - Method in class org.flag4j.algebraic_structures.fields.Complex64
Checks if this field element is infinite in magnitude.
isInfinite() - Method in interface org.flag4j.algebraic_structures.fields.Field
Checks if this field element is infinite in magnitude.
isInfinite() - Method in class org.flag4j.algebraic_structures.fields.RealFloat32
Checks if this field element is infinite in magnitude.
isInfinite() - Method in class org.flag4j.algebraic_structures.fields.RealFloat64
Checks if this field element is infinite in magnitude.
isInfinite() - Method in class org.flag4j.arrays.backend.field.AbstractDenseFieldTensor
Checks if this tensor contains at least one infinite value.
isInfinite() - Method in interface org.flag4j.arrays.backend.field.TensorOverField
Checks if this tensor contains at least one infinite value.
isInfinite(Field<V>[]) - Static method in class org.flag4j.linalg.ops.common.field_ops.FieldOps
Checks if any element of a tensor is infinite.
isInt() - Method in class org.flag4j.algebraic_structures.fields.Complex128
Checks if this complex number is a real valued integer.
isInt() - Method in class org.flag4j.algebraic_structures.fields.Complex64
Checks if this complex number is a real valued integer.
isInv(CMatrix, CMatrix) - Static method in class org.flag4j.linalg.Invert
Checks if matrices are inverses of each other.
isInv(Matrix, Matrix) - Static method in class org.flag4j.linalg.Invert
Checks if matrices are inverses of each other.
isInvertible() - Method in interface org.flag4j.arrays.backend.DenseMatrixMixinOld
Checks if a matrix is invertible.
isKind(String) - Method in class org.flag4j.io.parsing.ComplexNumberToken
Checks if token is of kind s.
isNaN() - Method in class org.flag4j.algebraic_structures.fields.Complex128
Checks if this field element is NaN in magnitude.
isNaN() - Method in class org.flag4j.algebraic_structures.fields.Complex64
Checks if this field element is NaN in magnitude.
isNaN() - Method in interface org.flag4j.algebraic_structures.fields.Field
Checks if this field element is NaN in magnitude.
isNaN() - Method in class org.flag4j.algebraic_structures.fields.RealFloat32
Checks if this field element is NaN in magnitude.
isNaN() - Method in class org.flag4j.algebraic_structures.fields.RealFloat64
Checks if this field element is NaN in magnitude.
isNaN() - Method in class org.flag4j.arrays.backend.field.AbstractDenseFieldTensor
Checks if this tensor contains at least one NaN value.
isNaN() - Method in interface org.flag4j.arrays.backend.field.TensorOverField
Checks if this tensor contains at least one NaN value.
isNaN(Field<V>[]) - Static method in class org.flag4j.linalg.ops.common.field_ops.FieldOps
Checks if any element of a tensor is NaN.
isNeg() - Method in class org.flag4j.arrays.backend.DensePrimitiveDoubleTensorBase
Checks if this tensor only contains negative values.
isNeg(double[]) - Static method in class org.flag4j.linalg.ops.common.real.RealProperties
Checks if a tensor only contain negative values.
isOne() - Method in class org.flag4j.algebraic_structures.fields.Complex128
Checks if this value is a multiplicative identity for this semi-ring.
isOne() - Method in class org.flag4j.algebraic_structures.fields.Complex64
Checks if this value is a multiplicative identity for this semi-ring.
isOne() - Method in class org.flag4j.algebraic_structures.fields.RealFloat32
Checks if this value is a multiplicative identity for this semi-ring.
isOne() - Method in class org.flag4j.algebraic_structures.fields.RealFloat64
Checks if this value is a multiplicative identity for this semi-ring.
isOne() - Method in class org.flag4j.algebraic_structures.rings.RealInt16
Checks if this value is a multiplicative identity for this semi-ring.
isOne() - Method in class org.flag4j.algebraic_structures.rings.RealInt32
Checks if this value is a multiplicitive identity for this semi-ring.
isOne() - Method in class org.flag4j.algebraic_structures.semirings.BooleanRing
Checks if this value is a multiplicitive identity for this semi-ring.
isOne() - Method in interface org.flag4j.algebraic_structures.semirings.Semiring
Checks if this value is a multiplicative identity for this semi-ring.
isOnes() - Method in interface org.flag4j.arrays.backend.field.FieldTensorMixin
Checks if this tensor only contains ones.
isOnes() - Method in interface org.flag4j.arrays.backend.ring.RingTensorMixin
Checks if this tensor only contains ones.
isOnes() - Method in interface org.flag4j.arrays.backend.semiring.SemiringTensorMixin
Checks if this tensor only contains ones.
isOnes() - Method in interface org.flag4j.arrays.backend.semiring.TensorOverSemiRing
Checks if this tensor only contains ones.
isOnes() - Method in class org.flag4j.arrays.backend.FieldTensorBase
Checks if this tensor only contains ones.
isOnes() - Method in class org.flag4j.arrays.backend.PrimitiveDoubleTensorBase
Checks if this tensor only contains zeros.
isOnes() - Method in class org.flag4j.arrays.backend.TensorOverSemiRing
Checks if this tensor only contains ones.
isOnes(double[]) - Static method in class org.flag4j.linalg.ops.dense.real.RealDenseProperties
Checks if this tensor only contains ones.
isOnes(Field<T>[]) - Static method in class org.flag4j.linalg.ops.dense.field_ops.DenseFieldProperties
Checks if this tensor only contains ones.
isOnes(Semiring<T>[]) - Static method in class org.flag4j.linalg.ops.common.semiring_ops.SemiRingProperties
Checks if an array contains only ones.
isOrthogonal() - Method in interface org.flag4j.arrays.backend.MatrixMixin
Checks if this matrix is orthogonal.
isOrthogonal() - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringMatrix
Checks if this matrix is orthogonal.
isOrthogonal() - Method in class org.flag4j.arrays.backend.semiring.AbstractDenseSemiringMatrix
Checks if this matrix is orthogonal.
isOrthogonal() - Method in class org.flag4j.arrays.backend.semiring.CsrSemiRingMatrixBase
Checks if this matrix is orthogonal.
isOrthogonal() - Method in class org.flag4j.arrays.backend.CooFieldMatrixBase
Checks if this matrix is orthogonal.
isOrthogonal() - Method in class org.flag4j.arrays.backend.CsrFieldMatrixBase
Checks if this matrix is orthogonal.
isOrthogonal() - Method in class org.flag4j.arrays.backend.DenseFieldMatrixBase
Checks if this matrix is orthogonal.
isOrthogonal() - Method in interface org.flag4j.arrays.backend.MatrixMixinOld
Checks if this matrix is orthogonal.
isOrthogonal() - Method in class org.flag4j.arrays.dense.Matrix
Checks if this matrix is orthogonal.
isOrthogonal() - Method in class org.flag4j.arrays.sparse.CooMatrix
Checks if this matrix is orthogonal.
isOrthogonal() - Method in class org.flag4j.arrays.sparse.CsrMatrix
Checks if this matrix is orthogonal.
isParallel(Vector) - Method in class org.flag4j.arrays.dense.Vector
Checks if a vector is parallel to this vector.
isParallel(CooVector) - Method in class org.flag4j.arrays.sparse.CooVector
Checks if a vector is parallel to this vector.
isParallel(T) - Method in class org.flag4j.arrays.backend.CooFieldVectorBase
Checks if a vector is parallel to this vector.
isParallel(T) - Method in class org.flag4j.arrays.backend.DenseFieldVectorBase
Checks if a vector is parallel to this vector.
isParallel(T) - Method in interface org.flag4j.arrays.backend.VectorMixinOld
Checks if a vector is parallel to this vector.
isPerp(Vector) - Method in class org.flag4j.arrays.dense.Vector
Checks if a vector is perpendicular to this vector.
isPerp(CooVector) - Method in class org.flag4j.arrays.sparse.CooVector
Checks if a vector is perpendicular to this vector.
isPerp(T) - Method in class org.flag4j.arrays.backend.CooFieldVectorBase
Checks if a vector is perpendicular to this vector.
isPerp(T) - Method in class org.flag4j.arrays.backend.DenseFieldVectorBase
Checks if a vector is perpendicular to this vector.
isPerp(T) - Method in interface org.flag4j.arrays.backend.VectorMixinOld
Checks if a vector is perpendicular to this vector.
isPos() - Method in class org.flag4j.arrays.backend.DensePrimitiveDoubleTensorBase
Checks if this tensor only contains positive values.
isPos(double[]) - Static method in class org.flag4j.linalg.ops.common.real.RealProperties
Checks if a tensor only contain positive values.
isReal() - Method in class org.flag4j.algebraic_structures.fields.Complex128
Checks if this complex number has zero imaginary part.
isReal() - Method in class org.flag4j.algebraic_structures.fields.Complex64
Checks if this complex number has zero imaginary part.
isReal() - Method in class org.flag4j.arrays.dense.CMatrix
Checks if this complex matrix only contains real values.
isReal(Field<Complex128>[]) - Static method in class org.flag4j.linalg.ops.common.complex.Complex128Properties
Checks whether a tensor contains only real values.
isReal(Field<Complex64>[]) - Static method in class org.flag4j.linalg.ops.common.complex.Complex64Properties
Checks whether a tensor contains only real values.
isSingular() - Method in class org.flag4j.arrays.backend.DenseFieldMatrixBase
Checks if a matrix is singular.
isSingular() - Method in interface org.flag4j.arrays.backend.DenseMatrixMixinOld
Checks if a matrix is singular.
isSingular() - Method in class org.flag4j.arrays.dense.Matrix
Checks if a matrix is singular.
isSquare() - Method in interface org.flag4j.arrays.backend.MatrixMixin
Checks if this matrix is square.
isSquare() - Method in interface org.flag4j.arrays.backend.MatrixMixinOld
Checks if this matrix is square.
isSymmetric() - Method in interface org.flag4j.arrays.backend.MatrixMixin
Checks if a matrix is symmetric.
isSymmetric() - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringMatrix
Checks if a matrix is symmetric.
isSymmetric() - Method in class org.flag4j.arrays.backend.semiring.AbstractDenseSemiringMatrix
Checks if a matrix is symmetric.
isSymmetric() - Method in class org.flag4j.arrays.backend.semiring.CsrSemiRingMatrixBase
Checks if a matrix is symmetric.
isSymmetric() - Method in class org.flag4j.arrays.backend.CooFieldMatrixBase
Checks if a matrix is symmetric.
isSymmetric() - Method in class org.flag4j.arrays.backend.CsrFieldMatrixBase
Checks if a matrix is symmetric.
isSymmetric() - Method in class org.flag4j.arrays.backend.DenseFieldMatrixBase
Checks if a matrix is symmetric.
isSymmetric() - Method in interface org.flag4j.arrays.backend.MatrixMixinOld
Checks if a matrix is symmetric.
isSymmetric() - Method in class org.flag4j.arrays.dense.Matrix
Checks if a matrix is symmetric.
isSymmetric() - Method in class org.flag4j.arrays.sparse.CooMatrix
Checks if a matrix is symmetric.
isSymmetric() - Method in class org.flag4j.arrays.sparse.CsrMatrix
Checks if a matrix is symmetric.
isSymmetric(double[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real.RealDenseProperties
Checks if a real dense matrix is symmetric.
isSymmetric(CooFieldMatrixBase<?, ?, ?, ?, V>) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatrixProperties
Checks if a sparse matrix is symmetric.
isSymmetric(CsrFieldMatrixBase<?, ?, ?, ?, T>) - Static method in class org.flag4j.linalg.ops.sparse.csr.field_ops.CsrFieldMatrixProperties
Checks if the src matrix is symmetric.
isSymmetric(Shape, Semiring<T>[], int[], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.semiring_ops.CooSemiringMatrixProperties
Checks if a sparse matrix is symmetric.
isSymmetric(CooMatrix) - Static method in class org.flag4j.linalg.ops.sparse.coo.real.RealSparseMatrixProperties
Checks if a real sparse matrix is symmetric.
isSymmetric(CsrMatrix) - Static method in class org.flag4j.linalg.ops.sparse.csr.real.RealCsrProperties
Checks if the src matrix is symmetric.
isSymmPosDef(CMatrix) - Static method in class org.flag4j.linalg.PositiveDefiniteness
Checks if the matrix is symmetric positive definite.
isSymmPosDef(Matrix) - Static method in class org.flag4j.linalg.PositiveDefiniteness
Checks if the matrix is symmetric positive definite.
isTri() - Method in interface org.flag4j.arrays.backend.MatrixMixin
Checks if this matrix is triangular (i.e.
isTri() - Method in interface org.flag4j.arrays.backend.MatrixMixinOld
Checks if this matrix is triangular (i.e.
isTriL() - Method in interface org.flag4j.arrays.backend.MatrixMixin
Checks if this matrix is lower triangular.
isTriL() - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringMatrix
Checks if this matrix is lower triangular.
isTriL() - Method in class org.flag4j.arrays.backend.semiring.AbstractDenseSemiringMatrix
Checks if this matrix is lower triangular.
isTriL() - Method in class org.flag4j.arrays.backend.semiring.CsrSemiRingMatrixBase
Checks if this matrix is lower triangular.
isTriL() - Method in class org.flag4j.arrays.backend.CooFieldMatrixBase
Checks if this matrix is lower triangular.
isTriL() - Method in class org.flag4j.arrays.backend.CsrFieldMatrixBase
Checks if this matrix is lower triangular.
isTriL() - Method in class org.flag4j.arrays.backend.DenseFieldMatrixBase
Checks if this matrix is lower triangular.
isTriL() - Method in interface org.flag4j.arrays.backend.MatrixMixinOld
Checks if this matrix is lower triangular.
isTriL() - Method in class org.flag4j.arrays.dense.Matrix
Checks if this matrix is lower triangular.
isTriL() - Method in class org.flag4j.arrays.sparse.CooMatrix
Checks if this matrix is lower triangular.
isTriL() - Method in class org.flag4j.arrays.sparse.CsrMatrix
Checks if this matrix is lower triangular.
isTriU() - Method in interface org.flag4j.arrays.backend.MatrixMixin
Checks if this matrix is upper triangular.
isTriU() - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringMatrix
Checks if this matrix is upper triangular.
isTriU() - Method in class org.flag4j.arrays.backend.semiring.AbstractDenseSemiringMatrix
Checks if this matrix is upper triangular.
isTriU() - Method in class org.flag4j.arrays.backend.semiring.CsrSemiRingMatrixBase
Checks if this matrix is upper triangular.
isTriU() - Method in class org.flag4j.arrays.backend.CooFieldMatrixBase
Checks if this matrix is upper triangular.
isTriU() - Method in class org.flag4j.arrays.backend.CsrFieldMatrixBase
Checks if this matrix is upper triangular.
isTriU() - Method in class org.flag4j.arrays.backend.DenseFieldMatrixBase
Checks if this matrix is upper triangular.
isTriU() - Method in interface org.flag4j.arrays.backend.MatrixMixinOld
Checks if this matrix is upper triangular.
isTriU() - Method in class org.flag4j.arrays.dense.Matrix
Checks if this matrix is upper triangular.
isTriU() - Method in class org.flag4j.arrays.sparse.CooMatrix
Checks if this matrix is upper triangular.
isTriU() - Method in class org.flag4j.arrays.sparse.CsrMatrix
Checks if this matrix is upper triangular.
isUnit - Variable in class org.flag4j.linalg.solvers.exact.triangular.ForwardSolver
Flag indicating if lower-triangular matrices passed to this solver will be unit lower-triangular (true) or simply lower-triangular (false).
isUnitary() - Method in class org.flag4j.arrays.backend.CsrFieldMatrixBase
Checks if this matrix is orthogonal.
isUnitary() - Method in class org.flag4j.arrays.dense.CMatrix
Checks if this matrix is unitary.
isVector() - Method in interface org.flag4j.arrays.backend.MatrixMixin
Checks if a matrix can be represented as a vector.
isVector() - Method in interface org.flag4j.arrays.backend.MatrixMixinOld
Checks if a matrix can be represented as a vector.
isZero() - Method in class org.flag4j.algebraic_structures.fields.Complex128
Checks if this value is an additive identity for this semi-ring.
isZero() - Method in class org.flag4j.algebraic_structures.fields.Complex64
Checks if this value is an additive identity for this semi-ring.
isZero() - Method in class org.flag4j.algebraic_structures.fields.RealFloat32
Checks if this value is an additive identity for this semi-ring.
isZero() - Method in class org.flag4j.algebraic_structures.fields.RealFloat64
Checks if this value is an additive identity for this semi-ring.
isZero() - Method in class org.flag4j.algebraic_structures.rings.RealInt16
Checks if this value is an additive identity for this semi-ring.
isZero() - Method in class org.flag4j.algebraic_structures.rings.RealInt32
Checks if this value is an additive identity for this semi-ring.
isZero() - Method in class org.flag4j.algebraic_structures.semirings.BooleanRing
Checks if this value is an additive identity for this semi-ring.
isZero() - Method in interface org.flag4j.algebraic_structures.semirings.Semiring
Checks if this value is an additive identity for this semi-ring.
isZeros() - Method in interface org.flag4j.arrays.backend.field.FieldTensorMixin
Checks if this tensor only contains zeros.
isZeros() - Method in interface org.flag4j.arrays.backend.ring.RingTensorMixin
Checks if this tensor only contains zeros.
isZeros() - Method in interface org.flag4j.arrays.backend.semiring.SemiringTensorMixin
Checks if this tensor only contains zeros.
isZeros() - Method in interface org.flag4j.arrays.backend.semiring.TensorOverSemiRing
Checks if this tensor only contains zeros.
isZeros() - Method in class org.flag4j.arrays.backend.FieldTensorBase
Checks if this tensor only contains zeros.
isZeros() - Method in class org.flag4j.arrays.backend.PrimitiveDoubleTensorBase
Checks if this tensor only contains zeros.
isZeros() - Method in class org.flag4j.arrays.backend.TensorOverSemiRing
Checks if this tensor only contains zeros.
isZeros(double[]) - Static method in class org.flag4j.linalg.ops.common.real.RealProperties
Checks if an array contains only zeros.
isZeros(Semiring<T>[]) - Static method in class org.flag4j.linalg.ops.common.semiring_ops.SemiRingProperties
Checks if an array contains only zeros.
A B C D E F G H I J K L M N O P Q R S T U V W X Z 
All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form