Index

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

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.operations.TransposeDispatcher
Chooses the appropriate matrix transpose algorithm based on the shape of a matrix.
chooseAlgorithmComplex(Shape) - Static method in class org.flag4j.operations.TransposeDispatcher
Chooses the appropriate matrix transpose algorithm based on the shape of a matrix.
chooseAlgorithmComplex(Shape, Shape) - Static method in class org.flag4j.operations.MatrixMultiplyDispatcher
Dynamically chooses matrix multiply algorithm based on the shapes of the two matrices to multiply.
chooseAlgorithmComplexTranspose(Shape) - Static method in class org.flag4j.operations.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.operations.MatrixMultiplyDispatcher
Dynamically chooses matrix-vector multiply algorithm based on the shapes of the matrix to multiply.
chooseAlgorithmHermitian(Shape) - Static method in class org.flag4j.operations.TransposeDispatcher
Chooses the appropriate matrix hermitian transpose algorithm based on the shape of a matrix.
chooseAlgorithmRealComplex(Shape, Shape) - Static method in class org.flag4j.operations.MatrixMultiplyDispatcher
Dynamically chooses matrix multiply algorithm based on the shapes of the two matrices to multiply.
chooseAlgorithmRealComplexTranspose(Shape) - Static method in class org.flag4j.operations.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.operations.MatrixMultiplyDispatcher
Dynamically chooses matrix-vector multiply algorithm based on the shapes of the matrix to multiply.
chooseAlgorithmRealVector(Shape) - Static method in class org.flag4j.operations.MatrixMultiplyDispatcher
Dynamically chooses matrix-vector multiply algorithm based on the shapes of the matrix to multiply.
chooseAlgorithmTensor(int) - Static method in class org.flag4j.operations.TransposeDispatcher
Chooses the appropriate algorithm for computing a tensor transpose.
chooseAlgorithmTensor(int, int) - Static method in class org.flag4j.operations.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
Complex dense matrix.
CMatrix(double[][]) - Constructor for class org.flag4j.arrays.dense.CMatrix
Creates a complex dense matrix whose entries are specified by a double array.
CMatrix(int) - Constructor for class org.flag4j.arrays.dense.CMatrix
Constructs a square complex dense matrix of a specified size.
CMatrix(int[][]) - Constructor for class org.flag4j.arrays.dense.CMatrix
Creates a complex dense matrix whose entries are specified by a double array.
CMatrix(int, double) - Constructor for class org.flag4j.arrays.dense.CMatrix
Creates a square complex dense matrix with a specified fill value.
CMatrix(int, int) - Constructor for class org.flag4j.arrays.dense.CMatrix
Creates a complex dense matrix of a specified shape filled with zeros.
CMatrix(int, int, double) - Constructor for class org.flag4j.arrays.dense.CMatrix
Creates a complex dense matrix with a specified shape and fills the matrix with the specified value.
CMatrix(int, int, CNumber) - Constructor for class org.flag4j.arrays.dense.CMatrix
Creates a complex dense matrix with a specified shape and fills the matrix with the specified value.
CMatrix(int, int, CNumber[]) - Constructor for class org.flag4j.arrays.dense.CMatrix
Constructs a complex matrix with specified shapes and entries.
CMatrix(int, CNumber) - Constructor for class org.flag4j.arrays.dense.CMatrix
Creates a square complex dense matrix with a specified fill value.
CMatrix(String[][]) - Constructor for class org.flag4j.arrays.dense.CMatrix
Creates a complex dense matrix whose entries are specified by a double array.
CMatrix(CMatrix) - Constructor for class org.flag4j.arrays.dense.CMatrix
Creates a complex dense matrix which is a copy of a specified matrix.
CMatrix(Matrix) - Constructor for class org.flag4j.arrays.dense.CMatrix
Creates a complex dense matrix which is a copy of a specified matrix.
CMatrix(CNumber[][]) - Constructor for class org.flag4j.arrays.dense.CMatrix
Creates a complex dense matrix whose entries are specified by a double array.
CMatrix(Shape) - Constructor for class org.flag4j.arrays.dense.CMatrix
Creates a complex dense matrix with specified shape.
CMatrix(Shape, double) - Constructor for class org.flag4j.arrays.dense.CMatrix
Creates a complex dense matrix with specified shape filled with specified value.
CMatrix(Shape, double...) - Constructor for class org.flag4j.arrays.dense.CMatrix
Creates a complex dense matrix with specified shape filled with specified entries.
CMatrix(Shape, CNumber) - Constructor for class org.flag4j.arrays.dense.CMatrix
Creates a complex dense matrix with specified shape filled with specified value.
CMatrix(Shape, CNumber...) - Constructor for class org.flag4j.arrays.dense.CMatrix
Constructs a complex matrix with specified shapes and entries.
CNumber - Class in org.flag4j.complex_numbers
A complex number stored in rectangular form with both the real and imaginary components stored as a 64-bit floats.
CNumber(double) - Constructor for class org.flag4j.complex_numbers.CNumber
Constructs a complex number with specified real component and zero imaginary component.
CNumber(double, double) - Constructor for class org.flag4j.complex_numbers.CNumber
Constructs a complex number with specified complex and real components.
CNumber(String) - Constructor for class org.flag4j.complex_numbers.CNumber
Constructs a complex number from a string of the form "a +/- bi" where a and {b} are real values and either may be omitted.
CNumberLexer - Class in org.flag4j.complex_numbers
A lexer for producing the tokens of a complex number represented as a string.
CNumberLexer(String) - Constructor for class org.flag4j.complex_numbers.CNumberLexer
 
CNumberParser - Class in org.flag4j.complex_numbers
A parser for complex numbers represented as a string.
CNumberParser() - Constructor for class org.flag4j.complex_numbers.CNumberParser
 
CNumberToken - Class in org.flag4j.complex_numbers
A CNumberToken is the smallest unit of a string which is being parsed to a complex number.
CNumberToken(String, String) - Constructor for class org.flag4j.complex_numbers.CNumberToken
Creates a token of the specified kind and with the specified details.
CNumberUtils - Class in org.flag4j.complex_numbers
Contains simple utility functions for the CNumber object.
CNumberUtils() - Constructor for class org.flag4j.complex_numbers.CNumberUtils
 
col() - Static method in enum class org.flag4j.util.Axis2D
Get the ordinal of the column axis in 2D.
COL - Enum constant in enum class org.flag4j.util.Axis2D
Column of 2D tensor
colIndices - Variable in class org.flag4j.arrays.sparse.CooCMatrix
Column indices of the non-zero entries of the sparse matrix.
colIndices - Variable in class org.flag4j.arrays.sparse.CooMatrix
Column indices of the non-zero entries of the sparse matrix.
colIndices - Variable in class org.flag4j.arrays.sparse.CsrCMatrix
Column indices of the non-zero entries of the sparse matrix.
colIndices - Variable in class org.flag4j.arrays.sparse.CsrMatrix
Column indices of the non-zero entries of the sparse matrix.
colSwaps - Variable in class org.flag4j.linalg.decompositions.lu.LU
 
