Index
All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form
C
- center - Static variable in class org.flag4j.io.PrintOptions
-
A flag which indicates if each value should be centered within its column.
- center(String, int) - Static method in class org.flag4j.util.StringUtils
-
Centers a string within a specified size bin.
- center(String, int, String) - Static method in class org.flag4j.util.StringUtils
-
Centers a string within a specified size bin.
- checkConvergence(int) - Method in class org.flag4j.linalg.decompositions.schur.ComplexSchur
-
Checks for convergence of lower 2x2 sub-matrix within working matrix to upper triangular or block upper triangular form.
- checkConvergence(int) - Method in class org.flag4j.linalg.decompositions.schur.RealSchur
-
Checks for convergence of lower 2x2 sub-matrix within working matrix to upper triangular or block upper triangular form.
- checkConvergence(int) - Method in class org.flag4j.linalg.decompositions.schur.Schur
-
Checks for convergence of lower 2x2 sub-matrix within working matrix to upper triangular or block upper triangular form.
- checkFinite - Variable in class org.flag4j.linalg.decompositions.schur.Schur
-
Flag indicating if a check should be made during the decomposition that the working matrix contains only finite values.
- checkParams(T, int) - Method in class org.flag4j.linalg.solvers.exact.triangular.BackSolver
-
Ensures passed parameters are valid for the back solver.
- checkParams(T, int) - Method in class org.flag4j.linalg.solvers.exact.triangular.ForwardSolver
-
Ensures passed parameters are valid for the back solver.
- checkSingular(double, int, int) - Method in class org.flag4j.linalg.solvers.exact.triangular.BackSolver
-
Checks if the coefficient matrix is singular based on the computed determinant.
- checkSingular(double, int, int) - Method in class org.flag4j.linalg.solvers.exact.triangular.ForwardSolver
-
Checks if the coefficient matrix is singular based on the computed determinant.
- checkSize(int, int) - Method in class org.flag4j.linalg.solvers.exact.ExactTensorSolver
-
Ensures that
aNumEntries==prod
. - Cholesky<T> - Class in org.flag4j.linalg.decompositions.chol
-
This abstract class specifies methods for computing the Cholesky decomposition of a positive-definite matrix.
- Cholesky(boolean) - Constructor for class org.flag4j.linalg.decompositions.chol.Cholesky
-
Constructs a Cholesky decomposer.
- chooseAlgorithm(Shape) - Static method in class org.flag4j.linalg.ops.TransposeDispatcher
-
Chooses the appropriate matrix transpose algorithm based on the shape of a matrix.
- chooseAlgorithmComplex(Shape) - Static method in class org.flag4j.linalg.ops.TransposeDispatcher
-
Chooses the appropriate matrix transpose algorithm based on the shape of a matrix.
- chooseAlgorithmComplex(Shape, Shape) - Static method in class org.flag4j.linalg.ops.MatrixMultiplyDispatcher
-
Dynamically chooses matrix multiply algorithm based on the shapes of the two matrices to multiply.
- chooseAlgorithmComplexTranspose(Shape) - Static method in class org.flag4j.linalg.ops.MatrixMultiplyDispatcher
-
Dynamically chooses the matrix multiplication-transpose algorithm to used based on the shape of the first matrix.
- chooseAlgorithmComplexVector(Shape) - Static method in class org.flag4j.linalg.ops.MatrixMultiplyDispatcher
-
Dynamically chooses matrix-vector multiply algorithm based on the shapes of the matrix to multiply.
- chooseAlgorithmHermitian(Shape) - Static method in class org.flag4j.linalg.ops.TransposeDispatcher
-
Chooses the appropriate matrix hermitian transpose algorithm based on the shape of a matrix.
- chooseAlgorithmRealComplex(Shape, Shape) - Static method in class org.flag4j.linalg.ops.MatrixMultiplyDispatcher
-
Dynamically chooses matrix multiply algorithm based on the shapes of the two matrices to multiply.
- chooseAlgorithmRealComplexTranspose(Shape) - Static method in class org.flag4j.linalg.ops.MatrixMultiplyDispatcher
-
Dynamically chooses the matrix multiplication-transpose algorithm to used based on the shape of the first matrix.
- chooseAlgorithmRealComplexVector(Shape) - Static method in class org.flag4j.linalg.ops.MatrixMultiplyDispatcher
-
Dynamically chooses matrix-vector multiply algorithm based on the shapes of the matrix to multiply.
- chooseAlgorithmRealVector(Shape) - Static method in class org.flag4j.linalg.ops.MatrixMultiplyDispatcher
-
Dynamically chooses matrix-vector multiply algorithm based on the shapes of the matrix to multiply.
- chooseAlgorithmTensor(int) - Static method in class org.flag4j.linalg.ops.TransposeDispatcher
-
Chooses the appropriate algorithm for computing a tensor transpose.
- chooseAlgorithmTensor(int, int) - Static method in class org.flag4j.linalg.ops.TransposeDispatcher
-
Chooses the appropriate algorithm for computing a tensor transpose.
- close() - Method in class org.flag4j.io.TensorInputStream
-
Closes the stream.
- close() - Method in class org.flag4j.io.TensorOutputStream
-
Closes the stream.
- CMatrix - Class in org.flag4j.arrays.dense
-
A complex dense matrix backed by a
Complex128
array. - CMatrix(double[][]) - Constructor for class org.flag4j.arrays.dense.CMatrix
-
Constructs a complex matrix from a 2D array of double values.
- CMatrix(int) - Constructor for class org.flag4j.arrays.dense.CMatrix
-
Creates a square zero matrix with the specified
size
. - CMatrix(int, int) - Constructor for class org.flag4j.arrays.dense.CMatrix
-
Creates a zero matrix with the specified shape.
- CMatrix(int, int, double) - Constructor for class org.flag4j.arrays.dense.CMatrix
-
Constructs a matrix with the specified shape filled with
fillValue
. - CMatrix(int, int, Complex128) - Constructor for class org.flag4j.arrays.dense.CMatrix
-
Creates a complex matrix with the specified shape and filled with
fillValue
. - CMatrix(int, int, Field<Complex128>[]) - Constructor for class org.flag4j.arrays.dense.CMatrix
-
Creates a complex matrix with the specified
entries
, and shape. - CMatrix(int, Double) - Constructor for class org.flag4j.arrays.dense.CMatrix
-
Creates a square matrix with the specified
size
filled withfillValue
. - CMatrix(int, Complex128) - Constructor for class org.flag4j.arrays.dense.CMatrix
-
Creates a square matrix with the specified
size
filled withfillValue
. - CMatrix(String[][]) - Constructor for class org.flag4j.arrays.dense.CMatrix
-
Constructs a complex matrix from a 2D array of strings.
- CMatrix(Field<Complex128>[][]) - Constructor for class org.flag4j.arrays.dense.CMatrix
-
Constructs a complex matrix from a 2D array.
- CMatrix(CMatrix) - Constructor for class org.flag4j.arrays.dense.CMatrix
-
Constructs a copy of the specified matrix.
- CMatrix(Shape) - Constructor for class org.flag4j.arrays.dense.CMatrix
-
Creates a zero matrix with the specified
shape
. - CMatrix(Shape, double[]) - Constructor for class org.flag4j.arrays.dense.CMatrix
-
Constructs a complex matrix with specified
shape
andentries
. - CMatrix(Shape, Double) - Constructor for class org.flag4j.arrays.dense.CMatrix
-
Creates matrix with the specified
shape
filled withfillValue
. - CMatrix(Shape, Complex128) - Constructor for class org.flag4j.arrays.dense.CMatrix
-
Creates a complex matrix with the specified
shape
filled withfillValue
. - CMatrix(Shape, Field<Complex128>[]) - Constructor for class org.flag4j.arrays.dense.CMatrix
-
Creates a complex matrix with the specified
entries
andshape
. - colIndices - Variable in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringMatrix
-
column indices for non-zero value of this sparse COO matrix.
- colIndices - Variable in class org.flag4j.arrays.backend.semiring.CsrSemiRingMatrixBase
-
Column indices for non-zero values of this sparse CSR matrix.
- colIndices - Variable in record class org.flag4j.arrays.backend.SparseMatrixData
-
The field for the
colIndices
record component. - colIndices - Variable in class org.flag4j.arrays.backend.CooFieldMatrixBase
-
column indices for non-zero value of this sparse COO matrix.
- colIndices - Variable in class org.flag4j.arrays.backend.CsrFieldMatrixBase
-
Column indices for non-zero values of this sparse CSR matrix.
- colIndices - Variable in class org.flag4j.arrays.sparse.CooMatrix
-
column indices for non-zero value of this sparse COO matrix.
- colIndices - Variable in class org.flag4j.arrays.sparse.CsrMatrix
-
Column indices for non-zero values of this sparse CSR matrix.
- colIndices() - Method in record class org.flag4j.arrays.backend.SparseMatrixData
-
Returns the value of the
colIndices
record component. - colSwaps - Variable in class org.flag4j.linalg.decompositions.lu.LU
- CompareRing - Class in org.flag4j.linalg.ops.common.ring_ops
-
This utility class provides methods useful for comparing elements of a
Ring
. - CompareRing() - Constructor for class org.flag4j.linalg.ops.common.ring_ops.CompareRing
- CompareSemiring - Class in org.flag4j.linalg.ops.common.semiring_ops
-
This utility class provides methods useful for comparing elements of a
Semiring
. - CompareSemiring() - Constructor for class org.flag4j.linalg.ops.common.semiring_ops.CompareSemiring
- compareTo(Complex128) - Method in class org.flag4j.algebraic_structures.fields.Complex128
-
Compares this element of the field with
b
. - compareTo(Complex64) - Method in class org.flag4j.algebraic_structures.fields.Complex64
-
Compares this element of the field with
b
. - compareTo(RealFloat32) - Method in class org.flag4j.algebraic_structures.fields.RealFloat32
-
Compares this element of the ordered field with
b
. - compareTo(RealFloat64) - Method in class org.flag4j.algebraic_structures.fields.RealFloat64
-
Compares this element of the ordered field with
b
. - compareTo(RealInt16) - Method in class org.flag4j.algebraic_structures.rings.RealInt16
-
Compares this element of the ordered field with
b
. - compareTo(RealInt32) - Method in class org.flag4j.algebraic_structures.rings.RealInt32
-
Compares this element of the ordered field with
b
. - compareTo(BooleanRing) - Method in class org.flag4j.algebraic_structures.semirings.BooleanRing
-
Compares this element of the semi-ring with
b
. - compareTo(T) - Method in interface org.flag4j.algebraic_structures.fields.Field
-
Compares this element of the field with
b
. - compareTo(T) - Method in interface org.flag4j.algebraic_structures.semirings.Semiring
-
Compares this element of the semi-ring with
b
. - COMPLEX_BLOCKED_THRESHOLD - Static variable in class org.flag4j.linalg.ops.TransposeDispatcher
-
Threshold for using complex blocked algorithm.
- COMPLEX_RNG - Variable in class org.flag4j.rng.RandomDenseTensor
-
Complex pseudorandom number generator.
- COMPLEX_RNG - Variable in class org.flag4j.rng.RandomSparseTensor
-
Complex pseudorandom number generator.
- Complex128 - Class in org.flag4j.algebraic_structures.fields
-
A complex number stored in rectangular form and backed by two 64-bit floating point numbers (one for the real and one for the imaginary component).
- Complex128(double) - Constructor for class org.flag4j.algebraic_structures.fields.Complex128
-
Constructs a complex number with specified real component and zero imaginary component.
- Complex128(double, double) - Constructor for class org.flag4j.algebraic_structures.fields.Complex128
-
Constructs a complex number with specified complex and real components.
- Complex128(String) - Constructor for class org.flag4j.algebraic_structures.fields.Complex128
-
Constructs a complex number from a string of the form
"a +/- bi"
wherea
and {b} are real values and either may be omitted. - Complex128(Complex64) - Constructor for class org.flag4j.algebraic_structures.fields.Complex128
-
Constructs a 128-bit complex number from a 64-bit complex number.
- Complex128Operations - Class in org.flag4j.linalg.ops.common.complex
-
This class provides low level methods for computing operations on complex tensors.
- Complex128Operations() - Constructor for class org.flag4j.linalg.ops.common.complex.Complex128Operations
- Complex128Properties - Class in org.flag4j.linalg.ops.common.complex
-
This class contains low-level implementations for operations which check if a complex tensor satisfies some property.
- Complex128Properties() - Constructor for class org.flag4j.linalg.ops.common.complex.Complex128Properties
- Complex64 - Class in org.flag4j.algebraic_structures.fields
-
A complex number stored in rectangular form and backed by two 32-bit floating point number (one for the real and one for the imaginary component).
- Complex64(double) - Constructor for class org.flag4j.algebraic_structures.fields.Complex64
-
Constructs a complex number with specified real component and zero imaginary component.
- Complex64(double, double) - Constructor for class org.flag4j.algebraic_structures.fields.Complex64
-
Constructs a complex number with specified complex and real components.
- Complex64(float) - Constructor for class org.flag4j.algebraic_structures.fields.Complex64
-
Constructs a complex number with specified real component and zero imaginary component.
- Complex64(float, float) - Constructor for class org.flag4j.algebraic_structures.fields.Complex64
-
Constructs a complex number with specified complex and real components.
- Complex64(String) - Constructor for class org.flag4j.algebraic_structures.fields.Complex64
-
Constructs a complex number from a string of the form
"a +/- bi"
wherea
and {b} are real values and either may be omitted. - Complex64Operations - Class in org.flag4j.linalg.ops.common.complex
-
This class provides low level methods for computing operations on complex tensors.
- Complex64Operations() - Constructor for class org.flag4j.linalg.ops.common.complex.Complex64Operations
- Complex64Properties - Class in org.flag4j.linalg.ops.common.complex
-
This class contains low-level implementations for operations which check if a complex tensor satisfies some property.
- Complex64Properties() - Constructor for class org.flag4j.linalg.ops.common.complex.Complex64Properties
- ComplexBackSolver - Class in org.flag4j.linalg.solvers.exact.triangular
-
This solver solves linear systems of equations where the coefficient matrix in an upper triangular complex dense matrix and the constant vector is a complex dense vector.
- ComplexBackSolver() - Constructor for class org.flag4j.linalg.solvers.exact.triangular.ComplexBackSolver
-
Creates a solver for solving linear systems for upper triangular coefficient matrices.
- ComplexBackSolver(boolean) - Constructor for class org.flag4j.linalg.solvers.exact.triangular.ComplexBackSolver
-
Creates a solver for solving linear systems for upper triangular coefficient matrices.
- ComplexCholesky - Class in org.flag4j.linalg.decompositions.chol
-
An instance of this class allows for the computation of a Cholesky decomposition of a complex Hermitian positive-definite matrix.
- ComplexCholesky() - Constructor for class org.flag4j.linalg.decompositions.chol.ComplexCholesky
-
Constructs a complex Cholesky decomposer.
- ComplexCholesky(boolean) - Constructor for class org.flag4j.linalg.decompositions.chol.ComplexCholesky
-
Constructs a complex Cholesky decomposer.
- ComplexDenseDeterminant - Class in org.flag4j.linalg.ops.dense.complex
-
This class contains methods for computing the determinant of a complex dense matrix.
- ComplexDenseDeterminant() - Constructor for class org.flag4j.linalg.ops.dense.complex.ComplexDenseDeterminant
- ComplexDenseSetOperations - Class in org.flag4j.linalg.ops.dense.complex
-
This class contains low-level implementations of setting operations for complex dense tensors.
- ComplexDenseSetOperations() - Constructor for class org.flag4j.linalg.ops.dense.complex.ComplexDenseSetOperations
- ComplexExactSolver - Class in org.flag4j.linalg.solvers.exact
-
Solver for solving a well determined system of linear equations in an exact sense using the
LU decomposition.
- ComplexExactSolver() - Constructor for class org.flag4j.linalg.solvers.exact.ComplexExactSolver
-
Constructs an exact LU solver where the coefficient matrix is real dense.
- ComplexExactTensorSolver - Class in org.flag4j.linalg.solvers.exact
-
Solver for solving a complex well determined linear tensor equation A*X=B in an exact sense.
- ComplexExactTensorSolver() - Constructor for class org.flag4j.linalg.solvers.exact.ComplexExactTensorSolver
-
Creates an exact tensor solver for solving a well determined linear tensor equation A*X=B for X in an exact sense.
- ComplexForwardSolver - Class in org.flag4j.linalg.solvers.exact.triangular
-
This solver solves linear systems of equations where the coefficient matrix in a lower triangular complex dense matrix and the constant vector/matrix is complex and dense.
- ComplexForwardSolver() - Constructor for class org.flag4j.linalg.solvers.exact.triangular.ComplexForwardSolver
-
Creates a solver to solve a linear system where the coefficient matrix is lower triangular.
- ComplexForwardSolver(boolean) - Constructor for class org.flag4j.linalg.solvers.exact.triangular.ComplexForwardSolver
-
Creates a solver to solve a linear system where the coefficient matrix is lower triangular or unit lower triangular.
- ComplexForwardSolver(boolean, boolean) - Constructor for class org.flag4j.linalg.solvers.exact.triangular.ComplexForwardSolver
-
Creates a solver to solve a linear system where the coefficient matrix is lower triangular or unit lower triangular.
- ComplexHess - Class in org.flag4j.linalg.decompositions.hess
-
Computes the Hessenburg decomposition of a complex dense square matrix.
- ComplexHess() - Constructor for class org.flag4j.linalg.decompositions.hess.ComplexHess
-
Creates a complex Hessenburg decomposer.
- ComplexHess(boolean) - Constructor for class org.flag4j.linalg.decompositions.hess.ComplexHess
-
Creates a complex Hessenburg decomposer.
- ComplexLstsqSolver - Class in org.flag4j.linalg.solvers.lstsq
-
This class solves a linear system of equations Ax=b in a least-squares sense.
- ComplexLstsqSolver() - Constructor for class org.flag4j.linalg.solvers.lstsq.ComplexLstsqSolver
-
Constructs a least-squares solver to solve a system Ax=b in a least square sense.
- ComplexLU - Class in org.flag4j.linalg.decompositions.lu
-
Complex128his class provides methods for computing the LU decomposition of a complex dense matrix.
- ComplexLU() - Constructor for class org.flag4j.linalg.decompositions.lu.ComplexLU
-
Constructs a LU decomposer to decompose the specified matrix using partial pivoting.
- ComplexLU(int) - Constructor for class org.flag4j.linalg.decompositions.lu.ComplexLU
-
Constructs a LU decomposer to decompose the specified matrix.
- ComplexLU(int, double) - Constructor for class org.flag4j.linalg.decompositions.lu.ComplexLU
-
Constructs a LU decomposer to decompose the specified matrix.
- ComplexLU(LU.Pivoting) - Constructor for class org.flag4j.linalg.decompositions.lu.ComplexLU
-
Constructs a LU decomposer to decompose the specified matrix.
- ComplexNumberLexer - Class in org.flag4j.io.parsing
-
A lexer for producing the tokens of a complex number represented as a string.
- ComplexNumberLexer(String) - Constructor for class org.flag4j.io.parsing.ComplexNumberLexer
- ComplexNumberParser - Class in org.flag4j.io.parsing
-
A parser for parsing complex numbers represented as a string.
- ComplexNumberParser() - Constructor for class org.flag4j.io.parsing.ComplexNumberParser
- ComplexNumberParsingException - Exception Class in org.flag4j.util.exceptions
-
An exception which is thrown when a string representation of a complex number cannot be parsed.
- ComplexNumberParsingException(String) - Constructor for exception class org.flag4j.util.exceptions.ComplexNumberParsingException
-
Creates a
LinearAlgebraException
to be thrown for a complex number parsing related error. - ComplexNumberToken - Class in org.flag4j.io.parsing
-
A ComplexNumberToken is the smallest unit of a string which is being parsed to a complex number.
- ComplexNumberToken(String, String) - Constructor for class org.flag4j.io.parsing.ComplexNumberToken
-
Creates a token of the specified kind and with the specified details.
- ComplexOpsMixin<T> - Interface in org.flag4j.arrays.backend
-
This interface defines operations that complex-valued matrices should implement.
- ComplexQR - Class in org.flag4j.linalg.decompositions.qr
-
Instances of this class compute the
QR
decomposition of acomplex dense matrix
. - ComplexQR() - Constructor for class org.flag4j.linalg.decompositions.qr.ComplexQR
-
Creates a
QR
decomposer. - ComplexQR(boolean) - Constructor for class org.flag4j.linalg.decompositions.qr.ComplexQR
-
Creates a
QR
decomposer to compute either the full or reducedQR
decomposition. - ComplexSchur - Class in org.flag4j.linalg.decompositions.schur
-
This class computes the Schur decomposition of a complex dense square matrix.
- ComplexSchur() - Constructor for class org.flag4j.linalg.decompositions.schur.ComplexSchur
-
Creates a decomposer to compute the Schur decomposition for a complex dense matrix.
- ComplexSchur(boolean) - Constructor for class org.flag4j.linalg.decompositions.schur.ComplexSchur
-
Creates a decomposer to compute the Schur decomposition for a real dense matrix where the U matrix may or may not be computed.
- ComplexSchur(boolean, long) - Constructor for class org.flag4j.linalg.decompositions.schur.ComplexSchur
-
Creates a decomposer to compute the Schur decomposition for a real dense matrix.
- ComplexSchur(long) - Constructor for class org.flag4j.linalg.decompositions.schur.ComplexSchur
-
Creates a decomposer to compute the Schur decomposition for a real dense matrix.
- ComplexSparseMatrixGetSet - Class in org.flag4j.linalg.ops.sparse.coo.complex
-
This class contains methods for getting/setting elements and slices from/to a complex sparse matrix.
- ComplexSparseMatrixGetSet() - Constructor for class org.flag4j.linalg.ops.sparse.coo.complex.ComplexSparseMatrixGetSet
- ComplexSVD - Class in org.flag4j.linalg.decompositions.svd
-
Instances of this class can be used to compute the singular value decomposition (SVD) of a
complex dense matrix
. - ComplexSVD() - Constructor for class org.flag4j.linalg.decompositions.svd.ComplexSVD
-
Creates a decomposer to compute the singular value decomposition of a real matrix.
- ComplexSVD(boolean) - Constructor for class org.flag4j.linalg.decompositions.svd.ComplexSVD
-
Creates a decomposer to compute the Schur decomposition.
- ComplexSVD(boolean, boolean) - Constructor for class org.flag4j.linalg.decompositions.svd.ComplexSVD
-
Creates a decomposer to compute the singular value decomposition of a real matrix.
- ComplexUnitaryDecomposition - Class in org.flag4j.linalg.decompositions.unitary
-
This class is the base class for complex matrix decompositions which proceed by using unitary transformations (specifically Householder reflectors) to bring a matrix into an upper triangular/Hessenburg matrix.
- ComplexUnitaryDecomposition(int) - Constructor for class org.flag4j.linalg.decompositions.unitary.ComplexUnitaryDecomposition
-
Creates a real unitary decomposer which will reduce the matrix to an upper triangular/Hessenburg matrix which is has zeros below the specified sub-diagonal.
- ComplexUnitaryDecomposition(int, boolean) - Constructor for class org.flag4j.linalg.decompositions.unitary.ComplexUnitaryDecomposition
-
Creates a real unitary decomposer which will reduce the matrix to an upper triangular/Hessenburg matrix which is has zeros below the specified sub-diagonal.
- computeExceptionalShift(int) - Method in class org.flag4j.linalg.decompositions.schur.ComplexSchur
-
Computes a random shift to help the QR algorithm converge if it gets stuck.
- computeExceptionalShift(int) - Method in class org.flag4j.linalg.decompositions.schur.RealSchur
-
Computes a random shift to help the QR algorithm converge if it gets stuck.
- computeHouseholder(int) - Method in class org.flag4j.linalg.decompositions.unitary.ComplexUnitaryDecomposition
-
Computes the Householder vector for the first column of the sub-matrix with upper left corner at
(j, j)
. - computeHouseholder(int) - Method in class org.flag4j.linalg.decompositions.unitary.RealUnitaryDecomposition
-
Computes the HouseholderOld vector for the first column of the sub-matrix with upper left corner at
(j, j)
. - computeHouseholder(int) - Method in class org.flag4j.linalg.decompositions.unitary.UnitaryDecomposition
-
Computes the HouseholderOld vector for the first column of the sub-matrix with upper left corner at
(j, j)
. - computeImplicitDoubleShift(int) - Method in class org.flag4j.linalg.decompositions.schur.ComplexSchur
-
Computes the shifts for a Francis double shift iteration.
- computeImplicitDoubleShift(int) - Method in class org.flag4j.linalg.decompositions.schur.RealSchur
-
Computes the shifts for a Francis double shift iteration.
- computeImplicitSingleShift(int, double) - Method in class org.flag4j.linalg.decompositions.schur.RealSchur
-
Computes the non-zero entries of the first column for the single shifted QR algorithm.
- computeImplicitSingleShift(int, Complex128) - Method in class org.flag4j.linalg.decompositions.schur.ComplexSchur
-
Computes the non-zero entries of the first column for the single shifted QR algorithm.
- computePhasedNorm(int, double) - Method in class org.flag4j.linalg.decompositions.unitary.ComplexUnitaryDecomposition
-
Computes the norm of column
j
below thej
th row of the matrix to be decomposed. - computePhasedNorm(int, double) - Method in class org.flag4j.linalg.decompositions.unitary.RealUnitaryDecomposition
-
Computes the norm of column
j
below thej
th row of the matrix to be decomposed. - computePhasedNorm(int, double) - Method in class org.flag4j.linalg.decompositions.unitary.UnitaryDecomposition
-
Computes the norm of column
j
at and below thej
th row of the matrix to be decomposed. - computeRank(int, int, double[]) - Method in class org.flag4j.linalg.decompositions.svd.SVD
-
Computes the rank of the matrix being decomposed using the singular values of the matrix.
- computeRows(int) - Method in class org.flag4j.linalg.decompositions.lu.ComplexLU
-
Helper method which computes rows in the gaussian elimination algorithm.
- computeRows(int) - Method in class org.flag4j.linalg.decompositions.lu.FieldLU
-
Helper method which computes rows in the gaussian elimination algorithm.
- computeRows(int) - Method in class org.flag4j.linalg.decompositions.lu.RealLU
-
Helper method which computes rows in the gaussian elimination algorithm.
- computeSwaps() - Method in class org.flag4j.arrays.sparse.PermutationMatrix
-
Computes the number of row/column swaps required for this permutation matrix to be converted to the identity matrix.
- computeU - Variable in class org.flag4j.linalg.decompositions.schur.Schur
-
Flag indicating if the orthogonal matrix
U
in the Schur decomposition should be computed. - computeUV - Variable in class org.flag4j.linalg.decompositions.svd.SVD
-
Flag which indicates if the singular vectors should be computed in addition to the singular values.
- concat(Object[], Object[], Object[]) - Static method in class org.flag4j.linalg.ops.dense.DenseConcat
-
Concatenates two arrays and stores the result in
dest
. - CONCURRENT_BLOCKED - Enum constant in enum class org.flag4j.linalg.ops.dense.field_ops.DenseFieldMatMultDispatcher.AlgorithmNames
- CONCURRENT_BLOCKED - Enum constant in enum class org.flag4j.linalg.ops.dense.semiring_ops.DenseSemiRingMatMultDispatcher.AlgorithmNames
- CONCURRENT_BLOCKED - Enum constant in enum class org.flag4j.linalg.ops.MatrixMultiplyDispatcher.AlgorithmName
- CONCURRENT_BLOCKED - Enum constant in enum class org.flag4j.linalg.ops.RealDenseMatrixMultiplyDispatcher.AlgorithmNames
- CONCURRENT_BLOCKED - Enum constant in enum class org.flag4j.linalg.ops.TransposeDispatcher.TransposeAlgorithms
-
A concurrent implementation of the blocked algorithm
- CONCURRENT_BLOCKED_REORDERED - Enum constant in enum class org.flag4j.linalg.ops.dense.field_ops.DenseFieldMatMultDispatcher.AlgorithmNames
- CONCURRENT_BLOCKED_REORDERED - Enum constant in enum class org.flag4j.linalg.ops.dense.semiring_ops.DenseSemiRingMatMultDispatcher.AlgorithmNames
- CONCURRENT_BLOCKED_REORDERED - Enum constant in enum class org.flag4j.linalg.ops.MatrixMultiplyDispatcher.AlgorithmName
- CONCURRENT_BLOCKED_REORDERED - Enum constant in enum class org.flag4j.linalg.ops.RealDenseMatrixMultiplyDispatcher.AlgorithmNames
- CONCURRENT_BLOCKED_VECTOR - Enum constant in enum class org.flag4j.linalg.ops.dense.field_ops.DenseFieldMatMultDispatcher.AlgorithmNames
- CONCURRENT_BLOCKED_VECTOR - Enum constant in enum class org.flag4j.linalg.ops.dense.semiring_ops.DenseSemiRingMatMultDispatcher.AlgorithmNames
- CONCURRENT_BLOCKED_VECTOR - Enum constant in enum class org.flag4j.linalg.ops.MatrixMultiplyDispatcher.AlgorithmName
- CONCURRENT_BLOCKED_VECTOR - Enum constant in enum class org.flag4j.linalg.ops.RealDenseMatrixMultiplyDispatcher.AlgorithmNames
- CONCURRENT_REORDERED - Enum constant in enum class org.flag4j.linalg.ops.dense.field_ops.DenseFieldMatMultDispatcher.AlgorithmNames
- CONCURRENT_REORDERED - Enum constant in enum class org.flag4j.linalg.ops.dense.semiring_ops.DenseSemiRingMatMultDispatcher.AlgorithmNames
- CONCURRENT_REORDERED - Enum constant in enum class org.flag4j.linalg.ops.MatrixMultiplyDispatcher.AlgorithmName
- CONCURRENT_REORDERED - Enum constant in enum class org.flag4j.linalg.ops.RealDenseMatrixMultiplyDispatcher.AlgorithmNames
- CONCURRENT_STANDARD - Enum constant in enum class org.flag4j.linalg.ops.dense.field_ops.DenseFieldMatMultDispatcher.AlgorithmNames
- CONCURRENT_STANDARD - Enum constant in enum class org.flag4j.linalg.ops.dense.semiring_ops.DenseSemiRingMatMultDispatcher.AlgorithmNames
- CONCURRENT_STANDARD - Enum constant in enum class org.flag4j.linalg.ops.MatrixMultiplyDispatcher.AlgorithmName
- CONCURRENT_STANDARD - Enum constant in enum class org.flag4j.linalg.ops.RealDenseMatrixMultiplyDispatcher.AlgorithmNames
- CONCURRENT_STANDARD - Enum constant in enum class org.flag4j.linalg.ops.TransposeDispatcher.TransposeAlgorithms
-
A concurrent implementation of the standard algorithm
- CONCURRENT_STANDARD_VECTOR - Enum constant in enum class org.flag4j.linalg.ops.dense.field_ops.DenseFieldMatMultDispatcher.AlgorithmNames
- CONCURRENT_STANDARD_VECTOR - Enum constant in enum class org.flag4j.linalg.ops.dense.semiring_ops.DenseSemiRingMatMultDispatcher.AlgorithmNames
- CONCURRENT_STANDARD_VECTOR - Enum constant in enum class org.flag4j.linalg.ops.MatrixMultiplyDispatcher.AlgorithmName
- CONCURRENT_STANDARD_VECTOR - Enum constant in enum class org.flag4j.linalg.ops.RealDenseMatrixMultiplyDispatcher.AlgorithmNames
- CONCURRENT_SWAPPED_THRESHOLD - Static variable in class org.flag4j.linalg.ops.dense.field_ops.DenseFieldMatMultDispatcher
-
Threshold for matrices to use the concurrent ikj algorithm.
- CONCURRENT_SWAPPED_THRESHOLD - Static variable in class org.flag4j.linalg.ops.dense.semiring_ops.DenseSemiRingMatMultDispatcher
-
Threshold for matrices to use the concurrent ikj algorithm.
- CONCURRENT_SWAPPED_THRESHOLD - Static variable in class org.flag4j.linalg.ops.MatrixMultiplyDispatcher
-
Threshold for matrices to use the concurrent ikj algorithm.
- CONCURRENT_SWAPPED_THRESHOLD - Static variable in class org.flag4j.linalg.ops.RealDenseMatrixMultiplyDispatcher
-
Threshold for matrices to use the concurrent ikj algorithm.
- CONCURRENT_THRESHOLD - Static variable in class org.flag4j.linalg.ops.dense.field_ops.DenseFieldElemDiv
-
Minimum number of entries in each tensor to apply concurrent algorithm.
- CONCURRENT_THRESHOLD - Static variable in class org.flag4j.linalg.ops.dense.field_ops.DenseFieldElemMult
-
Minimum number of entries in each tensor to apply concurrent algorithm.
- CONCURRENT_THRESHOLD - Static variable in class org.flag4j.linalg.ops.dense.real_field_ops.RealFieldDenseElemDiv
-
Minimum number of entries in each tensor to apply concurrent algorithm.
- CONCURRENT_THRESHOLD - Static variable in class org.flag4j.linalg.ops.dense.real_field_ops.RealFieldDenseElemMult
-
Minimum number of entries in each tensor to apply concurrent algorithm.
- CONCURRENT_THRESHOLD - Static variable in class org.flag4j.linalg.ops.dense.real.RealDenseElemDiv
-
Minimum number of entries in each tensor to apply concurrent algorithm.
- CONCURRENT_THRESHOLD - Static variable in class org.flag4j.linalg.ops.dense.real.RealDenseElemMult
-
Minimum number of entries in each tensor to apply concurrent algorithm.
- CONCURRENT_THRESHOLD - Static variable in class org.flag4j.linalg.ops.dense.semiring_ops.DenseSemiRingElemMult
-
Minimum number of entries in each tensor to apply concurrent algorithm.
- CONCURRENT_THRESHOLD - Static variable in class org.flag4j.linalg.ops.TransposeDispatcher
-
Threshold for number of elements in matrix to use concurrent implementation.
- concurrentBlocked(double[], Shape, double[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real.RealDenseMatrixMultiplication
-
Computes the matrix multiplication of two real dense matrices using a concurrent implementation of a blocked algorithm.
- concurrentBlocked(double[], Shape, Field<T>[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real_field_ops.RealFieldDenseMatMult
-
Computes the matrix multiplication of a real dense matrix with a dense field matrix using a concurrent implementation of a blocked algorithm.
- concurrentBlocked(Field<T>[], Shape, double[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real_field_ops.RealFieldDenseMatMult
-
Computes the matrix multiplication of a real dense matrix with a dense field matrix using a concurrent implementation of a blocked algorithm.
- concurrentBlocked(Field<T>[], Shape, Field<T>[], Shape) - Static method in class org.flag4j.linalg.ops.dense.field_ops.DenseFieldMatrixMultiplication
-
Computes the matrix multiplication of two dense matrices using a concurrent implementation of a blocked algorithm.
- concurrentBlocked(Semiring<T>[], Shape, Semiring<T>[], Shape, Semiring<T>[]) - Static method in class org.flag4j.linalg.ops.dense.semiring_ops.DenseSemiRingMatMult
-
Computes the matrix multiplication of two dense matrices using a concurrent implementation of a blocked algorithm.
- concurrentBlockedOperation(int, int, TensorOperation) - Static method in class org.flag4j.concurrency.ThreadManager
-
Computes a specified blocked tensor operation concurrently by evenly dividing work among available threads (specified by
Configurations.getNumThreads()
). - concurrentBlockedReordered(double[], Shape, double[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real.RealDenseMatrixMultiplication
-
Computes the matrix multiplication of two real dense matrices using a concurrent implementation of a blocked algorithm with the j-k loops swapped.
- concurrentBlockedReordered(double[], Shape, Field<T>[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real_field_ops.RealFieldDenseMatMult
-
Computes the matrix multiplication of a real dense matrix with a dense field matrix using a concurrent implementation of a blocked algorithm with the j-k loops swapped.
- concurrentBlockedReordered(Field<T>[], Shape, double[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real_field_ops.RealFieldDenseMatMult
-
Computes the matrix multiplication of a real dense matrix with a dense field matrix using a concurrent implementation of a blocked algorithm with the j-k loops swapped.
- concurrentBlockedReordered(Field<T>[], Shape, Field<T>[], Shape) - Static method in class org.flag4j.linalg.ops.dense.field_ops.DenseFieldMatrixMultiplication
-
Computes the matrix multiplication of two dense matrices using a concurrent implementation of a blocked algorithm with the j-k loops swapped.
- concurrentBlockedReordered(Semiring<T>[], Shape, Semiring<T>[], Shape, Semiring<T>[]) - Static method in class org.flag4j.linalg.ops.dense.semiring_ops.DenseSemiRingMatMult
-
Computes the matrix multiplication of two dense matrices using a concurrent implementation of a blocked algorithm with the j-k loops swapped.
- concurrentBlockedVector(double[], Shape, double[], int[]) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real.RealDenseSparseMatrixMultiplication
-
Computes the dense matrix sparse vector multiplication using a blocked algorithm.
- concurrentBlockedVector(double[], Shape, double[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real.RealDenseMatrixMultiplication
-
Computes the multiplication of a real dense matrix with a real dense vector using a concurrent implementation of a blocked algorithm.
- concurrentBlockedVector(double[], Shape, Field<T>[], int[]) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real_field_ops.RealFieldDenseCooMatMult
-
Computes the dense matrix sparse vector multiplication using a blocked algorithm.
- concurrentBlockedVector(double[], Shape, Field<T>[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real_field_ops.RealFieldDenseMatMult
-
Computes the multiplication of a real dense matrix with a dense field vector using a concurrent implementation of a blocked algorithm.
- concurrentBlockedVector(Field<T>[], Shape, double[], int[]) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real_field_ops.RealFieldDenseCooMatMult
-
Computes the dense matrix sparse vector multiplication using a blocked algorithm.
- concurrentBlockedVector(Field<T>[], Shape, double[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real_field_ops.RealFieldDenseMatMult
-
Computes the multiplication of a real dense matrix with a dense field vector using a concurrent implementation of a blocked algorithm.
- concurrentBlockedVector(Field<T>[], Shape, Field<T>[], int[]) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.field_ops.DenseCooFieldMatMult
-
Computes the dense matrix sparse vector multiplication using a blocked algorithm.
- concurrentBlockedVector(Field<T>[], Shape, Field<T>[], Shape) - Static method in class org.flag4j.linalg.ops.dense.field_ops.DenseFieldMatrixMultiplication
-
Computes the multiplication of a dense matrix with a dense vector using a concurrent implementation of a blocked algorithm.
- concurrentBlockedVector(Semiring<T>[], Shape, Semiring<T>[], Shape, Semiring<T>[]) - Static method in class org.flag4j.linalg.ops.dense.semiring_ops.DenseSemiRingMatMult
-
Computes the multiplication of a dense matrix with a dense vector using a concurrent implementation of a blocked algorithm.
- concurrentOperation(int, TensorOperation) - Static method in class org.flag4j.concurrency.ThreadManager
-
Computes a specified tensor operation concurrently by evenly dividing work among available threads (specified by
Configurations.getNumThreads()
). - concurrentReordered(double[], Shape, double[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real.RealDenseMatrixMultiplication
-
Computes the matrix multiplication of two real dense matrices using a concurrent implementation of the standard matrix multiplication algorithm with j-k loops swapped.
- concurrentReordered(double[], Shape, Field<T>[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real_field_ops.RealFieldDenseMatMult
-
Computes the matrix multiplication of a real dense matrix with a dense field matrix using a concurrent implementation of the standard matrix multiplication algorithm with j-k loops swapped.
- concurrentReordered(Field<T>[], Shape, double[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real_field_ops.RealFieldDenseMatMult
-
Computes the matrix multiplication of a real dense matrix with a dense field matrix using a concurrent implementation of the standard matrix multiplication algorithm with j-k loops swapped.
- concurrentReordered(Field<T>[], Shape, Field<T>[], Shape) - Static method in class org.flag4j.linalg.ops.dense.field_ops.DenseFieldMatrixMultiplication
-
Computes the matrix multiplication of two dense matrices using a concurrent implementation of the standard matrix multiplication algorithm with j-k loops swapped.
- concurrentReordered(Semiring<T>[], Shape, Semiring<T>[], Shape, Semiring<T>[]) - Static method in class org.flag4j.linalg.ops.dense.semiring_ops.DenseSemiRingMatMult
-
Computes the matrix multiplication of two dense matrices using a concurrent implementation of the standard matrix multiplication algorithm with j-k loops swapped.
- concurrentStandard(double[], int[], int[], Shape, double[], int[], int[], Shape) - Static method in class org.flag4j.linalg.ops.sparse.coo.real.RealSparseMatrixMultiplication
-
Computes the matrix multiplication between two sparse matrices using a concurrent implementation of the standard algorithm.
- concurrentStandard(double[], int[], int[], Shape, double[], Shape) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real.RealDenseSparseMatrixMultiplication
-
Computes the matrix multiplication between a real sparse matrix and a real dense matrix using a concurrent standard algorithm.
- concurrentStandard(double[], int[], int[], Shape, Field<Complex128>[], int[], int[], Shape) - Static method in class org.flag4j.linalg.ops.sparse.coo.real_complex.RealComplexSparseMatrixMultiplication
-
Computes the matrix multiplication between two sparse matrices using a concurrent implementation of the standard algorithm.
- concurrentStandard(double[], int[], int[], Shape, Field<T>[], Shape) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real_field_ops.RealFieldDenseCooMatMult
-
Computes the matrix multiplication between a real sparse matrix and a dense field matrix using a concurrent standard algorithm.
- concurrentStandard(double[], Shape, double[], int[], int[], Shape) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real.RealDenseSparseMatrixMultiplication
-
Computes the matrix multiplication between a real dense matrix and a real sparse matrix using a concurrent standard algorithm.
- concurrentStandard(double[], Shape, double[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real.RealDenseMatrixMultiplication
-
Computes the matrix multiplication of two real dense matrices using a concurrent implementation of the standard matrix multiplication algorithm.
- concurrentStandard(double[], Shape, Field<T>[], int[], int[], Shape) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real_field_ops.RealFieldDenseCooMatMult
-
Computes the matrix multiplication between a real dense matrix and a sparse field matrix using a concurrent standard algorithm.
- concurrentStandard(double[], Shape, Field<T>[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real_field_ops.RealFieldDenseMatMult
-
Computes the matrix multiplication of a real dense matrix with a dense field matrix using a concurrent implementation of the standard matrix multiplication algorithm.
- concurrentStandard(Field<Complex128>[], int[], int[], Shape, double[], int[], int[], Shape) - Static method in class org.flag4j.linalg.ops.sparse.coo.real_complex.RealComplexSparseMatrixMultiplication
-
Computes the matrix multiplication between two sparse matrices using a concurrent implementation of the standard algorithm.
- concurrentStandard(Field<T>[], int[], int[], Shape, double[], Shape) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real_field_ops.RealFieldDenseCooMatMult
-
Computes the matrix multiplication between a real sparse matrix and a dense field matrix using a concurrent standard algorithm.
- concurrentStandard(Field<T>[], int[], int[], Shape, Field<T>[], int[], int[], Shape) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatMult
-
Computes the matrix multiplication between two sparse matrices using a concurrent implementation of the standard algorithm.
- concurrentStandard(Field<T>[], int[], int[], Shape, Field<T>[], Shape) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.field_ops.DenseCooFieldMatMult
-
Computes the matrix multiplication between a real sparse matrix and a real dense matrix using a concurrent standard algorithm.
- concurrentStandard(Field<T>[], Shape, double[], int[], int[], Shape) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real_field_ops.RealFieldDenseCooMatMult
-
Computes the matrix multiplication between a real dense matrix and a sparse field matrix using a concurrent standard algorithm.
- concurrentStandard(Field<T>[], Shape, double[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real_field_ops.RealFieldDenseMatMult
-
Computes the matrix multiplication of a real dense matrix with a dense field matrix using a concurrent implementation of the standard matrix multiplication algorithm.
- concurrentStandard(Field<T>[], Shape, Field<T>[], int[], int[], Shape) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.field_ops.DenseCooFieldMatMult
-
Computes the matrix multiplication between a real dense matrix and a real sparse matrix using a concurrent standard algorithm.
- concurrentStandard(Field<T>[], Shape, Field<T>[], Shape) - Static method in class org.flag4j.linalg.ops.dense.field_ops.DenseFieldMatrixMultiplication
-
Computes the matrix multiplication of two dense matrices using a concurrent implementation of the standard matrix multiplication algorithm.
- concurrentStandard(Semiring<T>[], int[], int[], Shape, Semiring<T>[], int[], int[], Shape) - Static method in class org.flag4j.linalg.ops.sparse.coo.semiring_ops.CooSemiringMatMult
-
Computes the matrix multiplication between two sparse matrices using a concurrent implementation of the standard algorithm.
- concurrentStandard(Semiring<T>[], Shape, Semiring<T>[], Shape, Semiring<T>[]) - Static method in class org.flag4j.linalg.ops.dense.semiring_ops.DenseSemiRingMatMult
-
Computes the matrix multiplication of two dense matrices using a concurrent implementation of the standard matrix multiplication algorithm.
- concurrentStandardVector(double[], int[], int[], Shape, double[], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.real.RealSparseMatrixMultiplication
-
Computes the multiplication between a sparse matrix and a sparse vector using a concurrent implementation of the standard algorithm.
- concurrentStandardVector(double[], int[], int[], Shape, double[], Shape) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real.RealDenseSparseMatrixMultiplication
-
Computes the sparse matrix dense vector multiplication using a concurrent standard algorithm.
- concurrentStandardVector(double[], int[], int[], Shape, Field<Complex128>[], int[], Shape) - Static method in class org.flag4j.linalg.ops.sparse.coo.real_complex.RealComplexSparseMatrixMultiplication
-
Computes the multiplication between a sparse matrix and a sparse vector using a concurrent implementation of the standard algorithm.
- concurrentStandardVector(double[], int[], int[], Shape, Field<T>[], Shape) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real_field_ops.RealFieldDenseCooMatMult
-
Computes the sparse matrix dense vector multiplication using a concurrent standard algorithm.
- concurrentStandardVector(double[], Shape, double[], int[]) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real.RealDenseSparseMatrixMultiplication
-
Computes the dense matrix sparse vector multiplication using a concurrent standard algorithm.
- concurrentStandardVector(double[], Shape, double[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real.RealDenseMatrixMultiplication
-
Computes the multiplication of a real dense matrix with a real dense vector using a concurrent implementation of the standard matrix multiplication algorithm.
- concurrentStandardVector(double[], Shape, Field<T>[], int[]) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real_field_ops.RealFieldDenseCooMatMult
-
Computes the dense matrix sparse vector multiplication using a concurrent standard algorithm.
- concurrentStandardVector(double[], Shape, Field<T>[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real_field_ops.RealFieldDenseMatMult
-
Computes the multiplication of a real dense matrix with a dense field vector using a concurrent implementation of the standard matrix multiplication algorithm.
- concurrentStandardVector(Field<Complex128>[], int[], int[], Shape, double[], int[], Shape) - Static method in class org.flag4j.linalg.ops.sparse.coo.real_complex.RealComplexSparseMatrixMultiplication
-
Computes the multiplication between a sparse matrix and a sparse vector using a concurrent implementation of the standard algorithm.
- concurrentStandardVector(Field<T>[], int[], int[], Shape, double[], Shape) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real_field_ops.RealFieldDenseCooMatMult
-
Computes the sparse matrix dense vector multiplication using a concurrent standard algorithm.
- concurrentStandardVector(Field<T>[], int[], int[], Shape, Field<T>[], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatMult
-
Computes the multiplication between a sparse matrix and a sparse vector using a concurrent implementation of the standard algorithm.
- concurrentStandardVector(Field<T>[], int[], int[], Shape, Field<T>[], Shape) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.field_ops.DenseCooFieldMatMult
-
Computes the sparse matrix dense vector multiplication using a concurrent standard algorithm.
- concurrentStandardVector(Field<T>[], Shape, double[], int[]) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.real_field_ops.RealFieldDenseCooMatMult
-
Computes the dense matrix sparse vector multiplication using a concurrent standard algorithm.
- concurrentStandardVector(Field<T>[], Shape, double[], Shape) - Static method in class org.flag4j.linalg.ops.dense.real_field_ops.RealFieldDenseMatMult
-
Computes the multiplication of a real dense matrix with a dense field vector using a concurrent implementation of the standard matrix multiplication algorithm.
- concurrentStandardVector(Field<T>[], Shape, Field<T>[], int[]) - Static method in class org.flag4j.linalg.ops.dense_sparse.coo.field_ops.DenseCooFieldMatMult
-
Computes the dense matrix sparse vector multiplication using a concurrent standard algorithm.
- concurrentStandardVector(Field<T>[], Shape, Field<T>[], Shape) - Static method in class org.flag4j.linalg.ops.dense.field_ops.DenseFieldMatrixMultiplication
-
Computes the multiplication of a dense matrix with a dense vector using a concurrent implementation of the standard matrix multiplication algorithm.
- concurrentStandardVector(Semiring<T>[], int[], int[], Shape, Semiring<T>[], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.semiring_ops.CooSemiringMatMult
-
Computes the multiplication between a sparse matrix and a sparse vector using a concurrent implementation of the standard algorithm.
- concurrentStandardVector(Semiring<T>[], Shape, Semiring<T>[], Shape, Semiring<T>[]) - Static method in class org.flag4j.linalg.ops.dense.semiring_ops.DenseSemiRingMatMult
-
Computes the multiplication of a dense matrix with a dense vector using a concurrent implementation of the standard matrix multiplication algorithm.
- Condition - Class in org.flag4j.linalg
-
Utility class for computing the condition number of a matrix.
- Condition() - Constructor for class org.flag4j.linalg.Condition
- Configurations - Class in org.flag4j.concurrency
-
Configurations for standard and concurrent operations.
- Configurations() - Constructor for class org.flag4j.concurrency.Configurations
- conj() - Method in class org.flag4j.algebraic_structures.fields.Complex128
-
Computes the conjugate of this field element.
- conj() - Method in class org.flag4j.algebraic_structures.fields.Complex64
-
Computes the conjugate of this field element.
- conj() - Method in interface org.flag4j.algebraic_structures.rings.Ring
-
Computs the conjugation of this ring element.
- conj() - Method in interface org.flag4j.arrays.backend.field.FieldTensorMixin
-
Computes the element-wise conjugation of this tensor.
- conj() - Method in interface org.flag4j.arrays.backend.ring.RingTensorMixin
-
Computes the element-wise conjugation of this tensor.
- conj() - Method in interface org.flag4j.arrays.backend.ring.TensorOverRing
-
Computes the element-wise conjugation of this tensor.
- conj() - Method in interface org.flag4j.arrays.backend.ComplexOpsMixin
-
Computes the element-wise conjugation of this tensor.
- conj() - Method in class org.flag4j.arrays.backend.FieldTensorBase
-
Computes the element-wise conjugation of this tensor.
- conj() - Method in class org.flag4j.arrays.backend.PrimitiveDoubleTensorBase
-
Computes the element-wise conjugation of this tensor.
- conj() - Method in class org.flag4j.arrays.backend.TensorOverRing
-
Computes the element-wise conjugation of this tensor.
- conj() - Method in class org.flag4j.arrays.dense.Matrix
-
Computes the element-wise conjugation of this tensor.
- conj() - Method in class org.flag4j.arrays.dense.Vector
-
Computes the element-wise conjugation of this tensor.
- conj(Field<Complex128>[]) - Static method in class org.flag4j.linalg.ops.common.complex.Complex128Operations
-
Computes the element-wise complex conjugate of a tensor.
- conj(Field<V>[], Field<V>[]) - Static method in class org.flag4j.linalg.ops.common.field_ops.FieldOps
-
Computes the element-wise complex conjugate of a tensor.
- conj(Ring<T>[], Ring<T>[]) - Static method in class org.flag4j.linalg.ops.common.ring_ops.RingOps
-
Computes the element-wise conjugation of an array.
- contains(double[], double) - Static method in class org.flag4j.util.ArrayUtils
-
Checks if an array contains a specified value.
- contains(double[], double...) - Static method in class org.flag4j.util.ArrayUtils
-
Checks if a set of keys are in an array.
- contains(int[], int) - Static method in class org.flag4j.util.ArrayUtils
-
Checks if an array contains a specified value.
- contains(int[], int...) - Static method in class org.flag4j.util.ArrayUtils
-
Checks if a set of keys is in an array.
- content - Variable in class org.flag4j.io.parsing.ComplexNumberLexer
-
Content of the lexer.
- CooCMatrix - Class in org.flag4j.arrays.sparse
-
A complex sparse matrix stored in coordinate list (COO) format.
- CooCMatrix(int) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
-
Constructs a square sparse COO matrix with the specified
size
filled with zeros. - CooCMatrix(int, int) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
-
Constructs a zero matrix of the specified shape.
- CooCMatrix(int, int, List<Field<Complex128>>, List<Integer>, List<Integer>) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
-
Creates a sparse coo matrix with the specified non-zero entries, non-zero indices, and shape.
- CooCMatrix(int, int, Field<Complex128>[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
-
Creates a sparse coo matrix with the specified non-zero entries, non-zero indices, and shape.
- CooCMatrix(int, Field<Complex128>[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
-
Constructs a square complex sparse COO matrix with the specified
size
, non-zero values, and non-zero indices. - CooCMatrix(Shape) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
-
Constructs a zero matrix of the specified shape.
- CooCMatrix(Shape, double[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
-
Creates a sparse coo matrix with the specified non-zero entries, non-zero indices, and shape.
- CooCMatrix(Shape, List<Field<Complex128>>, List<Integer>, List<Integer>) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
-
Creates a sparse coo matrix with the specified non-zero entries, non-zero indices, and shape.
- CooCMatrix(Shape, Field<Complex128>[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
-
Creates a sparse coo matrix with the specified non-zero entries, non-zero indices, and shape.
- CooCMatrix(CooCMatrix) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
-
Constructs a copy of the specified complex sparse COO matrix.
- CooConcat - Class in org.flag4j.linalg.ops.sparse.coo
-
This utility class contains methods for combining or joining sparse COO tensors, matrices, and vectors.
- CooConcat() - Constructor for class org.flag4j.linalg.ops.sparse.coo.CooConcat
- CooCTensor - Class in org.flag4j.arrays.sparse
-
Sparse complex tensor stored in coordinate list (COO) format.
- CooCTensor(Shape) - Constructor for class org.flag4j.arrays.sparse.CooCTensor
-
Creates a tensor with the specified entries and shape.
- CooCTensor(Shape, double[], int[][]) - Constructor for class org.flag4j.arrays.sparse.CooCTensor
-
Creates a tensor with the specified entries and shape.
- CooCTensor(Shape, List<Field<Complex128>>, List<int[]>) - Constructor for class org.flag4j.arrays.sparse.CooCTensor
-
Creates a tensor with the specified entries and shape.
- CooCTensor(Shape, Complex64[], int[][]) - Constructor for class org.flag4j.arrays.sparse.CooCTensor
-
Creates a tensor with the specified entries and shape.
- CooCTensor(Shape, Field<Complex128>[], int[][]) - Constructor for class org.flag4j.arrays.sparse.CooCTensor
-
Creates a tensor with the specified entries and shape.
- CooCTensor(CooCTensor) - Constructor for class org.flag4j.arrays.sparse.CooCTensor
-
Constructs a copy of a sparse COO tensor.
- CooCTensor64 - Class in org.flag4j.arrays.sparse
-
Sparse complex tensor stored in coordinate list (COO) format.
- CooCTensor64(Shape) - Constructor for class org.flag4j.arrays.sparse.CooCTensor64
-
Creates a tensor with the specified entries and shape.
- CooCTensor64(Shape, List<Field<Complex64>>, List<int[]>) - Constructor for class org.flag4j.arrays.sparse.CooCTensor64
-
Creates a tensor with the specified entries and shape.
- CooCTensor64(Shape, Field<Complex64>[], int[][]) - Constructor for class org.flag4j.arrays.sparse.CooCTensor64
-
Creates a tensor with the specified entries and shape.
- CooCVector - Class in org.flag4j.arrays.sparse
-
A complex sparse vector stored in coordinate list (COO) format.
- CooCVector(int) - Constructor for class org.flag4j.arrays.sparse.CooCVector
-
Constructs a zero vector of the specified
size
. - CooCVector(int, double[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooCVector
-
Constructs a sparse complex COO vector from an array of double values.
- CooCVector(int, List<Field<Complex128>>, List<Integer>) - Constructor for class org.flag4j.arrays.sparse.CooCVector
-
Constructs a complex COO vector with the specified size, non-zero entries, and non-zero indices.
- CooCVector(int, Field<Complex128>[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooCVector
-
Creates a tensor with the specified entries and shape.
- CooCVector(CooCVector) - Constructor for class org.flag4j.arrays.sparse.CooCVector
-
Constructs a copy of the specified vector.
- CooDataSorter<T> - Class in org.flag4j.linalg.ops.sparse.coo
-
A class which can be used to sort the indices, along with data values, in lexicographical order.
- CooDataSorter(List<T>, List<Integer>, List<Integer>) - Constructor for class org.flag4j.linalg.ops.sparse.coo.CooDataSorter
-
Creates a sorter which can sort the indices and values of a COO matrix lexicographically.
- CooDataSorter(T[], int[][], boolean) - Constructor for class org.flag4j.linalg.ops.sparse.coo.CooDataSorter
-
Wraps the data, and it's associated indices, of a sparse tensor.
- CooFieldElementSearch - Class in org.flag4j.linalg.ops.sparse.coo.field_ops
-
Utility class for searching for specific elements within a sparse COO matrix.
- CooFieldElementSearch() - Constructor for class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldElementSearch
- CooFieldEquals - Class in org.flag4j.linalg.ops.sparse.coo.field_ops
-
This utility class contains methods for checking the equality, or approximately equal, of sparse tensors whose entries are
field
elements. - CooFieldEquals() - Constructor for class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldEquals
- CooFieldMatMult - Class in org.flag4j.linalg.ops.sparse.coo.field_ops
-
This class contains low level methods for computing the matrix multiplication of sparse
Field
matrices/vectors. - CooFieldMatMult() - Constructor for class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatMult
- CooFieldMatrix<T> - Class in org.flag4j.arrays.sparse
-
A sparse matrix stored in coordinate list (COO) format.
- CooFieldMatrix(int, int, List<Field<T>>, List<Integer>, List<Integer>) - Constructor for class org.flag4j.arrays.sparse.CooFieldMatrix
-
Creates a sparse coo matrix with the specified non-zero entries, non-zero indices, and shape.
- CooFieldMatrix(int, int, Field<T>[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooFieldMatrix
-
Creates a sparse coo matrix with the specified non-zero entries, non-zero indices, and shape.
- CooFieldMatrix(Shape, List<Field<T>>, List<Integer>, List<Integer>) - Constructor for class org.flag4j.arrays.sparse.CooFieldMatrix
-
Creates a sparse coo matrix with the specified non-zero entries, non-zero indices, and shape.
- CooFieldMatrix(Shape, Field<T>[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooFieldMatrix
-
Creates a sparse coo matrix with the specified non-zero entries, non-zero indices, and shape.
- CooFieldMatrixBase<T,
U, - Class in org.flag4j.arrays.backendV, W, Y> -
A real sparse matrix stored in coordinate list (COO) format.
- CooFieldMatrixBase(Shape, List<Field<Y>>, List<Integer>, List<Integer>) - Constructor for class org.flag4j.arrays.backend.CooFieldMatrixBase
-
Creates a sparse coo matrix with the specified non-zero entries, non-zero indices, and shape.
- CooFieldMatrixBase(Shape, Field<Y>[], int[], int[]) - Constructor for class org.flag4j.arrays.backend.CooFieldMatrixBase
-
Creates a sparse coo matrix with the specified non-zero entries, non-zero indices, and shape.
- CooFieldMatrixGetSet - Class in org.flag4j.linalg.ops.sparse.coo.field_ops
-
This class contains methods for getting/setting elements and slices from/to a sparse
Field
matrix. - CooFieldMatrixGetSet() - Constructor for class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatrixGetSet
- CooFieldMatrixManipulations - Class in org.flag4j.linalg.ops.sparse.coo.field_ops
-
This class contains implementations for sparse
Field
matrix manipulations. - CooFieldMatrixManipulations() - Constructor for class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatrixManipulations
- CooFieldMatrixOperations - Class in org.flag4j.linalg.ops.sparse.coo.field_ops
-
This class has low level implementations for operations between two sparse coo
Field
matrices. - CooFieldMatrixOperations() - Constructor for class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatrixOperations
- CooFieldMatrixProperties - Class in org.flag4j.linalg.ops.sparse.coo.field_ops
-
This class contains low level implementations for methods to evaluate certain properties of a sparse coo field matrix.
- CooFieldMatrixProperties() - Constructor for class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatrixProperties
- CooFieldNorms - Class in org.flag4j.linalg.ops.sparse.coo.field_ops
-
This utility class contains low level implementations of norms for sparse field coo tensors, matrices and vectors.
- CooFieldNorms() - Constructor for class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldNorms
- CooFieldTensor<T> - Class in org.flag4j.arrays.sparse
-
Sparse tensor stored in coordinate list (COO) format.
- CooFieldTensor(Shape, List<Field<T>>, List<int[]>) - Constructor for class org.flag4j.arrays.sparse.CooFieldTensor
-
Creates a tensor with the specified entries and shape.
- CooFieldTensor(Shape, Field<T>[], int[][]) - Constructor for class org.flag4j.arrays.sparse.CooFieldTensor
-
creates a tensor with the specified entries and shape.
- CooFieldTensorBase<T,
U, - Class in org.flag4j.arrays.backendV> -
Base class for all sparse tensors stored in coordinate list (COO) format.
- CooFieldTensorBase(Shape, Field<V>[], int[][]) - Constructor for class org.flag4j.arrays.backend.CooFieldTensorBase
-
Creates a tensor with the specified entries and shape.
- CooFieldTensorDot - Class in org.flag4j.linalg.ops.sparse.coo.field_ops
-
Utility class for computing tensor dot products between two COO field tensors.
- CooFieldTensorDot() - Constructor for class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldTensorDot
- CooFieldTensorOperations - Class in org.flag4j.linalg.ops.sparse.coo.field_ops
-
Utility class for computing operations between two sparse COO tensors whose elements are members of a
Field
. - CooFieldTensorOperations() - Constructor for class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldTensorOperations
- CooFieldVector<T> - Class in org.flag4j.arrays.sparse
-
A sparse vector stored in coordinate list (COO) format.
- CooFieldVector(int) - Constructor for class org.flag4j.arrays.sparse.CooFieldVector
-
Creates a zero vector of the specified
size
. - CooFieldVector(int, List<Field<T>>, List<Integer>) - Constructor for class org.flag4j.arrays.sparse.CooFieldVector
-
Creates sparse COO vector with the specified
size
, non-zero entries, and non-zero indices. - CooFieldVector(int, Field<T>[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooFieldVector
-
Creates sparse COO vector with the specified
size
, non-zero entries, and non-zero indices. - CooFieldVectorBase<T,
U, - Class in org.flag4j.arrays.backendV, W, Y> -
A sparse vector stored in coordinate list (COO) format.
- CooFieldVectorBase(int, Field<Y>[], int[]) - Constructor for class org.flag4j.arrays.backend.CooFieldVectorBase
-
Creates a tensor with the specified entries and shape.
- CooFieldVectorOperations - Class in org.flag4j.linalg.ops.sparse.coo.field_ops
-
This utility class contains methods for computing operations between two sparse coo
Field
vectors. - CooFieldVectorOperations() - Constructor for class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldVectorOperations
- cooFlattenIndices(Shape, int[][]) - Static method in class org.flag4j.linalg.ops.sparse.SparseUtils
-
Flattens the non-zero indices of a sparse COO tensor.
- cooFlattenIndices(Shape, int[][], int) - Static method in class org.flag4j.linalg.ops.sparse.SparseUtils
-
Flattens the non-zero indices of a sparse COO tensor along a specified axis.
- CooGetSet - Class in org.flag4j.linalg.ops.sparse.coo
-
A utility class that aids in getting or setting specified elements of a sparse COO tensor, matrix, or vector.
- CooGetSet() - Constructor for class org.flag4j.linalg.ops.sparse.coo.CooGetSet
- cooInsertNewValue(T, int[], T[], int[][], int, T[], int[][]) - Static method in class org.flag4j.linalg.ops.sparse.coo.CooGetSet
-
Inserts a new value into a sparse COO tensor.
- cooInsertNewValue(T, int, int, T[], int[], int[], int, T[], int[], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.CooGetSet
-
Inserts a new value into a sparse COO matrix.
- cooInsertNewValue(T, int, T[], int[], int, T[], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.CooGetSet
-
Inserts a new value into a sparse COO vector.
- CooManipulations - Class in org.flag4j.linalg.ops.sparse.coo
-
Utility class containing methods for manipulating a sparse COO tensor, matrix, or vector.
- CooManipulations() - Constructor for class org.flag4j.linalg.ops.sparse.coo.CooManipulations
- CooMatrix - Class in org.flag4j.arrays.sparse
-
A real sparse matrix stored in coordinate list (COO) format.
- CooMatrix(int) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
-
Constructs a square zero matrix with the specified size.
- CooMatrix(int, double[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
-
Creates a square sparse COO matrix with the specified size, non-zero entries, and non-zero indices.
- CooMatrix(int, int) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
-
Constructs a zero matrix with the specified shape.
- CooMatrix(int, int, double[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
-
Creates a sparse coo matrix with the specified non-zero entries, non-zero indices, and shape.
- CooMatrix(Shape) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
-
Constructs a zero matrix with the specified shape.
- CooMatrix(Shape, double[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
-
Creates a sparse coo matrix with the specified non-zero entries, non-zero indices, and shape.
- CooMatrix(Shape, int[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
-
Creates a sparse coo matrix with the specified non-zero entries, non-zero indices, and shape.
- CooMatrix(Shape, List<Double>, List<Integer>, List<Integer>) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
-
Creates a sparse coo matrix with the specified non-zero entries, non-zero indices, and shape.
- CooMatrix(CooMatrix) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
-
Constructs a copy of a real sparse COO matrix.
- cooMatrixEquals(CooFieldMatrixBase<?, ?, ?, ?, T>, CooFieldMatrixBase<?, ?, ?, ?, T>) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldEquals
-
Checks if two real sparse matrices are real.
- cooMatrixEquals(CooMatrix, CooMatrix) - Static method in class org.flag4j.linalg.ops.sparse.coo.real.RealSparseEquals
-
Checks if two real sparse matrices are real.
- CooMatrixMixin<T,
U, - Interface in org.flag4j.arrays.backendV, W, X, Y> -
This interface specifies methods which all sparse COO matrices should implement.
- cooReshape(Shape, Shape, int[][]) - Static method in class org.flag4j.linalg.ops.sparse.SparseUtils
-
Computes new indices for the reshaping of a sparse COO tensor.
- CooSemiringMatMult - Class in org.flag4j.linalg.ops.sparse.coo.semiring_ops
-
This utility class contains methods useful for computing the matrix multiplication between two sparse COO
Semiring
tensors. - CooSemiringMatMult() - Constructor for class org.flag4j.linalg.ops.sparse.coo.semiring_ops.CooSemiringMatMult
- CooSemiringMatrixOps - Class in org.flag4j.linalg.ops.sparse.coo.semiring_ops
-
Utility class for computing various operations on and between sparse COO
Semiring
matrices. - CooSemiringMatrixOps() - Constructor for class org.flag4j.linalg.ops.sparse.coo.semiring_ops.CooSemiringMatrixOps
- CooSemiringMatrixProperties - Class in org.flag4j.linalg.ops.sparse.coo.semiring_ops
-
This class contains low level implementations for methods to evaluate certain properties of a sparse COO
Semiring
matrix. - CooSemiringMatrixProperties() - Constructor for class org.flag4j.linalg.ops.sparse.coo.semiring_ops.CooSemiringMatrixProperties
- CooSemiringTensorOps - Class in org.flag4j.linalg.ops.sparse.coo.semiring_ops
-
This utility class contains methods for computing operations on two
Semiring
tensors. - CooSemiringTensorOps() - Constructor for class org.flag4j.linalg.ops.sparse.coo.semiring_ops.CooSemiringTensorOps
- CooSemiringVectorOps - Class in org.flag4j.linalg.ops.sparse.coo.semiring_ops
-
Utility class for computing operations between sparse COO
Semiring
vectors. - CooSemiringVectorOps() - Constructor for class org.flag4j.linalg.ops.sparse.coo.semiring_ops.CooSemiringVectorOps
- CooTensor - Class in org.flag4j.arrays.sparse
-
A real sparse tensor stored in coordinate list (COO) format.
- CooTensor(Shape) - Constructor for class org.flag4j.arrays.sparse.CooTensor
-
Creates a zero matrix with the specified shape.
- CooTensor(Shape, double[], int[][]) - Constructor for class org.flag4j.arrays.sparse.CooTensor
-
Creates a tensor with the specified entries and shape.
- CooTensor(Shape, int[], int[][]) - Constructor for class org.flag4j.arrays.sparse.CooTensor
-
Creates a sparse COO matrix with the specified shape, non-zero entries, and indices.
- CooTensor(Shape, List<Double>, List<int[]>) - Constructor for class org.flag4j.arrays.sparse.CooTensor
-
Creates a tensor with the specified entries and shape.
- CooTensor(CooTensor) - Constructor for class org.flag4j.arrays.sparse.CooTensor
-
Constructs a copy of the specified matrix.
- cooTensorEquals(CooFieldTensorBase<?, ?, T>, CooFieldTensorBase<?, ?, T>) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldEquals
-
Checks if two real sparse tensors are real.
- cooTensorEquals(CooTensor, CooTensor) - Static method in class org.flag4j.linalg.ops.sparse.coo.real.RealSparseEquals
-
Checks if two real sparse tensors are real.
- CooTranspose - Class in org.flag4j.linalg.ops.sparse.coo
-
Utility class for computing the transpose of a sparse COO tensor or matrix.
- CooTranspose() - Constructor for class org.flag4j.linalg.ops.sparse.coo.CooTranspose
- CooVector - Class in org.flag4j.arrays.sparse
-
A real sparse vector stored in coordinate list (COO) format.
- CooVector(int) - Constructor for class org.flag4j.arrays.sparse.CooVector
-
Creates a zero vector of the specified
size
. - CooVector(int, double[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooVector
-
Creates sparse COO vector with the specified
size
, non-zero entries, and non-zero indices. - CooVector(int, int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooVector
-
Creates sparse COO vector with the specified
size
, non-zero entries, and non-zero indices. - CooVector(int, List<Double>, List<Integer>) - Constructor for class org.flag4j.arrays.sparse.CooVector
-
Creates sparse COO vector with the specified
size
, non-zero entries, and non-zero indices. - CooVector(Shape, double[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooVector
-
Creates sparse COO vector with the specified
size
, non-zero entries, and non-zero indices. - CooVector(CooVector) - Constructor for class org.flag4j.arrays.sparse.CooVector
-
Constructs a copy of the specified sparse COO vector.
- cooVectorEquals(CooFieldVectorBase<?, ?, ?, ?, T>, CooFieldVectorBase<?, ?, ?, ?, T>) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldEquals
-
Checks if two real sparse vectors are real.
- cooVectorEquals(CooVector, CooVector) - Static method in class org.flag4j.linalg.ops.sparse.coo.real.RealSparseEquals
-
Checks if two real sparse vectors are real.
- copy() - Method in class org.flag4j.arrays.backend.field.AbstractDenseFieldTensor
-
Creates a deep copy of this tensor.
- copy() - Method in interface org.flag4j.arrays.backend.MatrixMixin
-
Creates a deep copy of this matrix.
- copy() - Method in class org.flag4j.arrays.backend.ring.AbstractDenseRingTensor
-
Creates a deep copy of this tensor.
- copy() - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringMatrix
-
Creates a deep copy of this tensor.
- copy() - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringTensor
-
Creates a deep copy of this tensor.
- copy() - Method in class org.flag4j.arrays.backend.semiring.AbstractCooSemiringVector
-
Creates a deep copy of this tensor.
- copy() - Method in class org.flag4j.arrays.backend.semiring.AbstractDenseSemiringTensor
-
Creates a deep copy of this tensor.
- copy() - Method in class org.flag4j.arrays.backend.semiring.CsrSemiRingMatrixBase
-
Creates a deep copy of this tensor.
- copy() - Method in class org.flag4j.arrays.backend.CooFieldTensorBase
-
Creates a deep copy of this tensor.
- copy() - Method in class org.flag4j.arrays.backend.FieldTensorBase
-
Creates a copy of this tensor.
- copy() - Method in interface org.flag4j.arrays.backend.MatrixMixinOld
-
Creates a deep copy of this matrix.
- copy() - Method in class org.flag4j.arrays.backend.PrimitiveDoubleTensorBase
-
Creates a deep copy of this tensor.
- copy() - Method in interface org.flag4j.arrays.backend.TensorMixin
-
Creates a deep copy of this tensor.
- copy() - Method in class org.flag4j.arrays.sparse.CooTensor
-
Creates a deep copy of this tensor.
- copy() - Method in class org.flag4j.arrays.sparse.PermutationMatrix
-
Creates a copy of this permutation matrix.
- copyRanges(CooFieldMatrixBase<?, ?, ?, ?, V>, Field<V>[], int[], int[], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatrixManipulations
-
A helper method which copies from a sparse matrix to a set of three arrays_old (non-zero entries, row indices, and column indices) but skips over a specified range.
- copyRanges(CooMatrix, double[], int[], int[], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.real.RealSparseMatrixManipulations
-
A helper method which copies from a sparse matrix to a set of three arrays_old (non-zero entries, row indices, and column indices) but skips over a specified range.
- copyRanges(T[], int[], int[], T[], int[], int[], int[]) - Static method in class org.flag4j.linalg.ops.sparse.SparseUtils
-
A helper method which copies from a sparse COO matrix to a set of three arrays (non-zero entries, row indices, and column indices) but skips over a specified range.
- copyUpperTri(CMatrix) - Method in class org.flag4j.linalg.decompositions.hess.HermHess
-
Copies the upper triangular portion of a matrix to the working matrix
UnitaryDecomposition.transformMatrix
. - copyUpperTri(Matrix) - Method in class org.flag4j.linalg.decompositions.hess.SymmHess
-
Copies the upper triangular portion of a matrix to the working matrix
UnitaryDecomposition.transformMatrix
. - copyValuesNotInSlice(CooFieldMatrixBase<?, ?, ?, ?, V>, List<Field<V>>, List<Integer>, List<Integer>, int[], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.field_ops.CooFieldMatrixGetSet
-
Copies values in sparse matrix which do not fall in the specified row and column ranges.
- copyValuesNotInSlice(CooCMatrix, List<Field<Complex128>>, List<Integer>, List<Integer>, int[], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.complex.ComplexSparseMatrixGetSet
-
Copies values in sparse matrix which do not fall in the specified row and column ranges.
- copyValuesNotInSlice(CooMatrix, List<Double>, List<Integer>, List<Integer>, int[], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.real.RealSparseMatrixGetSet
-
Copies values in sparse matrix which do not fall in the specified row and column ranges.
- copyValuesNotInSlice(T[], int[], int[], List<T>, List<Integer>, List<Integer>, int[], int[]) - Static method in class org.flag4j.linalg.ops.sparse.coo.CooGetSet
-
Copies values in sparse matrix which do not fall in the specified row and column ranges.
- cos(Complex128) - Static method in class org.flag4j.algebraic_structures.fields.Complex128
-
Computes the trigonometric cosine value of a complex value.
- cos(Complex64) - Static method in class org.flag4j.algebraic_structures.fields.Complex64
-
Computes the trigonometric cosine value of a complex value.
- cosh(Complex128) - Static method in class org.flag4j.algebraic_structures.fields.Complex128
-
Computes the hyperbolic cosine of a complex value.
- cosh(Complex64) - Static method in class org.flag4j.algebraic_structures.fields.Complex64
-
Computes the hyperbolic cosine of a complex value.
- createComplexChol() - Static method in class org.flag4j.linalg.decompositions.DecompositionFactory
-
Constructs a decomposer to compute the Cholesky decomposition of a complex dense matrix.
- createComplexHess() - Static method in class org.flag4j.linalg.decompositions.DecompositionFactory
-
Constructs a decomposer to compute the Hessenburg decomposition of a complex dense matrix.
- createComplexLU() - Static method in class org.flag4j.linalg.decompositions.DecompositionFactory
-
Constructs a decomposer to compute the LU decomposition of a complex dense matrix.
- createComplexQR() - Static method in class org.flag4j.linalg.decompositions.DecompositionFactory
-
Constructs a decomposer to compute the QR decomposition of a complex dense matrix.
- createComplexSchur() - Static method in class org.flag4j.linalg.decompositions.DecompositionFactory
-
Constructs a decomposer to compute the Schur decomposition of a complex dense matrix.
- createComplexSVD() - Static method in class org.flag4j.linalg.decompositions.DecompositionFactory
-
Constructs a decomposer to compute the singular value decomposition of a complex dense matrix.
- createMap(int, int[]) - Static method in class org.flag4j.linalg.ops.sparse.SparseUtils
-
Creates a HashMap where the keys are row indices and the value is a list of all indices in src with that row index.
- createNewStrides() - Method in class org.flag4j.arrays.Shape
-
Constructs strides for each dimension of this shape as if for a newly constructed tensor.
- createRealChol() - Static method in class org.flag4j.linalg.decompositions.DecompositionFactory
-
Constructs a decomposer to compute the Cholesky decomposition of a real dense matrix.
- createRealHess() - Static method in class org.flag4j.linalg.decompositions.DecompositionFactory
-
Constructs a decomposer to compute the Hessenburg decomposition of a real dense matrix.
- createRealLU() - Static method in class org.flag4j.linalg.decompositions.DecompositionFactory
-
Constructs a decomposer to compute the LU decomposition of a real dense matrix.
- createRealQR() - Static method in class org.flag4j.linalg.decompositions.DecompositionFactory
-
Constructs a decomposer to compute the QR decomposition of a real dense matrix.
- createRealSchur() - Static method in class org.flag4j.linalg.decompositions.DecompositionFactory
-
Constructs a decomposer to compute the Schur decomposition of a real dense matrix.
- createRealSVD() - Static method in class org.flag4j.linalg.decompositions.DecompositionFactory
-
Constructs a decomposer to compute the singular value decomposition of a real dense matrix.
- createUniqueMapping(int[]) - Static method in class org.flag4j.util.ArrayUtils
-
Creates a mapping of unique values in {code arr} to integers such that each unique value is mapped to a unique integer and those integers range from
0
tonumUnique(arr) - 1
. - cross(Vector) - Method in class org.flag4j.arrays.dense.Vector
-
Computes the vector cross product between two vectors.
- cross(T) - Method in class org.flag4j.arrays.backend.DenseFieldVectorBase
-
Computes the vector cross product between two vectors.
- cross(T) - Method in interface org.flag4j.arrays.backend.DenseVectorMixin
-
Computes the vector cross product between two vectors.
- CsrCMatrix - Class in org.flag4j.arrays.sparse
-
A complex sparse matrix stored in compressed sparse row (CSR) format.
- CsrCMatrix(int, int) - Constructor for class org.flag4j.arrays.sparse.CsrCMatrix
-
Constructs a zero matrix of the specified shape.
- CsrCMatrix(int, int, List<Field<Complex128>>, List<Integer>, List<Integer>) - Constructor for class org.flag4j.arrays.sparse.CsrCMatrix
-
Creates a complex sparse CSR matrix with the specified
shape
, non-zero entries, row pointers, and non-zero column indices. - CsrCMatrix(int, int, Field<Complex128>[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CsrCMatrix
-
Creates a complex sparse CSR matrix with the specified shape, non-zero entries, row pointers, and non-zero column indices.
- CsrCMatrix(Shape) - Constructor for class org.flag4j.arrays.sparse.CsrCMatrix
-
Constructs a zero matrix of the specified shape.
- CsrCMatrix(Shape, List<Field<Complex128>>, List<Integer>, List<Integer>) - Constructor for class org.flag4j.arrays.sparse.CsrCMatrix
-
Creates a complex sparse CSR matrix with the specified
shape
, non-zero entries, row pointers, and non-zero column indices. - CsrCMatrix(Shape, Field<Complex128>[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CsrCMatrix
-
Creates a complex sparse CSR matrix with the specified
shape
, non-zero entries, row pointers, and non-zero column indices. - CSREquals(CsrFieldMatrixBase<?, ?, ?, ?, T>, CsrFieldMatrixBase<?, ?, ?, ?, T>) - Static method in class org.flag4j.linalg.ops.sparse.SparseUtils
-
Checks if two
CSR Field matrices
are equal considering the fact that one may explicitly store zeros at some position that the other does not store. - CSREquals(CsrMatrix, CsrMatrix) - Static method in class org.flag4j.linalg.ops.sparse.SparseUtils
-
Checks if two
CSR Matrices
are equal considering the fact that one may explicitly store zeros at some position that the other does not store. - CsrFieldEquals - Class in org.flag4j.linalg.ops.sparse.csr.field_ops
-
This class contains methods to check equality or approximate equality between two sparse CSR field matrices.
- CsrFieldEquals() - Constructor for class org.flag4j.linalg.ops.sparse.csr.field_ops.CsrFieldEquals
- CsrFieldMatMult - Class in org.flag4j.linalg.ops.sparse.csr.field_ops
-
This class contains low-level implementations of sparse-sparse
Field
matrix multiplication where the sparse matrices are in CSR format. - CsrFieldMatMult() - Constructor for class org.flag4j.linalg.ops.sparse.csr.field_ops.CsrFieldMatMult
- CsrFieldMatrix<T> - Class in org.flag4j.arrays.sparse
-
A sparse matrix stored in compressed sparse row (CSR) format.
- CsrFieldMatrix(Shape, Field<T>[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CsrFieldMatrix
-
Creates a sparse CSR matrix with the specified
shape
, non-zero entries, row pointers, and non-zero column indices. - CsrFieldMatrixBase<T,
U, - Class in org.flag4j.arrays.backendV, W, Y> -
A real sparse matrix stored in compressed sparse row (CSR) format.
- CsrFieldMatrixBase(Shape, Field<Y>[], int[], int[]) - Constructor for class org.flag4j.arrays.backend.CsrFieldMatrixBase
-
Creates a sparse CSR matrix with the specified
shape
, non-zero entries, row pointers, and non-zero column indices. - CsrFieldMatrixManipulations - Class in org.flag4j.linalg.ops.sparse.csr.field_ops
-
This utility class contains methods for manipulating CSR
Field
matrices. - CsrFieldMatrixManipulations() - Constructor for class org.flag4j.linalg.ops.sparse.csr.field_ops.CsrFieldMatrixManipulations
- CsrFieldMatrixOperations - Class in org.flag4j.linalg.ops.sparse.csr.field_ops
-
This class contains low-level implementations for element-wise operations on CSR
Field
matrices. - CsrFieldMatrixOperations() - Constructor for class org.flag4j.linalg.ops.sparse.csr.field_ops.CsrFieldMatrixOperations
- CsrFieldMatrixProperties - Class in org.flag4j.linalg.ops.sparse.csr.field_ops
-
This utility class contains methods usefully for determining properties of a sparse CSR
Field
matrix. - CsrFieldMatrixProperties() - Constructor for class org.flag4j.linalg.ops.sparse.csr.field_ops.CsrFieldMatrixProperties
- CsrFieldMatrixTensorDot - Class in org.flag4j.linalg.ops.sparse.csr.field_ops
-
This utility class provides implementations for tensor dot products on two sparse CSR
Field
matrices. - CsrFieldMatrixTensorDot() - Constructor for class org.flag4j.linalg.ops.sparse.csr.field_ops.CsrFieldMatrixTensorDot
- CsrMatrix - Class in org.flag4j.arrays.sparse
-
A real sparse matrix stored in compressed sparse row (CSR) format.
- CsrMatrix(int, int) - Constructor for class org.flag4j.arrays.sparse.CsrMatrix
-
Constructs a zero matrix with the specified shape.
- CsrMatrix(int, int, double[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CsrMatrix
-
Creates a sparse CSR matrix with the specified
shape
, non-zero entries, row pointers, and non-zero column indices. - CsrMatrix(Shape, double[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CsrMatrix
-
Creates a sparse CSR matrix with the specified
shape
, non-zero entries, row pointers, and non-zero column indices. - CsrMatrixMixin<T,
U, - Interface in org.flag4j.arrays.backendV, W, X, Y> -
This interface specifies methods which all sparse CSR matrices should implement.
- CsrSemiRingMatrixBase<T,
U, - Class in org.flag4j.arrays.backend.semiring_arraysV, W> -
A real sparse matrix stored in compressed sparse row (CSR) format.
- CsrSemiRingMatrixBase(Shape, Semiring<W>[], int[], int[]) - Constructor for class org.flag4j.arrays.backend.semiring.CsrSemiRingMatrixBase
-
Creates a sparse CSR matrix with the specified
shape
, non-zero entries, row pointers, and non-zero column indices. - CTensor - Class in org.flag4j.arrays.dense
-
A dense complex tensor backed by an array of
Complex128
's. - CTensor(CTensor) - Constructor for class org.flag4j.arrays.dense.CTensor
-
Constructs a copy of the specified tensor.
- CTensor(Shape) - Constructor for class org.flag4j.arrays.dense.CTensor
-
Creates a zero tensor with the specified shape.
- CTensor(Shape, double) - Constructor for class org.flag4j.arrays.dense.CTensor
-
Creates a tensor with the specified shape and filled with
fillValue
. - CTensor(Shape, double[]) - Constructor for class org.flag4j.arrays.dense.CTensor
-
Creates a tensor with the specified entries and shape.
- CTensor(Shape, String) - Constructor for class org.flag4j.arrays.dense.CTensor
-
Creates a tensor with the specified shape and filled with
fillValue
. - CTensor(Shape, String[]) - Constructor for class org.flag4j.arrays.dense.CTensor
-
Creates a tensor with the specified entries and shape.
- CTensor(Shape, Complex128) - Constructor for class org.flag4j.arrays.dense.CTensor
-
Creates a tensor with the specified shape and filled with
fillValue
. - CTensor(Shape, Complex64) - Constructor for class org.flag4j.arrays.dense.CTensor
-
Creates a tensor with the specified shape and filled with
fillValue
. - CTensor(Shape, Complex64[]) - Constructor for class org.flag4j.arrays.dense.CTensor
-
Creates a tensor with the specified entries and shape.
- CTensor(Shape, Field<Complex128>[]) - Constructor for class org.flag4j.arrays.dense.CTensor
-
Creates a tensor with the specified entries and shape.
- CTensor64 - Class in org.flag4j.arrays.dense
-
A dense complex tensor backed by an array of
Complex128
's. - CTensor64(Shape) - Constructor for class org.flag4j.arrays.dense.CTensor64
-
Creates a zero tensor with the specified shape.
- CTensor64(Shape, String) - Constructor for class org.flag4j.arrays.dense.CTensor64
-
Creates a tensor with the specified shape and filled with
fillValue
. - CTensor64(Shape, String[]) - Constructor for class org.flag4j.arrays.dense.CTensor64
-
Creates a tensor with the specified entries and shape.
- CTensor64(Shape, Complex64) - Constructor for class org.flag4j.arrays.dense.CTensor64
-
Creates a tensor with the specified shape and filled with
fillValue
. - CTensor64(Shape, Field<Complex64>[]) - Constructor for class org.flag4j.arrays.dense.CTensor64
-
Creates a tensor with the specified entries and shape.
- currentFactor - Variable in class org.flag4j.linalg.decompositions.schur.ComplexSchur
-
Stores the scalar factor invalid input: '&alpha' for use in computation of the Householder reflector P = I - invalid input: '&alpha' vvH.
- currentFactor - Variable in class org.flag4j.linalg.decompositions.schur.RealSchur
-
Stores the scalar factor invalid input: '&alpha' for use in computation of the Householder reflector P = I - invalid input: '&alpha' vvT.
- currentFactor - Variable in class org.flag4j.linalg.decompositions.unitary.ComplexUnitaryDecomposition
-
Scalar factor of the currently computed Householder reflector.
- currentFactor - Variable in class org.flag4j.linalg.decompositions.unitary.RealUnitaryDecomposition
-
Scalar factor of the currently computed HouseholderOld reflector.
- CVector - Class in org.flag4j.arrays.dense
-
A complex dense vector whose entries are
Complex128
's. - CVector(double...) - Constructor for class org.flag4j.arrays.dense.CVector
-
Creates a complex vector with the specified
entries
. - CVector(int) - Constructor for class org.flag4j.arrays.dense.CVector
-
Creates a complex zero vector with the specified
size
. - CVector(int...) - Constructor for class org.flag4j.arrays.dense.CVector
-
Creates a complex vector with the specified
entries
. - CVector(int, double) - Constructor for class org.flag4j.arrays.dense.CVector
-
Creates a complex vector with the specified
size
and filled withfillValue
. - CVector(int, Complex128) - Constructor for class org.flag4j.arrays.dense.CVector
-
Creates a complex vector with the specified
size
and filled withfillValue
. - CVector(int, Complex64) - Constructor for class org.flag4j.arrays.dense.CVector
-
Creates a complex vector with the specified
size
and filled withfillValue
. - CVector(Complex64...) - Constructor for class org.flag4j.arrays.dense.CVector
-
Creates a complex vector with the specified
entries
. - CVector(Field<Complex128>...) - Constructor for class org.flag4j.arrays.dense.CVector
-
Creates a complex vector with the specified
entries
. - CVector(CVector) - Constructor for class org.flag4j.arrays.dense.CVector
-
Creates a copy of the provided vector.
All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form