compareTo(CNumber) - Method in class org.flag4j.complex_numbers.CNumber
Compares the size of two complex numbers (magnitudes).
compareToReal(double) - Method in class org.flag4j.complex_numbers.CNumber
Compares the real value of two numbers.
compareToReal(CNumber) - Method in class org.flag4j.complex_numbers.CNumber
Compares the real value of two numbers.
COMPLEX_BLOCKED_THRESHOLD - Static variable in class org.flag4j.operations.TransposeDispatcher
Threshold for using complex blocked algorithm.
COMPLEX_RNG - Variable in class org.flag4j.rng.RandomTensor
Complex pseudorandom number generator.
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
This abstract class specifies methods for computing the Cholesky decomposition of a hermitian positive-definite matrix.
ComplexCholesky() - Constructor for class org.flag4j.linalg.decompositions.chol.ComplexCholesky
Constructs a Cholesky decomposer.
ComplexCholesky(boolean) - Constructor for class org.flag4j.linalg.decompositions.chol.ComplexCholesky
Constructs a Cholesky decomposer.
ComplexCooTensorDot - Class in org.flag4j.operations.sparse.coo.complex
Utility class for computing tensor dot products between two complex sparse COO tensors.
ComplexCooTensorDot() - Constructor for class org.flag4j.operations.sparse.coo.complex.ComplexCooTensorDot
 
ComplexCooTensorOperations - Class in org.flag4j.operations.sparse.coo.complex
Utility class for computing operations between two complex sparse COO tensors.
ComplexCooTensorOperations() - Constructor for class org.flag4j.operations.sparse.coo.complex.ComplexCooTensorOperations
 
ComplexCsrDenseMatrixMultiplication - Class in org.flag4j.operations.dense_sparse.csr.complex
This class contains low-level implementations of complex-complex sparse-sparse matrix multiplication where the sparse matrices are in CSR format.
ComplexCsrDenseMatrixMultiplication() - Constructor for class org.flag4j.operations.dense_sparse.csr.complex.ComplexCsrDenseMatrixMultiplication
 
ComplexCsrDenseOperations - Class in org.flag4j.operations.dense_sparse.csr.complex
This class contains low-level operations which act on a complex dense and a complex sparse CSR matrix.
ComplexCsrDenseOperations() - Constructor for class org.flag4j.operations.dense_sparse.csr.complex.ComplexCsrDenseOperations
 
ComplexCsrEquals - Class in org.flag4j.operations.sparse.csr.complex
This class contains methods to check equality or approximate equality between two complex sparse CSR matrices.
ComplexCsrEquals() - Constructor for class org.flag4j.operations.sparse.csr.complex.ComplexCsrEquals
 
ComplexCsrManipulations - Class in org.flag4j.operations.sparse.csr.complex
Utility class for manipulating real sparse CSR matrices (e.g.
ComplexCsrManipulations() - Constructor for class org.flag4j.operations.sparse.csr.complex.ComplexCsrManipulations
 
ComplexCsrMatrixMultiplication - Class in org.flag4j.operations.sparse.csr.complex
This class contains low-level implementations of complex-complex sparse-sparse matrix multiplication where the sparse matrices are in CSR format.
ComplexCsrMatrixMultiplication() - Constructor for class org.flag4j.operations.sparse.csr.complex.ComplexCsrMatrixMultiplication
 
ComplexCsrOperations - Class in org.flag4j.operations.sparse.csr.complex
This class contains low-level implementations for element-wise operations on complex CSR matrices.
ComplexCsrOperations() - Constructor for class org.flag4j.operations.sparse.csr.complex.ComplexCsrOperations
 
ComplexCsrProperties - Class in org.flag4j.operations.sparse.csr.complex
This class contains low-level implementations for determining certain properties of complex sparse CSR matrices.
ComplexCsrProperties() - Constructor for class org.flag4j.operations.sparse.csr.complex.ComplexCsrProperties
 
ComplexDenseDeterminant - Class in org.flag4j.operations.dense.complex
This class contains methods for computing the determinant of a complex dense matrix.
ComplexDenseDeterminant() - Constructor for class org.flag4j.operations.dense.complex.ComplexDenseDeterminant
 
ComplexDenseElemDiv - Class in org.flag4j.operations.dense.complex
This class contains low-level implementations of complex element-wise tensor multiplication.
ComplexDenseElemDiv() - Constructor for class org.flag4j.operations.dense.complex.ComplexDenseElemDiv
 
ComplexDenseElemMult - Class in org.flag4j.operations.dense.complex
This class contains low-level implementations of complex element-wise tensor multiplication.
ComplexDenseElemMult() - Constructor for class org.flag4j.operations.dense.complex.ComplexDenseElemMult
 
ComplexDenseEquals - Class in org.flag4j.operations.dense.complex
This class provides methods for checking the equality of complex dense tensors.
ComplexDenseEquals() - Constructor for class org.flag4j.operations.dense.complex.ComplexDenseEquals
 
complexDenseLookUp - Static variable in class org.flag4j.operations.common.TensorEquals
 
ComplexDenseMatrixMultiplication - Class in org.flag4j.operations.dense.complex
This class contains several low level methods for computing complex matrix-matrix multiplications.
ComplexDenseMatrixMultiplication() - Constructor for class org.flag4j.operations.dense.complex.ComplexDenseMatrixMultiplication
 
ComplexDenseMatrixMultTranspose - Class in org.flag4j.operations.dense.complex
This class contains several low level methods for computing matrix-matrix multiplications with a transpose for two dense complex matrices.
ComplexDenseMatrixMultTranspose() - Constructor for class org.flag4j.operations.dense.complex.ComplexDenseMatrixMultTranspose
 
ComplexDenseOperations - Class in org.flag4j.operations.dense.complex
This class provides low level methods for computing operations on dense complex tensors.
ComplexDenseOperations() - Constructor for class org.flag4j.operations.dense.complex.ComplexDenseOperations
 
ComplexDenseProperties - Class in org.flag4j.operations.dense.complex
This class contains low-level implementations for operations which check if a complex tensor satisfies some property.
ComplexDenseProperties() - Constructor for class org.flag4j.operations.dense.complex.ComplexDenseProperties
 
ComplexDenseSetOperations - Class in org.flag4j.operations.dense.complex
This class contains low-level implementations of setting operations for complex dense tensors.
ComplexDenseSetOperations() - Constructor for class org.flag4j.operations.dense.complex.ComplexDenseSetOperations
 
ComplexDenseSparseEquals - Class in org.flag4j.operations.dense_sparse.coo.complex
This class provides methods for checking the equality of a complex dense tensor with a complex sparse tensor.
ComplexDenseSparseEquals() - Constructor for class org.flag4j.operations.dense_sparse.coo.complex.ComplexDenseSparseEquals
 
ComplexDenseSparseMatrixMultiplication - Class in org.flag4j.operations.dense_sparse.coo.complex
This class provides low level methods for computing the matrix multiplication between a sparse/dense matrix and dense/sparse matrix/vector.
ComplexDenseSparseMatrixMultiplication() - Constructor for class org.flag4j.operations.dense_sparse.coo.complex.ComplexDenseSparseMatrixMultiplication
 
ComplexDenseSparseMatrixMultTranspose - Class in org.flag4j.operations.dense_sparse.coo.complex
This class contains several low level methods for computing matrix-matrix multiplications with a transpose for a complex dense matrix and a complex sparse matrix.
ComplexDenseSparseMatrixMultTranspose() - Constructor for class org.flag4j.operations.dense_sparse.coo.complex.ComplexDenseSparseMatrixMultTranspose
 
ComplexDenseSparseMatrixOperations - Class in org.flag4j.operations.dense_sparse.coo.complex
This class contains low level implementations for operations between a dense and a sparse complex matrix.
ComplexDenseSparseMatrixOperations() - Constructor for class org.flag4j.operations.dense_sparse.coo.complex.ComplexDenseSparseMatrixOperations
 
ComplexDenseSparseOperations - Class in org.flag4j.operations.dense_sparse.coo.complex
This class contains methods to apply common binary operations to a complex dense/sparse matrix and to a complex sparse/dense matrix.
ComplexDenseSparseOperations() - Constructor for class org.flag4j.operations.dense_sparse.coo.complex.ComplexDenseSparseOperations
 
ComplexDenseSparseVectorOperations - Class in org.flag4j.operations.dense_sparse.coo.complex
This class provides low level methods for computing operations between complex dense/sparse and complex sparse/dense vectors.
ComplexDenseSparseVectorOperations() - Constructor for class org.flag4j.operations.dense_sparse.coo.complex.ComplexDenseSparseVectorOperations
 
ComplexDenseTensorBase<T,Y> - Class in org.flag4j.core.dense_base
The base class for all complex dense tensors.
ComplexDenseTensorBase(Shape, CNumber[]) - Constructor for class org.flag4j.core.dense_base.ComplexDenseTensorBase
Creates a complex dense tensor with specified entries and shape.
ComplexDenseTensorDot - Class in org.flag4j.operations.dense.complex
This class contains methods for computing a tensor dot product, i.e.
ComplexDenseTensorDot() - Constructor for class org.flag4j.operations.dense.complex.ComplexDenseTensorDot
 
ComplexDenseTranspose - Class in org.flag4j.operations.dense.complex
This class contains several algorithms for computing the transpose of a complex dense tensor.
ComplexDenseTranspose() - Constructor for class org.flag4j.operations.dense.complex.ComplexDenseTranspose
 
ComplexDenseVectorOperations - Class in org.flag4j.operations.dense.complex
This class provides low level implementations for vector operations with two complex dense vectors.
ComplexDenseVectorOperations() - Constructor for class org.flag4j.operations.dense.complex.ComplexDenseVectorOperations
 
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 is a complex dense vector.
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 Hessenburg decomposer.
ComplexHess(boolean) - Constructor for class org.flag4j.linalg.decompositions.hess.ComplexHess
Creates a real unitary decomposer which will reduce the matrix to an upper quasi-triangular matrix which is has zeros below the specified sub-diagonal.
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
This 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.
ComplexMatrixMixin<T> - Interface in org.flag4j.core
This interface specifies methods which any complex matrix should implement.
ComplexOperations - Class in org.flag4j.operations.common.complex
This class provides low level methods for computing operations on real tensors.
ComplexOperations() - Constructor for class org.flag4j.operations.common.complex.ComplexOperations
 
ComplexProperties - Class in org.flag4j.operations.common.complex
This class contains low-level implementations for operations which check if a complex tensor satisfies some property.
ComplexProperties() - Constructor for class org.flag4j.operations.common.complex.ComplexProperties
 
ComplexQR - Class in org.flag4j.linalg.decompositions.qr
Instances of this class compute the QR decomposition of a complex 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 reduced QR 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.
ComplexSparseElementSearch - Class in org.flag4j.operations.sparse.coo.complex
 
ComplexSparseElementSearch() - Constructor for class org.flag4j.operations.sparse.coo.complex.ComplexSparseElementSearch
 
ComplexSparseEquals - Class in org.flag4j.operations.sparse.coo.complex
This class contains low-level implementations to check if a pair of complex sparse tensors/matrices/vectors are element-wise equivalent.
ComplexSparseEquals() - Constructor for class org.flag4j.operations.sparse.coo.complex.ComplexSparseEquals
 
complexSparseLookUp - Static variable in class org.flag4j.operations.common.TensorEquals
 
ComplexSparseMatrixGetSet - Class in org.flag4j.operations.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.operations.sparse.coo.complex.ComplexSparseMatrixGetSet
 
ComplexSparseMatrixManipulations - Class in org.flag4j.operations.sparse.coo.complex
This class contains implementations for complex sparse matrix manipulations.
ComplexSparseMatrixManipulations() - Constructor for class org.flag4j.operations.sparse.coo.complex.ComplexSparseMatrixManipulations
 
ComplexSparseMatrixMultiplication - Class in org.flag4j.operations.sparse.coo.complex
This class contains low level methods for computing the matrix multiplication of sparse complex matrices/vectors.
WARNING: The methods in this class do not perform any sanity checks.
ComplexSparseMatrixMultiplication() - Constructor for class org.flag4j.operations.sparse.coo.complex.ComplexSparseMatrixMultiplication
 
ComplexSparseMatrixOperations - Class in org.flag4j.operations.sparse.coo.complex
This class has low level implementations for operations between two complex sparse matrices.
ComplexSparseMatrixOperations() - Constructor for class org.flag4j.operations.sparse.coo.complex.ComplexSparseMatrixOperations
 
ComplexSparseMatrixProperties - Class in org.flag4j.operations.sparse.coo.complex
This class contains low level implementations for methods to evaluate certain properties of a complex sparse matrix.
ComplexSparseMatrixProperties() - Constructor for class org.flag4j.operations.sparse.coo.complex.ComplexSparseMatrixProperties
 
ComplexSparseNorms - Class in org.flag4j.operations.sparse.coo.complex
This class contains low level implementations of norms for complex sparse tensors, matrices and vector.
ComplexSparseNorms() - Constructor for class org.flag4j.operations.sparse.coo.complex.ComplexSparseNorms
 
ComplexSparseTensorBase<T,U,Y> - Class in org.flag4j.core.sparse_base
This abstract class is the base class of all complex sparse tensors.
ComplexSparseTensorBase(Shape, int, CNumber[], int[][]) - Constructor for class org.flag4j.core.sparse_base.ComplexSparseTensorBase
Creates a sparse tensor with specified shape.
ComplexSparseTensorBase(Shape, int, CNumber[], int[], int[]...) - Constructor for class org.flag4j.core.sparse_base.ComplexSparseTensorBase
Creates a sparse tensor with specified shape.
ComplexSparseVectorOperations - Class in org.flag4j.operations.sparse.coo.complex
This class contains low level implementations of operations on two complex sparse tensors.
ComplexSparseVectorOperations() - Constructor for class org.flag4j.operations.sparse.coo.complex.ComplexSparseVectorOperations
 
ComplexSVD - Class in org.flag4j.linalg.decompositions.svd
Instances of this class can be used to compute the singular value decomposition (SVD) of a real 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.
ComplexTensorExclusiveMixin<T> - Interface in org.flag4j.core
This class specifies methods which any complex tensor that is NOT a matrix or vector should implement.
ComplexTensorMixin<T,Y> - Interface in org.flag4j.core
This interface specifies methods which any complex tensor should implement.
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 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.UnitaryDecomposition
Computes the Householder 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, CNumber) - 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 the jth 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 the jth 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 the jth 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.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.
CONCURRENT_BLOCKED - Enum constant in enum class org.flag4j.operations.MatrixMultiplyDispatcher.AlgorithmName
 
CONCURRENT_BLOCKED - Enum constant in enum class org.flag4j.operations.RealDenseMatrixMultiplyDispatcher.AlgorithmNames
 
CONCURRENT_BLOCKED - Enum constant in enum class org.flag4j.operations.TransposeDispatcher.Algorithm
A concurrent implementation of the blocked algorithm
CONCURRENT_BLOCKED_REORDERED - Enum constant in enum class org.flag4j.operations.MatrixMultiplyDispatcher.AlgorithmName
 
CONCURRENT_BLOCKED_REORDERED - Enum constant in enum class org.flag4j.operations.RealDenseMatrixMultiplyDispatcher.AlgorithmNames
 
CONCURRENT_BLOCKED_VECTOR - Enum constant in enum class org.flag4j.operations.MatrixMultiplyDispatcher.AlgorithmName
 
CONCURRENT_BLOCKED_VECTOR - Enum constant in enum class org.flag4j.operations.RealDenseMatrixMultiplyDispatcher.AlgorithmNames
 
CONCURRENT_REORDERED - Enum constant in enum class org.flag4j.operations.MatrixMultiplyDispatcher.AlgorithmName
 
CONCURRENT_REORDERED - Enum constant in enum class org.flag4j.operations.RealDenseMatrixMultiplyDispatcher.AlgorithmNames
 
CONCURRENT_STANDARD - Enum constant in enum class org.flag4j.operations.MatrixMultiplyDispatcher.AlgorithmName
 
CONCURRENT_STANDARD - Enum constant in enum class org.flag4j.operations.RealDenseMatrixMultiplyDispatcher.AlgorithmNames
 
CONCURRENT_STANDARD - Enum constant in enum class org.flag4j.operations.TransposeDispatcher.Algorithm
A concurrent implementation of the standard algorithm
CONCURRENT_STANDARD_VECTOR - Enum constant in enum class org.flag4j.operations.MatrixMultiplyDispatcher.AlgorithmName
 
CONCURRENT_STANDARD_VECTOR - Enum constant in enum class org.flag4j.operations.RealDenseMatrixMultiplyDispatcher.AlgorithmNames
 
CONCURRENT_SWAPPED_THRESHOLD - Static variable in class org.flag4j.operations.MatrixMultiplyDispatcher
Threshold for matrices to use the concurrent ikj algorithm.
CONCURRENT_SWAPPED_THRESHOLD - Static variable in class org.flag4j.operations.RealDenseMatrixMultiplyDispatcher
Threshold for matrices to use the concurrent ikj algorithm.
CONCURRENT_THRESHOLD - Static variable in class org.flag4j.operations.dense.complex.ComplexDenseElemDiv
Minimum number of entries in each tensor to apply concurrent algorithm.
CONCURRENT_THRESHOLD - Static variable in class org.flag4j.operations.dense.complex.ComplexDenseElemMult
Minimum number of entries in each tensor to apply concurrent algorithm.
CONCURRENT_THRESHOLD - Static variable in class org.flag4j.operations.dense.real_complex.RealComplexDenseElemDiv
Minimum number of entries in each tensor to apply concurrent algorithm.
CONCURRENT_THRESHOLD - Static variable in class org.flag4j.operations.dense.real_complex.RealComplexDenseElemMult
Minimum number of entries in each tensor to apply concurrent algorithm.
CONCURRENT_THRESHOLD - Static variable in class org.flag4j.operations.dense.real.RealDenseElemDiv
Minimum number of entries in each tensor to apply concurrent algorithm.
CONCURRENT_THRESHOLD - Static variable in class org.flag4j.operations.dense.real.RealDenseElemMult
Minimum number of entries in each tensor to apply concurrent algorithm.
CONCURRENT_THRESHOLD - Static variable in class org.flag4j.operations.TransposeDispatcher
Threshold for number of elements in matrix to use concurrent implementation.
concurrentBlocked(double[], Shape, double[], Shape) - Static method in class org.flag4j.operations.dense.real.RealDenseMatrixMultiplication
Computes the matrix multiplication of two real dense matrices using a concurrent implementation of a blocked algorithm.
concurrentBlocked(double[], Shape, CNumber[], Shape) - Static method in class org.flag4j.operations.dense.real_complex.RealComplexDenseMatrixMultiplication
Computes the matrix multiplication of a real dense matrix with a complex dense matrix using a concurrent implementation of a blocked algorithm.
concurrentBlocked(CNumber[], Shape, double[], Shape) - Static method in class org.flag4j.operations.dense.real_complex.RealComplexDenseMatrixMultiplication
Computes the matrix multiplication of a real dense matrix with a complex dense matrix using a concurrent implementation of a blocked algorithm.
concurrentBlocked(CNumber[], Shape, CNumber[], Shape) - Static method in class org.flag4j.operations.dense.complex.ComplexDenseMatrixMultiplication
Computes the matrix multiplication of two real 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 amoung available threads (specified by Configurations.getNumThreads()).
concurrentBlockedReordered(double[], Shape, double[], Shape) - Static method in class org.flag4j.operations.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, CNumber[], Shape) - Static method in class org.flag4j.operations.dense.real_complex.RealComplexDenseMatrixMultiplication
Computes the matrix multiplication of a real dense matrix with a complex dense matrix using a concurrent implementation of a blocked algorithm with the j-k loops swapped.
concurrentBlockedReordered(CNumber[], Shape, double[], Shape) - Static method in class org.flag4j.operations.dense.real_complex.RealComplexDenseMatrixMultiplication
Computes the matrix multiplication of a real dense matrix with a complex dense matrix using a concurrent implementation of a blocked algorithm with the j-k loops swapped.
concurrentBlockedReordered(CNumber[], Shape, CNumber[], Shape) - Static method in class org.flag4j.operations.dense.complex.ComplexDenseMatrixMultiplication
Computes the matrix multiplication of two real 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.operations.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.operations.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, CNumber[], int[]) - Static method in class org.flag4j.operations.dense_sparse.coo.real_complex.RealComplexDenseSparseMatrixMultiplication
Computes the dense matrix sparse vector multiplication using a blocked algorithm.
concurrentBlockedVector(double[], Shape, CNumber[], Shape) - Static method in class org.flag4j.operations.dense.real_complex.RealComplexDenseMatrixMultiplication
Computes the multiplication of a real dense matrix with a complex dense vector using a concurrent implementation of a blocked algorithm.
concurrentBlockedVector(CNumber[], Shape, double[], int[]) - Static method in class org.flag4j.operations.dense_sparse.coo.real_complex.RealComplexDenseSparseMatrixMultiplication
Computes the dense matrix sparse vector multiplication using a blocked algorithm.
concurrentBlockedVector(CNumber[], Shape, double[], Shape) - Static method in class org.flag4j.operations.dense.real_complex.RealComplexDenseMatrixMultiplication
Computes the multiplication of a real dense matrix with a complex dense vector using a concurrent implementation of a blocked algorithm.
concurrentBlockedVector(CNumber[], Shape, CNumber[], int[]) - Static method in class org.flag4j.operations.dense_sparse.coo.complex.ComplexDenseSparseMatrixMultiplication
Computes the dense matrix sparse vector multiplication using a blocked algorithm.
concurrentBlockedVector(CNumber[], Shape, CNumber[], Shape) - Static method in class org.flag4j.operations.dense.complex.ComplexDenseMatrixMultiplication
Computes the multiplication of a real dense matrix with a real 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 amoung available threads (specified by Configurations.getNumThreads()).
concurrentOperation(int, ThreadManager.TriConsumer<Integer, Integer, Integer>) - Static method in class org.flag4j.concurrency.ThreadManager
Executes a concurrent operation on a given range of indices.
concurrentReordered(double[], Shape, double[], Shape) - Static method in class org.flag4j.operations.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, CNumber[], Shape) - Static method in class org.flag4j.operations.dense.real_complex.RealComplexDenseMatrixMultiplication
Computes the matrix multiplication of a real dense matrix with a complex dense matrix using a concurrent implementation of the standard matrix multiplication algorithm with j-k loops swapped.
concurrentReordered(CNumber[], Shape, double[], Shape) - Static method in class org.flag4j.operations.dense.real_complex.RealComplexDenseMatrixMultiplication
Computes the matrix multiplication of a real dense matrix with a complex dense matrix using a concurrent implementation of the standard matrix multiplication algorithm with j-k loops swapped.
concurrentReordered(CNumber[], Shape, CNumber[], Shape) - Static method in class org.flag4j.operations.dense.complex.ComplexDenseMatrixMultiplication
Computes the matrix multiplication of two real 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.operations.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.operations.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, CNumber[], int[], int[], Shape) - Static method in class org.flag4j.operations.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, CNumber[], Shape) - Static method in class org.flag4j.operations.dense_sparse.coo.real_complex.RealComplexDenseSparseMatrixMultiplication
Computes the matrix multiplication between a real sparse matrix and a complex dense matrix using a concurrent standard algorithm.
concurrentStandard(double[], Shape, double[], int[], int[], Shape) - Static method in class org.flag4j.operations.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.operations.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, CNumber[], int[], int[], Shape) - Static method in class org.flag4j.operations.dense_sparse.coo.real_complex.RealComplexDenseSparseMatrixMultiplication
Computes the matrix multiplication between a real dense matrix and a complex sparse matrix using a concurrent standard algorithm.
concurrentStandard(double[], Shape, CNumber[], Shape) - Static method in class org.flag4j.operations.dense.real_complex.RealComplexDenseMatrixMultiplication
Computes the matrix multiplication of a real dense matrix with a complex dense matrix using a concurrent implementation of the standard matrix multiplication algorithm.
concurrentStandard(CNumber[], int[], int[], Shape, double[], int[], int[], Shape) - Static method in class org.flag4j.operations.sparse.coo.real_complex.RealComplexSparseMatrixMultiplication
Computes the matrix multiplication between two sparse matrices using a concurrent implementation of the standard algorithm.
concurrentStandard(CNumber[], int[], int[], Shape, double[], Shape) - Static method in class org.flag4j.operations.dense_sparse.coo.real_complex.RealComplexDenseSparseMatrixMultiplication
Computes the matrix multiplication between a real sparse matrix and a complex dense matrix using a concurrent standard algorithm.
concurrentStandard(CNumber[], int[], int[], Shape, CNumber[], int[], int[], Shape) - Static method in class org.flag4j.operations.sparse.coo.complex.ComplexSparseMatrixMultiplication
Computes the matrix multiplication between two sparse matrices using a concurrent implementation of the standard algorithm.
concurrentStandard(CNumber[], int[], int[], Shape, CNumber[], Shape) - Static method in class org.flag4j.operations.dense_sparse.coo.complex.ComplexDenseSparseMatrixMultiplication
Computes the matrix multiplication between a real sparse matrix and a real dense matrix using a concurrent standard algorithm.
concurrentStandard(CNumber[], Shape, double[], int[], int[], Shape) - Static method in class org.flag4j.operations.dense_sparse.coo.real_complex.RealComplexDenseSparseMatrixMultiplication
Computes the matrix multiplication between a real dense matrix and a complex sparse matrix using a concurrent standard algorithm.
concurrentStandard(CNumber[], Shape, double[], Shape) - Static method in class org.flag4j.operations.dense.real_complex.RealComplexDenseMatrixMultiplication
Computes the matrix multiplication of a real dense matrix with a complex dense matrix using a concurrent implementation of the standard matrix multiplication algorithm.
concurrentStandard(CNumber[], Shape, CNumber[], int[], int[], Shape) - Static method in class org.flag4j.operations.dense_sparse.coo.complex.ComplexDenseSparseMatrixMultiplication
Computes the matrix multiplication between a real dense matrix and a real sparse matrix using a concurrent standard algorithm.
concurrentStandard(CNumber[], Shape, CNumber[], Shape) - Static method in class org.flag4j.operations.dense.complex.ComplexDenseMatrixMultiplication
Computes the matrix multiplication of two real 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.operations.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.operations.dense_sparse.coo.real.RealDenseSparseMatrixMultiplication
Computes the sparse matrix dense vector multiplication using a concurrent standard algorithm.
concurrentStandardVector(double[], int[], int[], Shape, CNumber[], int[], Shape) - Static method in class org.flag4j.operations.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, CNumber[], Shape) - Static method in class org.flag4j.operations.dense_sparse.coo.real_complex.RealComplexDenseSparseMatrixMultiplication
Computes the sparse matrix dense vector multiplication using a concurrent standard algorithm.
concurrentStandardVector(double[], Shape, double[], int[]) - Static method in class org.flag4j.operations.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.operations.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, CNumber[], int[]) - Static method in class org.flag4j.operations.dense_sparse.coo.real_complex.RealComplexDenseSparseMatrixMultiplication
Computes the dense matrix sparse vector multiplication using a concurrent standard algorithm.
concurrentStandardVector(double[], Shape, CNumber[], Shape) - Static method in class org.flag4j.operations.dense.real_complex.RealComplexDenseMatrixMultiplication
Computes the multiplication of a real dense matrix with a complex dense vector using a concurrent implementation of the standard matrix multiplication algorithm.
concurrentStandardVector(CNumber[], int[], int[], Shape, double[], int[], Shape) - Static method in class org.flag4j.operations.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(CNumber[], int[], int[], Shape, double[], Shape) - Static method in class org.flag4j.operations.dense_sparse.coo.real_complex.RealComplexDenseSparseMatrixMultiplication
Computes the sparse matrix dense vector multiplication using a concurrent standard algorithm.
concurrentStandardVector(CNumber[], int[], int[], Shape, CNumber[], int[]) - Static method in class org.flag4j.operations.sparse.coo.complex.ComplexSparseMatrixMultiplication
Computes the multiplication between a sparse matrix and a sparse vector using a concurrent implementation of the standard algorithm.
concurrentStandardVector(CNumber[], int[], int[], Shape, CNumber[], Shape) - Static method in class org.flag4j.operations.dense_sparse.coo.complex.ComplexDenseSparseMatrixMultiplication
Computes the sparse matrix dense vector multiplication using a concurrent standard algorithm.
concurrentStandardVector(CNumber[], Shape, double[], int[]) - Static method in class org.flag4j.operations.dense_sparse.coo.real_complex.RealComplexDenseSparseMatrixMultiplication
Computes the dense matrix sparse vector multiplication using a concurrent standard algorithm.
concurrentStandardVector(CNumber[], Shape, double[], Shape) - Static method in class org.flag4j.operations.dense.real_complex.RealComplexDenseMatrixMultiplication
Computes the multiplication of a real dense matrix with a complex dense vector using a concurrent implementation of the standard matrix multiplication algorithm.
concurrentStandardVector(CNumber[], Shape, CNumber[], int[]) - Static method in class org.flag4j.operations.dense_sparse.coo.complex.ComplexDenseSparseMatrixMultiplication
Computes the dense matrix sparse vector multiplication using a concurrent standard algorithm.
concurrentStandardVector(CNumber[], Shape, CNumber[], Shape) - Static method in class org.flag4j.operations.dense.complex.ComplexDenseMatrixMultiplication
Computes the multiplication of a real dense matrix with a real dense vector using a concurrent implementation of the standard matrix multiplication algorithm.
cond(CMatrix) - Static method in class org.flag4j.linalg.Condition
Computes the condition number of this matrix using the 2-norm.
cond(CMatrix, double) - Static method in class org.flag4j.linalg.Condition
Computes the condition number of this matrix using a specified norm.
cond(Matrix) - Static method in class org.flag4j.linalg.Condition
Computes the condition number of this matrix using the 2-norm.
cond(Matrix, double) - Static method in class org.flag4j.linalg.Condition
Computes the condition number of this matrix using a specified norm.
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.arrays.sparse.CooCVector
 
conj() - Method in class org.flag4j.complex_numbers.CNumber
Computes the complex conjugate of this complex number.
conj() - Method in interface org.flag4j.core.ComplexMatrixMixin
Computes the complex conjugate of a tensor.
conj() - Method in interface org.flag4j.core.ComplexTensorMixin
Computes the complex conjugate of a tensor.
conj() - Method in class org.flag4j.core.dense_base.ComplexDenseTensorBase
Computes the complex conjugate of a tensor.
conj() - Method in class org.flag4j.core.sparse_base.ComplexSparseTensorBase
 
conj(CNumber[]) - Static method in class org.flag4j.operations.common.complex.ComplexOperations
Computes the element-wise complex conjugate of a tensor.
conjT() - Method in interface org.flag4j.core.ComplexMatrixMixin
Computes the complex conjugate transpose of a tensor.
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.complex_numbers.CNumberLexer
Content of the lexer.
CooCMatrix - Class in org.flag4j.arrays.sparse
A Complex sparse matrix.
CooCMatrix(int) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
Creates a square sparse matrix filled with zeros.
CooCMatrix(int, double[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
Creates a square sparse matrix with specified non-zero entries, row indices, and column indices.
CooCMatrix(int, int) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
Creates a sparse matrix of specified size filled with zeros.
CooCMatrix(int, int[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
Creates a square sparse matrix with specified non-zero entries, row indices, and column indices.
CooCMatrix(int, int, double[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
Creates a sparse matrix with specified size, non-zero entries, row indices, and column indices.
CooCMatrix(int, int, int[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
Creates a sparse matrix with specified size, non-zero entries, row indices, and column indices.
CooCMatrix(int, int, CNumber[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
Creates a sparse matrix with specified size, non-zero entries, row indices, and column indices.
CooCMatrix(int, CNumber[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
Creates a square sparse matrix with specified non-zero entries, row indices, and column indices.
CooCMatrix(CooCMatrix) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
Constructs a sparse complex matrix whose non-zero entries, indices, and shape are specified by another complex sparse matrix.
CooCMatrix(Shape) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
Creates a sparse matrix of specified shape filled with zeros.
CooCMatrix(Shape, double[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
Creates a sparse matrix with specified shape, non-zero entries, row indices, and column indices.
CooCMatrix(Shape, int[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
Creates a sparse matrix with specified shape, non-zero entries, row indices, and column indices.
CooCMatrix(Shape, List<CNumber>, List<Integer>, List<Integer>) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
Creates a complex sparse matrix with specified shape, non-zero entries, and indices.
CooCMatrix(Shape, CNumber[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooCMatrix
Creates a sparse matrix with specified shape, non-zero entries, row indices, and column indices.
CooCTensor - Class in org.flag4j.arrays.sparse
Complex sparse tensor.
CooCTensor(CooCTensor) - Constructor for class org.flag4j.arrays.sparse.CooCTensor
Constructs a sparse complex tensor whose non-zero values, indices, and shape are specified by another sparse complex tensor.
CooCTensor(Shape) - Constructor for class org.flag4j.arrays.sparse.CooCTensor
Creates a sparse tensor with specified shape filled with zeros.
CooCTensor(Shape, double[], int[][]) - Constructor for class org.flag4j.arrays.sparse.CooCTensor
Creates a sparse tensor with specified shape filled with zeros.
CooCTensor(Shape, int[], int[][]) - Constructor for class org.flag4j.arrays.sparse.CooCTensor
Creates a sparse tensor with specified shape filled with zeros.
CooCTensor(Shape, List<CNumber>, List<int[]>) - Constructor for class org.flag4j.arrays.sparse.CooCTensor
Creates a sparse tensor with specified shape and non-zero values/indices.
CooCTensor(Shape, CNumber[], int[][]) - Constructor for class org.flag4j.arrays.sparse.CooCTensor
Creates a sparse tensor with specified shape filled with zeros.
CooCVector - Class in org.flag4j.arrays.sparse
Complex sparse vector.
CooCVector(int) - Constructor for class org.flag4j.arrays.sparse.CooCVector
Creates a sparse column vector of specified size filled with zeros.
CooCVector(int, double[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooCVector
Creates a sparse column vector of specified size filled with zeros.
CooCVector(int, int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooCVector
Creates a sparse column vector of specified size filled with zeros.
CooCVector(int, List<CNumber>, List<Integer>) - Constructor for class org.flag4j.arrays.sparse.CooCVector
Creates a sparse vector of specified size, non-zero entries, and non-zero indices.
CooCVector(int, CNumber[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooCVector
Creates a sparse column vector of specified size filled with zeros.
CooCVector(CooCVector) - Constructor for class org.flag4j.arrays.sparse.CooCVector
Constructs a complex sparse vector whose size, orientation, non-zero entries, and indices are specified by another complex sparse vector.
CooMatrix - Class in org.flag4j.arrays.sparse
Real sparse matrix.
CooMatrix(int) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
Creates a square sparse matrix of specified size filled with zeros.
CooMatrix(int, double[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
Creates a square sparse matrix with specified non-zero entries, row indices, and column indices.
CooMatrix(int, int) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
Creates a sparse matrix of specified number of rows and columns filled with zeros.
CooMatrix(int, int[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
Creates a square sparse matrix with specified non-zero entries, row indices, and column indices.
CooMatrix(int, int, double[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
Creates a sparse matrix with specified shape, non-zero entries, row indices, and column indices.
CooMatrix(int, int, int[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
Creates a sparse matrix with specified shape, non-zero entries, row indices, and column indices.
CooMatrix(CooMatrix) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
Constructs a sparse tensor whose shape and values are given by another sparse tensor.
CooMatrix(Shape) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
Creates a sparse matrix of specified shape filled with zeros.
CooMatrix(Shape, double[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
Creates a sparse matrix with specified shape, non-zero entries, row indices, and column indices.
CooMatrix(Shape, int[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
Creates a sparse matrix with specified shape, non-zero entries, row indices, and column indices.
CooMatrix(Shape, List<Double>, List<Integer>, List<Integer>) - Constructor for class org.flag4j.arrays.sparse.CooMatrix
Creates a sparse matrix with specified shape, non-zero entries, and indices.
CooTensor - Class in org.flag4j.arrays.sparse
Real sparse tensor.
CooTensor(CooTensor) - Constructor for class org.flag4j.arrays.sparse.CooTensor
Constructs a sparse tensor whose shape and non-zero values/indices are given by another sparse tensor.
CooTensor(Shape) - Constructor for class org.flag4j.arrays.sparse.CooTensor
Creates a sparse tensor with specified shape filled with zeros.
CooTensor(Shape, double[], int[][]) - Constructor for class org.flag4j.arrays.sparse.CooTensor
Creates a sparse tensor with specified shape and non-zero values/indices.
CooTensor(Shape, int[], int[][]) - Constructor for class org.flag4j.arrays.sparse.CooTensor
Creates a sparse tensor with specified shape and non-zero values/indices.
CooTensor(Shape, List<Double>, List<int[]>) - Constructor for class org.flag4j.arrays.sparse.CooTensor
Creates a sparse tensor with specified shape and non-zero values/indices.
CooVector - Class in org.flag4j.arrays.sparse
Real sparse vector stored in coordinate (COO) format.
CooVector(int) - Constructor for class org.flag4j.arrays.sparse.CooVector
Creates a sparse vector of specified size filled with zeros.
CooVector(int, double[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooVector
Creates a sparse vector of specified size along with non-zero entries and their indices.
CooVector(int, int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CooVector
Creates a sparse vector of specified size filled with zeros.
CooVector(int, List<Double>, List<Integer>) - Constructor for class org.flag4j.arrays.sparse.CooVector
Creates a sparse vector of specified size, non-zero entries, and non-zero indices.
CooVector(CooVector) - Constructor for class org.flag4j.arrays.sparse.CooVector
Constructs a sparse vector whose non-zero values, indices, and size are specified by another sparse vector.
copy() - Method in class org.flag4j.arrays.sparse.CooCMatrix
Creates a copy of this tensor.
copy() - Method in class org.flag4j.arrays.sparse.CooCTensor
Creates a copy of this tensor.
copy() - Method in class org.flag4j.arrays.sparse.CooCVector
Creates a dense copy of this tensor.
copy() - Method in class org.flag4j.arrays.sparse.CooMatrix
Creates a copy of this tensor.
copy() - Method in class org.flag4j.arrays.sparse.CooTensor
Creates a copy of this tensor.
copy() - Method in class org.flag4j.arrays.sparse.CooVector
Creates a copy of this tensor.
copy() - Method in class org.flag4j.arrays.sparse.CsrCMatrix
Creates a copy of this tensor.
copy() - Method in class org.flag4j.arrays.sparse.CsrMatrix
Creates a copy of this tensor.
copy() - Method in class org.flag4j.arrays.sparse.PermutationMatrix
Creates a copy of this permutation matrix.
copy() - Method in class org.flag4j.core.dense_base.ComplexDenseTensorBase
Creates a deep copy of this tensor.
copy() - Method in class org.flag4j.core.dense_base.RealDenseTensorBase
Creates a deep copy of this tensor.
copy() - Method in interface org.flag4j.core.MatrixOperationsMixin
Copies this matrix.
copy() - Method in interface org.flag4j.core.TensorOperationsMixin
Creates a copy of this tensor.
copy2CNumber(double[], CNumber[]) - Static method in class org.flag4j.util.ArrayUtils
Converts array to an array of complex numbers.
copy2CNumber(int[], CNumber[]) - Static method in class org.flag4j.util.ArrayUtils
Converts array to an array of complex numbers.
copy2CNumber(Double[], CNumber[]) - Static method in class org.flag4j.util.ArrayUtils
Converts array to an array of complex numbers.
copy2CNumber(Integer[], CNumber[]) - Static method in class org.flag4j.util.ArrayUtils
Converts array to an array of complex numbers.
copy2CNumber(String[], CNumber[]) - Static method in class org.flag4j.util.ArrayUtils
Converts array to an array of complex numbers.
copyIndices() - Method in class org.flag4j.core.sparse_base.ComplexSparseTensorBase
Creates a deep copy of the indices of this sparse tensor.
copyIndices() - Method in class org.flag4j.core.sparse_base.RealSparseTensorBase
Creates a deep copy of the indices of this sparse tensor.
copyRanges(CooCMatrix, CNumber[], int[], int[], int[]) - Static method in class org.flag4j.operations.sparse.coo.complex.ComplexSparseMatrixManipulations
A helper method which copies from a sparse matrix to a set of three arrays (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.operations.sparse.coo.real.RealSparseMatrixManipulations
A helper method which copies from a sparse matrix to a set of three arrays (non-zero entries, row indices, and column indices) but skips over a specified range.
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(CooCMatrix, List<CNumber>, List<Integer>, List<Integer>, int[], int[]) - Static method in class org.flag4j.operations.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.operations.sparse.coo.real.RealSparseMatrixGetSet
Copies values in sparse matrix which do not fall in the specified row and column ranges.
cos(double) - Static method in class org.flag4j.complex_numbers.CNumber
Computes the trigonometric cosine of a value.
cos(CNumber) - Static method in class org.flag4j.complex_numbers.CNumber
Computes the trigonometric cosine value of a complex value.
cosh(double) - Static method in class org.flag4j.complex_numbers.CNumber
Computes the hyperbolic cosine of a value.
cosh(CNumber) - Static method in class org.flag4j.complex_numbers.CNumber
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.operations.sparse.coo.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.core.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 to numUnique(arr) - 1.
cross(CVector) - Method in class org.flag4j.arrays.dense.CVector
Computes the vector cross product between two vectors.
cross(CVector) - Method in class org.flag4j.arrays.dense.Vector
Computes the vector cross product between two vectors.
cross(Vector) - Method in class org.flag4j.arrays.dense.CVector
Computes the vector cross product between two vectors.
cross(Vector) - Method in class org.flag4j.arrays.dense.Vector
Computes the vector cross product between two vectors.
CsrCMatrix - Class in org.flag4j.arrays.sparse
Complex sparse matrix stored in compressed sparse row (CSR) format.
CsrCMatrix(int, int) - Constructor for class org.flag4j.arrays.sparse.CsrCMatrix
Constructs an empty sparse CSR matrix with the specified shape.
CsrCMatrix(int, int, CNumber[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CsrCMatrix
Constructs a sparse matrix in CSR format with specified row-pointers, column indices and non-zero entries.
CsrCMatrix(CooCMatrix) - Constructor for class org.flag4j.arrays.sparse.CsrCMatrix
Converts a sparse COO matrix to a sparse CSR matrix.
CsrCMatrix(CooMatrix) - Constructor for class org.flag4j.arrays.sparse.CsrCMatrix
Converts a real sparse COO matrix to a complex sparse CSR matrix.
CsrCMatrix(CsrCMatrix) - Constructor for class org.flag4j.arrays.sparse.CsrCMatrix
Constructs a sparse CSR matrix which is a deep copy of the src matrix.
CsrCMatrix(Shape) - Constructor for class org.flag4j.arrays.sparse.CsrCMatrix
Constructs an empty sparse CSR matrix with the specified shape.
CsrCMatrix(Shape, double[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CsrCMatrix
Constructs a sparse matrix in CSR format with specified row-pointers, column indices and non-zero entries.
CsrCMatrix(Shape, CNumber[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CsrCMatrix
Constructs a sparse matrix in CSR format with specified row-pointers, column indices and non-zero entries.
CSREquals(CsrCMatrix, CsrCMatrix) - Static method in class org.flag4j.arrays.sparse.SparseUtils
Checks if two Complex CSR 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.arrays.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.
CsrMatrix - Class in org.flag4j.arrays.sparse
Real sparse matrix stored in compressed sparse row (CSR) format.
CsrMatrix(int, int) - Constructor for class org.flag4j.arrays.sparse.CsrMatrix
Constructs an empty sparse CSR matrix with the specified shape.
CsrMatrix(int, int, double[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CsrMatrix
Constructs a sparse matrix in CSR format with specified row-pointers, column indices and non-zero entries.
CsrMatrix(CooMatrix) - Constructor for class org.flag4j.arrays.sparse.CsrMatrix
Converts a sparse COO matrix to a sparse CSR matrix.
CsrMatrix(CsrMatrix) - Constructor for class org.flag4j.arrays.sparse.CsrMatrix
Constructs a sparse CSR matrix which is a deep copy of the src matrix.
CsrMatrix(Shape) - Constructor for class org.flag4j.arrays.sparse.CsrMatrix
Constructs an empty sparse CSR matrix with the specified shape.
CsrMatrix(Shape, double[], int[], int[]) - Constructor for class org.flag4j.arrays.sparse.CsrMatrix
Constructs a sparse matrix in CSR format with specified row-pointers, column indices and non-zero entries.
CTensor - Class in org.flag4j.arrays.dense
Complex dense tensor.
CTensor(CTensor) - Constructor for class org.flag4j.arrays.dense.CTensor
Creates a complex tensor whose shape and entries are specified by another tensor.
CTensor(Tensor) - Constructor for class org.flag4j.arrays.dense.CTensor
Creates a complex tensor whose shape and entries are specified by another tensor.
CTensor(Shape) - Constructor for class org.flag4j.arrays.dense.CTensor
Constructs a tensor with given shape filled with zeros.
CTensor(Shape, double) - Constructor for class org.flag4j.arrays.dense.CTensor
Constructs a tensor with given shape filled with specified values.
CTensor(Shape, double[]) - Constructor for class org.flag4j.arrays.dense.CTensor
Constructs a tensor with given shape filled with specified values.
CTensor(Shape, int[]) - Constructor for class org.flag4j.arrays.dense.CTensor
Constructs a tensor with given shape filled with specified values.
CTensor(Shape, CNumber) - Constructor for class org.flag4j.arrays.dense.CTensor
Constructs a tensor with given shape filled with specified values.
CTensor(Shape, CNumber[]) - Constructor for class org.flag4j.arrays.dense.CTensor
Constructs a tensor with given shape filled with specified values.
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 Householder reflector.
CVector - Class in org.flag4j.arrays.dense
Complex dense vector.
CVector(double...) - Constructor for class org.flag4j.arrays.dense.CVector
Creates a vector with specified entries.
CVector(int) - Constructor for class org.flag4j.arrays.dense.CVector
Creates a column vector of specified size filled with zeros.
CVector(int...) - Constructor for class org.flag4j.arrays.dense.CVector
Creates a vector with specified entries.
CVector(int, double) - Constructor for class org.flag4j.arrays.dense.CVector
Creates a vector of specified size filled with a specified value.
CVector(int, CNumber) - Constructor for class org.flag4j.arrays.dense.CVector
Creates a vector of specified size filled with a specified value.
CVector(CVector) - Constructor for class org.flag4j.arrays.dense.CVector
Constructs a complex vector whose entries and shape are specified by another complex vector.
CVector(Vector) - Constructor for class org.flag4j.arrays.dense.CVector
Constructs a complex vector whose entries and shape are specified by another real vector.
CVector(CNumber...) - Constructor for class org.flag4j.arrays.dense.CVector
Creates a vector with specified entries.
A B C D E F G H I J K L M N O P Q R S T U V W X Z 
All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form