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

R

R - Variable in class org.flag4j.linalg.solvers.lstsq.LstsqSolver
R The upper triangular matrix from the QR decomposition.
RAND_ARRAY - Variable in class org.flag4j.rng.RandomTensor
 
randn() - Method in class org.flag4j.rng.RandomCNumber
Generates a pseudorandom complex number with normally distributed magnitude with a mean of 0.0 and standard deviation of 1.0.
randn(double, double) - Method in class org.flag4j.rng.RandomCNumber
Generates a pseudorandom complex number with normally distributed magnitude with a specified mean and standard deviation.
randnCMatrix(int, int) - Method in class org.flag4j.rng.RandomTensor
Generates a matrix filled with pseudorandom complex values with magnitudes sampled from a normal distribution with a mean of 0.0 and a standard deviation of 1.0.
randnCMatrix(int, int, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a matrix filled with pseudorandom complex values with magnitudes sampled from a normal distribution with a specified mean and standard deviation.
randnCMatrix(Shape) - Method in class org.flag4j.rng.RandomTensor
Generates a matrix filled with pseudorandom complex values with magnitudes sampled from a normal distribution with a mean of 0.0 and a standard deviation of 1.0.
randnCMatrix(Shape, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a matrix filled with pseudorandom values sampled from a normal distribution with a specified mean and standard deviation.
randnCTensor(Shape) - Method in class org.flag4j.rng.RandomTensor
Generates a tensor filled with pseudorandom values sampled from a normal distribution with mean of 0.0 and standard deviation of 1.0.
randnCTensor(Shape, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a tensor filled with pseudorandom values sampled from a normal distribution with specified mean and standard deviation.
randnCVector(int) - Method in class org.flag4j.rng.RandomTensor
Generates a vector filled with pseudorandom values with magnitudes sampled from a normal distribution with a mean of 0.0 and a standard deviation of 1.0.
randnCVector(int, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a vector filled with pseudorandom values with magnitudes sampled from a normal distribution with specified mean and standard deviation.
randnMatrix(int, int) - Method in class org.flag4j.rng.RandomTensor
Generates a matrix filled with pseudorandom values sampled from a normal distribution with a mean of 0.0 and a standard deviation of 1.0.
randnMatrix(int, int, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a matrix filled with pseudorandom values sampled from a normal distribution with a specified mean and standard deviation.
randnMatrix(Shape) - Method in class org.flag4j.rng.RandomTensor
Generates a matrix filled with pseudorandom values sampled from a normal distribution with a mean of 0.0 and a standard deviation of 1.0.
randnMatrix(Shape, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a matrix filled with pseudorandom values sampled from a normal distribution with a specified mean and standard deviation.
randnTensor(Shape) - Method in class org.flag4j.rng.RandomTensor
Generates a tensor filled with pseudorandom values sampled from a normal distribution with mean of 0.0 and standard deviation of 1.0.
randnTensor(Shape, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a tensor filled with pseudorandom values sampled from a normal distribution with specified mean and standard deviation.
randnVector(int) - Method in class org.flag4j.rng.RandomTensor
Generates a vector filled with pseudorandom values sampled from a normal distribution with a mean of 0.0 and a standard deviation of 1.0.
randnVector(int, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a vector filled with pseudorandom values sampled from a normal distribution with specified mean and standard deviation.
random() - Method in class org.flag4j.rng.RandomCNumber
Generates a pseudorandom complex number which is uniformly distributed on the unit disk within the complex plane.
random(double) - Method in class org.flag4j.rng.RandomCNumber
Generates pseudorandom complex number with specified magnitude which is uniformly distributed around the origin.
random(double, double) - Method in class org.flag4j.rng.RandomCNumber
Generates a pseudorandom complex number with magnitude in [min, max) which is uniformly distributed in the annulus (i.e.
RandomArray - Class in org.flag4j.rng
This class contains methods useful for generating arrays filled with random values.
RandomArray() - Constructor for class org.flag4j.rng.RandomArray
Creates a RandomArray object to generate arrays filled with random values using a default random number generator.
RandomArray(RandomCNumber) - Constructor for class org.flag4j.rng.RandomArray
Creates a RandomArray object to generate arrays filled with random values using the specified complex random number generator.
randomCMatrix(int, int) - Method in class org.flag4j.rng.RandomTensor
Generates a matrix filled with pseudorandom complex values with magnitudes uniformly distributed in [0, 1).
randomCMatrix(int, int, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a matrix filled with pseudorandom complex values with magnitudes uniformly distributed in [min, max).
randomCMatrix(Shape) - Method in class org.flag4j.rng.RandomTensor
Generates a matrix filled with pseudorandom complex values with magnitudes uniformly distributed in [0, 1).
randomCMatrix(Shape, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a matrix filled with pseudorandom complex values with magnitudes uniformly distributed in [min, max).
RandomCNumber - Class in org.flag4j.rng
An instance of this class is used to generate a stream of random complex numbers.
RandomCNumber() - Constructor for class org.flag4j.rng.RandomCNumber
Constructs a complex value random number generator.
RandomCNumber(long) - Constructor for class org.flag4j.rng.RandomCNumber
Constructs a complex value random number generator.
randomCooMatrix(int, int, double, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a random sparse matrix with the specified sparsity.
randomCooMatrix(int, int, double, double, int) - Method in class org.flag4j.rng.RandomTensor
Generates a random sparse matrix with the specified number of non-zero entries.
randomCooMatrix(Shape, double, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a random sparse matrix with the specified sparsity.
randomCooMatrix(Shape, double, double, int) - Method in class org.flag4j.rng.RandomTensor
Generates a random sparse matrix with the specified number of non-zero entries.
randomCsrMatrix(int, int, double, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a random sparse matrix with the specified sparsity.
randomCsrMatrix(int, int, double, double, int) - Method in class org.flag4j.rng.RandomTensor
Generates a random sparse matrix with the specified number of non-zero entries.
randomCsrMatrix(Shape, double, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a random sparse matrix with the specified sparsity.
randomCsrMatrix(Shape, double, double, int) - Method in class org.flag4j.rng.RandomTensor
Generates a random sparse matrix with the specified number of non-zero entries.
randomCTensor(Shape) - Method in class org.flag4j.rng.RandomTensor
Generates a tensor filled with pseudorandom complex values with magnitudes uniformly distributed in [0, 1).
randomCTensor(Shape, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a tensor filled with pseudorandom values with magnitudes uniformly distributed in [min, max).
randomCVector(int) - Method in class org.flag4j.rng.RandomTensor
Generates a vector filled with pseudorandom complex values with magnitudes uniformly distributed in [0, 1).
randomCVector(int, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a vector filled with pseudorandom values with magnitudes uniformly distributed in [min, max).
randomMatrix(int, int) - Method in class org.flag4j.rng.RandomTensor
Generates a matrix filled with pseudorandom values uniformly distributed in [0, 1).
randomMatrix(int, int, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a matrix filled with pseudorandom values uniformly distributed in [min, max).
randomMatrix(Shape) - Method in class org.flag4j.rng.RandomTensor
Generates a matrix filled with pseudorandom values uniformly distributed in [0, 1).
randomMatrix(Shape, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a matrix filled with pseudorandom values uniformly distributed in [min, max).
randomOrthogonalMatrix(int) - Method in class org.flag4j.rng.RandomTensor
Gets a pseudorandom orthogonal matrix.
randomSparseCMatrix(int, int, double, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a random sparse matrix with the specified sparsity.
randomSparseCMatrix(int, int, double, double, int) - Method in class org.flag4j.rng.RandomTensor
Generates a random sparse matrix with the specified number of non-zero entries.
randomSparseCMatrix(Shape, double, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a random sparse matrix with the specified sparsity.
randomSparseCMatrix(Shape, double, double, int) - Method in class org.flag4j.rng.RandomTensor
Generates a random sparse matrix with the specified number of non-zero entries.
randomSymmetricCooMatrix(int, int, int, double) - Method in class org.flag4j.rng.RandomTensor
Generates a symmetric COO matrix filled with pseudorandom values uniformly distributed in [min, max).
randomSymmetricCsrMatrix(int, int, int, double) - Method in class org.flag4j.rng.RandomTensor
Generates a symmetric CSR matrix filled with pseudorandom values uniformly distributed in [min, max).
randomSymmetricMatrix(int) - Method in class org.flag4j.rng.RandomTensor
Generates a symmetric matrix filled with pseudorandom values uniformly distributed in [0, 1).
randomTensor(Shape) - Method in class org.flag4j.rng.RandomTensor
Generates a tensor filled with pseudorandom values uniformly distributed in [0, 1).
randomTensor(Shape, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a tensor filled with pseudorandom values uniformly distributed in [min, max).
RandomTensor - Class in org.flag4j.rng
An instance of this class is used for generating streams of pseudorandom tensors, matrices, and vectors.
RandomTensor() - Constructor for class org.flag4j.rng.RandomTensor
Constructs a new pseudorandom tensor generator with a seed which is unlikely to be the same as other from any other invocation of this constructor.
RandomTensor(long) - Constructor for class org.flag4j.rng.RandomTensor
Constructs a pseudorandom tensor generator with a specified seed.
randomTriuMatrix(int, int, int) - Method in class org.flag4j.rng.RandomTensor
Gets a pseudorandom upper triangular matrix of the specified size.
randomUniqueIndices(int, int, int) - Method in class org.flag4j.rng.RandomArray
Creates unique indices in [start, end).
randomUniqueIndices2D(int, int, int, int, int) - Method in class org.flag4j.rng.RandomArray
Creates a list of unique two-dimensional indices.
randomUnitaryMatrix(int) - Method in class org.flag4j.rng.RandomTensor
Gets a pseudorandom unitary matrix.
randomVector(int) - Method in class org.flag4j.rng.RandomTensor
Generates a vector filled with pseudorandom values uniformly distributed in [0, 1).
randomVector(int, double, double) - Method in class org.flag4j.rng.RandomTensor
Generates a vector filled with pseudorandom values uniformly distributed in [min, max).
range(int, int) - Static method in class org.flag4j.util.ArrayUtils
Gets an array filled with integers from start (inclusive) to end (exclusive)
RANGE_ERR - Static variable in class org.flag4j.util.ErrorMessages
Error message for a parameter which is not within the expected range.
rank - Variable in class org.flag4j.linalg.decompositions.svd.SVD
The rank of the matrix being decomposed.
RANK_CONDITION - Static variable in class org.flag4j.linalg.solvers.exact.triangular.BackSolver
Threshold for determining if a determinant is to be considered zero when checking if the coefficient matrix is full rank.
RANK_CONDITION - Static variable in class org.flag4j.linalg.solvers.exact.triangular.ForwardSolver
Threshold for determining if a determinant is to be considered zero when checking if the coefficient matrix is full rank.
re - Variable in class org.flag4j.complex_numbers.CNumber
Real component of the complex number.
re() - Method in class org.flag4j.complex_numbers.CNumber
Gets the real component of this complex number.
read() - Method in class org.flag4j.io.TensorInputStream
Reads a byte of data.
readMatrix() - Method in class org.flag4j.io.TensorInputStream
Reads a serialized matrix from a file.
readMatrix(String) - Static method in class org.flag4j.io.TensorReader
Reads a serialized matrix from a specified file using a TensorInputStream.
readTensor() - Method in class org.flag4j.io.TensorInputStream
Reads a serialized tesnor from a file.
readTensor(String) - Static method in class org.flag4j.io.TensorReader
Reads a serialized tensor from a specified file using a TensorInputStream.
readVector() - Method in class org.flag4j.io.TensorInputStream
Reads a serialized vector from a file.
readVector(String) - Static method in class org.flag4j.io.TensorReader
Reads a serialized vector from a specified file using a TensorInputStream.
real2ComplexSchur() - Method in class org.flag4j.linalg.decompositions.schur.ComplexSchur
 
real2ComplexSchur() - Method in class org.flag4j.linalg.decompositions.schur.RealSchur
Converts the real schur form computed in the last decomposition to the complex Schur form.
RealBackSolver - Class in org.flag4j.linalg.solvers.exact.triangular
This solver solves linear systems of equations where the coefficient matrix in an upper triangular real dense matrix and the constant vector is a real dense vector or matrix.
RealBackSolver() - Constructor for class org.flag4j.linalg.solvers.exact.triangular.RealBackSolver
Creates a solver for solving linear systems for upper triangular coefficient matrices.
RealBackSolver(boolean) - Constructor for class org.flag4j.linalg.solvers.exact.triangular.RealBackSolver
Creates a solver for solving linear systems for upper triangular coefficient matrices.
RealCholesky - Class in org.flag4j.linalg.decompositions.chol
An instance of this class allows for the computation of a Cholesky decomposition for a real dense matrix.
RealCholesky() - Constructor for class org.flag4j.linalg.decompositions.chol.RealCholesky
Constructs a Cholesky decomposer.
RealCholesky(boolean) - Constructor for class org.flag4j.linalg.decompositions.chol.RealCholesky
Constructs a Cholesky decomposer.
RealComplexCooTensorOperations - Class in org.flag4j.operations.sparse.coo.real_complex
Utility class for computing operations between a complex sparse COO tensor and a real coo tensor.
RealComplexCooTensorOperations() - Constructor for class org.flag4j.operations.sparse.coo.real_complex.RealComplexCooTensorOperations
 
RealComplexCsrDenseMatrixMultiplication - Class in org.flag4j.operations.dense_sparse.csr.real_complex
This class contains low-level implementations of real-complex sparse-dense matrix multiplication where the sparse matrix is in CSR format.
RealComplexCsrDenseMatrixMultiplication() - Constructor for class org.flag4j.operations.dense_sparse.csr.real_complex.RealComplexCsrDenseMatrixMultiplication
 
RealComplexCsrDenseOperations - Class in org.flag4j.operations.dense_sparse.csr.real_complex
This class contains low-level operations which act on a real/complex dense and a complex/real sparse CSR matrix.
RealComplexCsrDenseOperations() - Constructor for class org.flag4j.operations.dense_sparse.csr.real_complex.RealComplexCsrDenseOperations
 
RealComplexCsrMatrixMultiplication - Class in org.flag4j.operations.sparse.csr.real_complex
This class provides low-level implementation of matrix multiplication between a real CSR matrix and a complex CSR matrix.
RealComplexCsrMatrixMultiplication() - Constructor for class org.flag4j.operations.sparse.csr.real_complex.RealComplexCsrMatrixMultiplication
 
RealComplexCsrOperations - Class in org.flag4j.operations.sparse.csr.real_complex
This class contains low-level implementations for element-wise operations on real/complex CSR matrices.
RealComplexCsrOperations() - Constructor for class org.flag4j.operations.sparse.csr.real_complex.RealComplexCsrOperations
 
RealComplexDenseElemDiv - Class in org.flag4j.operations.dense.real_complex
This class contains low-level implementations of element-wise tensor division for a real dense and complex dense tensor.
RealComplexDenseElemDiv() - Constructor for class org.flag4j.operations.dense.real_complex.RealComplexDenseElemDiv
 
RealComplexDenseElemMult - Class in org.flag4j.operations.dense.real_complex
This class contains low-level implementations of element-wise tensor multiplication for a real dense and complex dense tensor.
RealComplexDenseElemMult() - Constructor for class org.flag4j.operations.dense.real_complex.RealComplexDenseElemMult
 
RealComplexDenseEquals - Class in org.flag4j.operations.dense.real_complex
This class provides methods for checking the equality of one real and one complex dense tensors.
RealComplexDenseEquals() - Constructor for class org.flag4j.operations.dense.real_complex.RealComplexDenseEquals
 
RealComplexDenseMatrixMultiplication - Class in org.flag4j.operations.dense.real_complex
This class contains several low level methods for computing real/complex matrix-matrix multiplications.
RealComplexDenseMatrixMultiplication() - Constructor for class org.flag4j.operations.dense.real_complex.RealComplexDenseMatrixMultiplication
 
RealComplexDenseMatrixMultTranspose - Class in org.flag4j.operations.dense.real_complex
This class contains several low level methods for computing matrix-matrix multiplications with a transpose for a real dense matrix and a complex dense matrix.
RealComplexDenseMatrixMultTranspose() - Constructor for class org.flag4j.operations.dense.real_complex.RealComplexDenseMatrixMultTranspose
 
RealComplexDenseOperations - Class in org.flag4j.operations.dense.real_complex
This class provides low level methods for computing operations with at least one real tensor and at least one complex tensor.
RealComplexDenseOperations() - Constructor for class org.flag4j.operations.dense.real_complex.RealComplexDenseOperations
 
RealComplexDenseSparseEquals - Class in org.flag4j.operations.dense_sparse.coo.real_complex
This class contains methods for checking the equality of real dense/sparse and complex dense/sparse tensors.
RealComplexDenseSparseEquals() - Constructor for class org.flag4j.operations.dense_sparse.coo.real_complex.RealComplexDenseSparseEquals
 
RealComplexDenseSparseMatrixMultiplication - Class in org.flag4j.operations.dense_sparse.coo.real_complex
This class contains low level methods for computing the matrix multiplication (and matrix vector multiplication) between a real dense/sparse matrix and a real sparse/dense matrix or vector.
RealComplexDenseSparseMatrixMultiplication() - Constructor for class org.flag4j.operations.dense_sparse.coo.real_complex.RealComplexDenseSparseMatrixMultiplication
 
RealComplexDenseSparseMatrixMultTranspose - Class in org.flag4j.operations.dense_sparse.coo.real_complex
This class contains several low level methods for computing matrix-matrix multiplications with a transpose for a real/complex sparse/dense
WARNING: These methods do not perform any sanity checks.
RealComplexDenseSparseMatrixMultTranspose() - Constructor for class org.flag4j.operations.dense_sparse.coo.real_complex.RealComplexDenseSparseMatrixMultTranspose
 
RealComplexDenseSparseMatrixOperations - Class in org.flag4j.operations.dense_sparse.coo.real_complex
This class contains low level implementations of operations between real/complex and dense/sparse matrices.
RealComplexDenseSparseMatrixOperations() - Constructor for class org.flag4j.operations.dense_sparse.coo.real_complex.RealComplexDenseSparseMatrixOperations
 
RealComplexDenseSparseOperations - Class in org.flag4j.operations.dense_sparse.coo.real_complex
This class contains methods to apply common binary operations to a real/complex dense matrix and to a complex/real sparse matrix.
RealComplexDenseSparseOperations() - Constructor for class org.flag4j.operations.dense_sparse.coo.real_complex.RealComplexDenseSparseOperations
 
RealComplexDenseSparseVectorOperations - Class in org.flag4j.operations.dense_sparse.coo.real_complex
This class provides low level methods for computing operations between a real/complex dense/sparse vector and a complex/real sparse/dense vector.
RealComplexDenseSparseVectorOperations() - Constructor for class org.flag4j.operations.dense_sparse.coo.real_complex.RealComplexDenseSparseVectorOperations
 
RealComplexDenseVectorOperations - Class in org.flag4j.operations.dense.real_complex
This class provides low level implementations for vector operations with a real/complex dense vector and a complex/real dense vector.
RealComplexDenseVectorOperations() - Constructor for class org.flag4j.operations.dense.real_complex.RealComplexDenseVectorOperations
 
RealComplexSparseEquals - Class in org.flag4j.operations.sparse.coo.real_complex
This class contains methods for checking the equality of real/complex sparse tensors.
RealComplexSparseEquals() - Constructor for class org.flag4j.operations.sparse.coo.real_complex.RealComplexSparseEquals
 
RealComplexSparseMatrixMultiplication - Class in org.flag4j.operations.sparse.coo.real_complex
This class contains low level methods for computing the multiplication between a real/complex matrix and a complex/real matrix/vector.
RealComplexSparseMatrixMultiplication() - Constructor for class org.flag4j.operations.sparse.coo.real_complex.RealComplexSparseMatrixMultiplication
 
RealComplexSparseMatrixOperations - Class in org.flag4j.operations.sparse.coo.real_complex
This class has low level implementations for operations between a real sparse matrix and a complex sparse matrix.
RealComplexSparseMatrixOperations() - Constructor for class org.flag4j.operations.sparse.coo.real_complex.RealComplexSparseMatrixOperations
 
RealComplexSparseVectorOperations - Class in org.flag4j.operations.sparse.coo.real_complex
This class contains low level implementations of operations on a real sparse tensor and a complex sparse tensor.
RealComplexSparseVectorOperations() - Constructor for class org.flag4j.operations.sparse.coo.real_complex.RealComplexSparseVectorOperations
 
RealCooTensorDot - Class in org.flag4j.operations.sparse.coo.real
Utility class for computing tensor dot products between two real sparse COO tensors.
RealCooTensorDot() - Constructor for class org.flag4j.operations.sparse.coo.real.RealCooTensorDot
 
RealCooTensorOperations - Class in org.flag4j.operations.sparse.coo.real
Utility class for computing operations between two real sparse COO tensors.
RealCooTensorOperations() - Constructor for class org.flag4j.operations.sparse.coo.real.RealCooTensorOperations
 
RealCsrConcats - Class in org.flag4j.operations.sparse.csr.real
Utility class for concatenating real CSR matrices
RealCsrConcats() - Constructor for class org.flag4j.operations.sparse.csr.real.RealCsrConcats
 
RealCsrDenseMatrixMultiplication - Class in org.flag4j.operations.dense_sparse.csr.real
This class contains low-level implementations of real sparse-dense matrix multiplication where the sparse matrix is in CSR format.
RealCsrDenseMatrixMultiplication() - Constructor for class org.flag4j.operations.dense_sparse.csr.real.RealCsrDenseMatrixMultiplication
 
RealCsrDenseOperations - Class in org.flag4j.operations.dense_sparse.csr.real
This class contains low-level operations which act on a real dense and a real sparse CSR matrix.
RealCsrDenseOperations() - Constructor for class org.flag4j.operations.dense_sparse.csr.real.RealCsrDenseOperations
 
RealCsrEquals - Class in org.flag4j.operations.sparse.csr.real
This class contains methods to check equality or approximate equality between two sparse CSR matrices.
RealCsrEquals() - Constructor for class org.flag4j.operations.sparse.csr.real.RealCsrEquals
 
RealCsrManipulations - Class in org.flag4j.operations.sparse.csr.real
Utility class for manipulating real sparse CSR matrices (e.g.
RealCsrManipulations() - Constructor for class org.flag4j.operations.sparse.csr.real.RealCsrManipulations
 
RealCsrMatrixMultiplication - Class in org.flag4j.operations.sparse.csr.real
This class provides low-level implementation of matrix multiplication between two real CSR matrices.
RealCsrMatrixMultiplication() - Constructor for class org.flag4j.operations.sparse.csr.real.RealCsrMatrixMultiplication
 
RealCsrOperations - Class in org.flag4j.operations.sparse.csr.real
This class contains low-level implementations for element-wise operations on CSR matrices.
RealCsrOperations() - Constructor for class org.flag4j.operations.sparse.csr.real.RealCsrOperations
 
RealCsrProperties - Class in org.flag4j.operations.sparse.csr.real
This class contains low-level implementations for determining certain properties of real sparse CSR matrices.
RealCsrProperties() - Constructor for class org.flag4j.operations.sparse.csr.real.RealCsrProperties
 
RealDenseDeterminant - Class in org.flag4j.operations.dense.real
This class contains methods for computing the determinant of a real dense matrix.
RealDenseDeterminant() - Constructor for class org.flag4j.operations.dense.real.RealDenseDeterminant
 
RealDenseElemDiv - Class in org.flag4j.operations.dense.real
This class contains low level implementations of element-wise division algorithms for real dense tensors.
RealDenseElemDiv() - Constructor for class org.flag4j.operations.dense.real.RealDenseElemDiv
 
RealDenseElemMult - Class in org.flag4j.operations.dense.real
This class contains low level implementations of element-wise multiplications algorithms for real dense tensors.
RealDenseElemMult() - Constructor for class org.flag4j.operations.dense.real.RealDenseElemMult
 
RealDenseEquals - Class in org.flag4j.operations.dense.real
This class provides methods for checking the equality of real dense tensors.
RealDenseEquals() - Constructor for class org.flag4j.operations.dense.real.RealDenseEquals
 
realDenseLookUp - Static variable in class org.flag4j.operations.common.TensorEquals
 
RealDenseMatrixMultiplication - Class in org.flag4j.operations.dense.real
This class contains several low level methods for computing matrix-matrix multiplications.
RealDenseMatrixMultiplication() - Constructor for class org.flag4j.operations.dense.real.RealDenseMatrixMultiplication
 
RealDenseMatrixMultiplyDispatcher - Class in org.flag4j.operations
Singleton class which stores a map of all viable real dense matrix multiply algorithms and uses that map to dispatch a real dense matrix multiply problem to the appropriate algorithm.
RealDenseMatrixMultiplyDispatcher() - Constructor for class org.flag4j.operations.RealDenseMatrixMultiplyDispatcher
Creates an instance containing a map of all viable real dense matrix multiply algorithms.
RealDenseMatrixMultiplyDispatcher.AlgorithmNames - Enum Class in org.flag4j.operations
Simple enum class containing all possible choices of real dense matrix multiply algorithms.
RealDenseMatrixMultTranspose - Class in org.flag4j.operations.dense.real
This class contains several low level methods for computing matrix-matrix multiplications with a transpose for two real dense matrices.
RealDenseMatrixMultTranspose() - Constructor for class org.flag4j.operations.dense.real.RealDenseMatrixMultTranspose
 
RealDenseOperations - Class in org.flag4j.operations.dense.real
This class provides low level methods for computing operations on real dense tensors.
RealDenseOperations() - Constructor for class org.flag4j.operations.dense.real.RealDenseOperations
 
RealDenseProperties - Class in org.flag4j.operations.dense.real
This class contains low-level implementations for operations which check if a tensor satisfies some property.
RealDenseProperties() - Constructor for class org.flag4j.operations.dense.real.RealDenseProperties
 
RealDenseSetOperations - Class in org.flag4j.operations.dense.real
This class contains low-level implementations of setting operations for real dense tensors.
RealDenseSetOperations() - Constructor for class org.flag4j.operations.dense.real.RealDenseSetOperations
 
RealDenseSparseEquals - Class in org.flag4j.operations.dense_sparse.coo.real
This class contains methods for checking the equality of a real dense and real sparse tensors.
RealDenseSparseEquals() - Constructor for class org.flag4j.operations.dense_sparse.coo.real.RealDenseSparseEquals
 
RealDenseSparseMatrixMultiplication - Class in org.flag4j.operations.dense_sparse.coo.real
This class contains low level methods for computing the matrix multiplication (and matrix vector multiplication) between a real dense/sparse matrix and a real sparse/dense matrix or vector.
RealDenseSparseMatrixMultiplication() - Constructor for class org.flag4j.operations.dense_sparse.coo.real.RealDenseSparseMatrixMultiplication
 
RealDenseSparseMatrixMultTranspose - Class in org.flag4j.operations.dense_sparse.coo.real
This class contains several low level methods for computing matrix-matrix multiplications with a transpose for a real dense matrix and a real sparse matrix.
RealDenseSparseMatrixMultTranspose() - Constructor for class org.flag4j.operations.dense_sparse.coo.real.RealDenseSparseMatrixMultTranspose
 
RealDenseSparseMatrixOperations - Class in org.flag4j.operations.dense_sparse.coo.real
This class contains low-level operations between a real dense and real sparse matrix.
RealDenseSparseMatrixOperations() - Constructor for class org.flag4j.operations.dense_sparse.coo.real.RealDenseSparseMatrixOperations
 
RealDenseSparseTensorOperations - Class in org.flag4j.operations.dense_sparse.coo.real
This class contains methods to apply common binary operations to a real dense matrix and to a real sparse matrix.
RealDenseSparseTensorOperations() - Constructor for class org.flag4j.operations.dense_sparse.coo.real.RealDenseSparseTensorOperations
 
RealDenseSparseVectorOperations - Class in org.flag4j.operations.dense_sparse.coo.real
This class provides low level methods for computing operations between a real dense/sparse vector and a real sparse/dense vector.
RealDenseSparseVectorOperations() - Constructor for class org.flag4j.operations.dense_sparse.coo.real.RealDenseSparseVectorOperations
 
RealDenseTensorBase<T,W> - Class in org.flag4j.core.dense_base
The base class for all real dense tensors.
RealDenseTensorBase(Shape, double[]) - Constructor for class org.flag4j.core.dense_base.RealDenseTensorBase
Creates a real dense tensor with specified entries and shape.
RealDenseTensorBinaryOperation - Interface in org.flag4j.operations
Functional interface for creating a lambda which implements an operation acting on two real dense tensors.
RealDenseTensorDot - Class in org.flag4j.operations.dense.real
This class contains methods for computing a tensor dot product, i.e.
RealDenseTensorDot() - Constructor for class org.flag4j.operations.dense.real.RealDenseTensorDot
 
RealDenseTranspose - Class in org.flag4j.operations.dense.real
This class contains several low-level algorithms for computing the transpose of real dense tensors.
RealDenseTranspose() - Constructor for class org.flag4j.operations.dense.real.RealDenseTranspose
 
RealDenseVectorOperations - Class in org.flag4j.operations.dense.real
This class provides low level implementations for several vector operation.
RealDenseVectorOperations() - Constructor for class org.flag4j.operations.dense.real.RealDenseVectorOperations
 
RealExactSolver - 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.
RealExactSolver() - Constructor for class org.flag4j.linalg.solvers.exact.RealExactSolver
Constructs an exact LU solver where the coefficient matrix is real dense.
RealExactTensorSolver - Class in org.flag4j.linalg.solvers.exact
Solver for solving a real well determined linear tensor equation A*X=B in an exact sense.
RealExactTensorSolver() - Constructor for class org.flag4j.linalg.solvers.exact.RealExactTensorSolver
Creates an exact tensor solver for solving a well determined linear tensor equation A*X=B for X in an exact sense.
RealForwardSolver - Class in org.flag4j.linalg.solvers.exact.triangular
This solver solves linear systems of equations where the coefficient matrix in a lower triangular real dense matrix and the constant vector is a real dense vector.
RealForwardSolver() - Constructor for class org.flag4j.linalg.solvers.exact.triangular.RealForwardSolver
Creates a solver to solve a linear system where the coefficient matrix is lower triangular.
RealForwardSolver(boolean) - Constructor for class org.flag4j.linalg.solvers.exact.triangular.RealForwardSolver
Creates a solver to solve a linear system where the coefficient matrix is lower triangular or unit lower triangular.
RealForwardSolver(boolean, boolean) - Constructor for class org.flag4j.linalg.solvers.exact.triangular.RealForwardSolver
Creates a solver to solve a linear system where the coefficient matrix is lower triangular or unit lower triangular.
RealHess - Class in org.flag4j.linalg.decompositions.hess
Computes the Hessenburg decomposition of a real dense square matrix.
RealHess() - Constructor for class org.flag4j.linalg.decompositions.hess.RealHess
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.
RealHess(boolean) - Constructor for class org.flag4j.linalg.decompositions.hess.RealHess
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.
RealLstsqSolver - Class in org.flag4j.linalg.solvers.lstsq
This class solves a linear system of equations Ax=b in a least-squares sense.
RealLstsqSolver() - Constructor for class org.flag4j.linalg.solvers.lstsq.RealLstsqSolver
Constructs a least-squares solver to solve a system Ax=b in a least square sense.
RealLU - Class in org.flag4j.linalg.decompositions.lu
This class provides methods for computing the LU decomposition of a real dense matrix.
RealLU() - Constructor for class org.flag4j.linalg.decompositions.lu.RealLU
Constructs a LU decomposer to decompose the specified matrix using partial pivoting.
RealLU(int) - Constructor for class org.flag4j.linalg.decompositions.lu.RealLU
Constructs a LU decomposer to decompose the specified matrix.
RealLU(int, double) - Constructor for class org.flag4j.linalg.decompositions.lu.RealLU
Constructs a LU decomposer to decompose the specified matrix.
RealMatrixMixin<T,W> - Interface in org.flag4j.core
This interface specifies methods which all real matrices should implement.
RealOperations - Class in org.flag4j.operations.common.real
This class provides low level methods for computing operations on real tensors.
RealOperations() - Constructor for class org.flag4j.operations.common.real.RealOperations
 
RealProperties - Class in org.flag4j.operations.common.real
This class provides low level methods for checking tensor properties.
RealProperties() - Constructor for class org.flag4j.operations.common.real.RealProperties
 
RealQR - Class in org.flag4j.linalg.decompositions.qr
Instances of this class compute the QR decomposition of a real dense matrix.
RealQR() - Constructor for class org.flag4j.linalg.decompositions.qr.RealQR
Creates a QR decomposer.
RealQR(boolean) - Constructor for class org.flag4j.linalg.decompositions.qr.RealQR
Creates a QR decomposer to compute either the full or reduced QR decomposition.
RealSchur - Class in org.flag4j.linalg.decompositions.schur
This class computes the Schur decomposition of a real dense square matrix.
RealSchur() - Constructor for class org.flag4j.linalg.decompositions.schur.RealSchur
Creates a decomposer to compute the Schur decomposition for a real dense matrix.
RealSchur(boolean) - Constructor for class org.flag4j.linalg.decompositions.schur.RealSchur
Creates a decomposer to compute the Schur decomposition for a real dense matrix where the U matrix may or may not be computed.
RealSchur(boolean, long) - Constructor for class org.flag4j.linalg.decompositions.schur.RealSchur
Creates a decomposer to compute the Schur decomposition for a real dense matrix.
RealSchur(long) - Constructor for class org.flag4j.linalg.decompositions.schur.RealSchur
Creates a decomposer to compute the Schur decomposition for a real dense matrix.
RealSparseEquals - Class in org.flag4j.operations.sparse.coo.real
This class contains methods for checking the equality of real sparse tensors.
RealSparseEquals() - Constructor for class org.flag4j.operations.sparse.coo.real.RealSparseEquals
 
realSparseLookUp - Static variable in class org.flag4j.operations.common.TensorEquals
 
RealSparseManipulations - Class in org.flag4j.operations.sparse.coo.real
This utility class provides methods for inserting/removing values in a real sparse vector.
RealSparseManipulations() - Constructor for class org.flag4j.operations.sparse.coo.real.RealSparseManipulations
 
RealSparseMatrixGetSet - Class in org.flag4j.operations.sparse.coo.real
This class provides methods for getting and setting elements and slices from/to a real sparse matrix.
RealSparseMatrixGetSet() - Constructor for class org.flag4j.operations.sparse.coo.real.RealSparseMatrixGetSet
 
RealSparseMatrixManipulations - Class in org.flag4j.operations.sparse.coo.real
This class contains implementations for real sparse matrix manipulations.
RealSparseMatrixManipulations() - Constructor for class org.flag4j.operations.sparse.coo.real.RealSparseMatrixManipulations
 
RealSparseMatrixMultiplication - Class in org.flag4j.operations.sparse.coo.real
This class contains low level implementations of matrix multiplication for real sparse matrices.
RealSparseMatrixMultiplication() - Constructor for class org.flag4j.operations.sparse.coo.real.RealSparseMatrixMultiplication
 
RealSparseMatrixOperations - Class in org.flag4j.operations.sparse.coo.real
This class has low level implementations for operations between two real sparse matrices.
RealSparseMatrixOperations() - Constructor for class org.flag4j.operations.sparse.coo.real.RealSparseMatrixOperations
 
RealSparseMatrixProperties - Class in org.flag4j.operations.sparse.coo.real
This class contains low level implementations for methods to evaluate certain properties of a real sparse matrix.
RealSparseMatrixProperties() - Constructor for class org.flag4j.operations.sparse.coo.real.RealSparseMatrixProperties
 
RealSparseNorms - Class in org.flag4j.operations.sparse.coo.real
This class contains low level implementations of norms for tensors, matrices and vector.
RealSparseNorms() - Constructor for class org.flag4j.operations.sparse.coo.real.RealSparseNorms
 
RealSparseTensorBase<T,U,W,Z> - Class in org.flag4j.core.sparse_base
Base class for all sparse tensor.
RealSparseTensorBase(Shape, int, double[], int[][]) - Constructor for class org.flag4j.core.sparse_base.RealSparseTensorBase
Creates a sparse tensor with specified shape.
RealSparseTensorBase(Shape, int, double[], int[], int[]...) - Constructor for class org.flag4j.core.sparse_base.RealSparseTensorBase
Creates a sparse tensor with specified shape.
RealSparseVectorOperations - Class in org.flag4j.operations.sparse.coo.real
This class contains low level implementations of operations on two real sparse tensors.
RealSparseVectorOperations() - Constructor for class org.flag4j.operations.sparse.coo.real.RealSparseVectorOperations
 
RealSVD - 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.
RealSVD() - Constructor for class org.flag4j.linalg.decompositions.svd.RealSVD
Creates a decomposer to compute the singular value decomposition of a real matrix.
RealSVD(boolean) - Constructor for class org.flag4j.linalg.decompositions.svd.RealSVD
Creates a decomposer to compute the singular value decomposition of a real matrix.
RealSVD(boolean, boolean) - Constructor for class org.flag4j.linalg.decompositions.svd.RealSVD
Creates a decomposer to compute the singular value decomposition of a real matrix.
RealTensorMixin<T,W> - Interface in org.flag4j.core
This interface specifies methods which all real tensors should implement.
RealUnitaryDecomposition - Class in org.flag4j.linalg.decompositions.unitary
This class is the base class for real matrix decompositions which proceed by using unitary/orthogonal transformations (specifically Householder reflectors) to bring a matrix into an upper triangular/Hessenburg matrix.
RealUnitaryDecomposition(int) - Constructor for class org.flag4j.linalg.decompositions.unitary.RealUnitaryDecomposition
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.
RealUnitaryDecomposition(int, boolean) - Constructor for class org.flag4j.linalg.decompositions.unitary.RealUnitaryDecomposition
Creates a real unitary decomposer which will reduce the matrix to an upper triangular/Hessenburg matrix which has zeros below the specified sub-diagonal (must be 0 or 1).
recip() - Method in class org.flag4j.arrays.sparse.CooCVector
Computes the reciprocals, element-wise, of this sparse vector.
recip() - Method in class org.flag4j.core.dense_base.ComplexDenseTensorBase
Computes the reciprocals, element-wise, of a tensor.
recip() - Method in class org.flag4j.core.dense_base.RealDenseTensorBase
Computes the reciprocals, element-wise, of a tensor.
recip() - Method in class org.flag4j.core.sparse_base.ComplexSparseTensorBase
 
recip() - Method in class org.flag4j.core.sparse_base.RealSparseTensorBase
 
recip() - Method in interface org.flag4j.core.TensorOperationsMixin
Computes the reciprocals, element-wise, of a tensor.
recip(double[]) - Static method in class org.flag4j.operations.dense.real.RealDenseOperations
Computes the reciprocals, element-wise, of a tensor.
recip(CNumber[]) - Static method in class org.flag4j.operations.dense.complex.ComplexDenseOperations
Computes the reciprocals, element-wise, of a tensor.
reduced - Variable in class org.flag4j.linalg.decompositions.qr.ComplexQR
Flag indicating if the reduced (true) or full (false) QR decomposition should be computed.
reduced - Variable in class org.flag4j.linalg.decompositions.qr.RealQR
Flag indicating if the reduced (true) or full (false) QR decomposition should be computed.
reduced - Variable in class org.flag4j.linalg.decompositions.svd.SVD
Flag which indicates if the reduced (or full) SVD should be computed.
ref(CMatrix) - Static method in class org.flag4j.linalg.RowEchelon
Computes a row echelon form of a Matrix.
ref(Matrix) - Static method in class org.flag4j.linalg.RowEchelon
Computes a row echelon form of a Matrix.
removeCloseToZero(CsrCMatrix, List<CNumber>, int[], List<Integer>, double) - Static method in class org.flag4j.operations.sparse.csr.complex.ComplexCsrEquals
Removes entries in src which are within atol in absolute value from zero.
removeCloseToZero(CsrMatrix, List<Double>, int[], List<Integer>, double) - Static method in class org.flag4j.operations.sparse.csr.real.RealCsrEquals
Removes entries in src which are within atol in absolute value from zero.
removeCol(int) - Method in class org.flag4j.arrays.dense.CMatrix
Removes a specified column from this matrix.
removeCol(int) - Method in class org.flag4j.arrays.dense.Matrix
Removes a specified column from this matrix.
removeCol(int) - Method in class org.flag4j.arrays.sparse.CooCMatrix
Removes a specified column from this matrix.
removeCol(int) - Method in class org.flag4j.arrays.sparse.CooMatrix
Removes a specified column from this matrix.
removeCol(int) - Method in class org.flag4j.arrays.sparse.CsrCMatrix
Removes a specified column from this matrix.
removeCol(int) - Method in class org.flag4j.arrays.sparse.CsrMatrix
Removes a specified column from this matrix.
removeCol(int) - Method in interface org.flag4j.core.MatrixManipulationsMixin
Removes a specified column from this matrix.
removeCol(CooCMatrix, int) - Static method in class org.flag4j.operations.sparse.coo.complex.ComplexSparseMatrixManipulations
Removes a specified column from a sparse matrix.
removeCol(CooMatrix, int) - Static method in class org.flag4j.operations.sparse.coo.real.RealSparseMatrixManipulations
Removes a specified column from a sparse matrix.
removeCols(int...) - Method in class org.flag4j.arrays.dense.CMatrix
Removes a specified set of columns from this matrix.
removeCols(int...) - Method in class org.flag4j.arrays.dense.Matrix
Removes a specified set of columns from this matrix.
removeCols(int...) - Method in class org.flag4j.arrays.sparse.CooCMatrix
Removes a specified set of columns from this matrix.
removeCols(int...) - Method in class org.flag4j.arrays.sparse.CooMatrix
Removes a specified set of columns from this matrix.
removeCols(int...) - Method in class org.flag4j.arrays.sparse.CsrCMatrix
Removes a specified set of columns from this matrix.
removeCols(int...) - Method in class org.flag4j.arrays.sparse.CsrMatrix
Removes a specified set of columns from this matrix.
removeCols(int...) - Method in interface org.flag4j.core.MatrixManipulationsMixin
Removes a specified set of columns from this matrix.
removeCols(CooCMatrix, int...) - Static method in class org.flag4j.operations.sparse.coo.complex.ComplexSparseMatrixManipulations
Removes a list of specified columns from a sparse matrix.
removeCols(CooMatrix, int...) - Static method in class org.flag4j.operations.sparse.coo.real.RealSparseMatrixManipulations
Removes a list of specified columns from a sparse matrix.
removeRow(int) - Method in class org.flag4j.arrays.dense.CMatrix
Removes a specified row from this matrix.
removeRow(int) - Method in class org.flag4j.arrays.dense.Matrix
Removes a specified row from this matrix.
removeRow(int) - Method in class org.flag4j.arrays.sparse.CooCMatrix
Removes a specified row from this matrix.
removeRow(int) - Method in class org.flag4j.arrays.sparse.CooMatrix
Removes a specified row from this matrix.
removeRow(int) - Method in class org.flag4j.arrays.sparse.CsrCMatrix
Removes a specified row from this matrix.
removeRow(int) - Method in class org.flag4j.arrays.sparse.CsrMatrix
Removes a specified row from this matrix.
removeRow(int) - Method in interface org.flag4j.core.MatrixManipulationsMixin
Removes a specified row from this matrix.
removeRow(CooCMatrix, int) - Static method in class org.flag4j.operations.sparse.coo.complex.ComplexSparseMatrixManipulations
Removes a specified row from a sparse matrix.
removeRow(CooMatrix, int) - Static method in class org.flag4j.operations.sparse.coo.real.RealSparseMatrixManipulations
Removes a specified row from a sparse matrix.
removeRows(int...) - Method in class org.flag4j.arrays.dense.CMatrix
Removes a specified set of rows from this matrix.
removeRows(int...) - Method in class org.flag4j.arrays.dense.Matrix
Removes a specified set of rows from this matrix.
removeRows(int...) - Method in class org.flag4j.arrays.sparse.CooCMatrix
Removes a specified set of rows from this matrix.
removeRows(int...) - Method in class org.flag4j.arrays.sparse.CooMatrix
Removes a specified set of rows from this matrix.
removeRows(int...) - Method in class org.flag4j.arrays.sparse.CsrCMatrix
Removes a specified set of rows from this matrix.
removeRows(int...) - Method in class org.flag4j.arrays.sparse.CsrMatrix
Removes a specified set of rows from this matrix.
removeRows(int...) - Method in interface org.flag4j.core.MatrixManipulationsMixin
Removes a specified set of rows from this matrix.
removeRows(CooCMatrix, int...) - Static method in class org.flag4j.operations.sparse.coo.complex.ComplexSparseMatrixManipulations
Removes multiple rows from a real sparse matrix.
removeRows(CooMatrix, int...) - Static method in class org.flag4j.operations.sparse.coo.real.RealSparseMatrixManipulations
Removes multiple rows from a real sparse matrix.
reordered(double[], Shape, double[], Shape) - Static method in class org.flag4j.operations.dense.real.RealDenseMatrixMultiplication
Computes the matrix multiplication between two real dense matrices using the standard algorithm with j-k loops swapped.
reordered(double[], Shape, CNumber[], Shape) - Static method in class org.flag4j.operations.dense.real_complex.RealComplexDenseMatrixMultiplication
Computes the matrix multiplication between a real dense matrix with a complex dense matrix using the standard algorithm with j-k loops swapped.
reordered(CNumber[], Shape, double[], Shape) - Static method in class org.flag4j.operations.dense.real_complex.RealComplexDenseMatrixMultiplication
Computes the matrix multiplication between a real dense matrix with a complex dense matrix using the standard algorithm with j-k loops swapped.
reordered(CNumber[], Shape, CNumber[], Shape) - Static method in class org.flag4j.operations.dense.complex.ComplexDenseMatrixMultiplication
Computes the matrix multiplication between two real dense matrices using the standard algorithm with j-k loops swapped.
REORDERED - Enum constant in enum class org.flag4j.operations.MatrixMultiplyDispatcher.AlgorithmName
 
REORDERED - Enum constant in enum class org.flag4j.operations.RealDenseMatrixMultiplyDispatcher.AlgorithmNames
 
repeat(int, int) - Method in class org.flag4j.arrays.dense.CVector
Repeats a vector n times along a certain axis to create a matrix.
repeat(int, int) - Method in class org.flag4j.arrays.dense.Vector
Repeats a vector n times along a certain axis to create a matrix.
repeat(int, int) - Method in class org.flag4j.arrays.sparse.CooCVector
Repeats a vector n times along a certain axis to create a matrix.
repeat(int, int) - Method in class org.flag4j.arrays.sparse.CooVector
Repeats a vector n times along a certain axis to create a matrix.
repeat(int, int) - Method in interface org.flag4j.core.VectorMixin
Repeats a vector n times along a certain axis to create a matrix.
repeat(int, int[]) - Static method in class org.flag4j.util.ArrayUtils
Repeats an array a specified number of times.
resetAll() - Static method in class org.flag4j.concurrency.Configurations
Resets all configurations to their default values.
resetAll() - Static method in class org.flag4j.io.PrintOptions
Resets all print options to their default values.
reshape(int...) - Method in class org.flag4j.arrays.sparse.CooCVector
Copies and reshapes tensor if possible.
reshape(int...) - Method in class org.flag4j.core.dense_base.ComplexDenseTensorBase
Copies and reshapes tensor if possible.
reshape(int...) - Method in class org.flag4j.core.dense_base.RealDenseTensorBase
Copies and reshapes tensor if possible.
reshape(int...) - Method in class org.flag4j.core.sparse_base.ComplexSparseTensorBase
Copies and reshapes tensor if possible.
reshape(int...) - Method in class org.flag4j.core.sparse_base.RealSparseTensorBase
 
reshape(int...) - Method in interface org.flag4j.core.TensorManipulationsMixin
Copies and reshapes tensor if possible.
reshape(Shape) - Method in class org.flag4j.arrays.dense.CVector
Since vectors are rank 1 tensors, this method simply copies the vector.
reshape(Shape) - Method in class org.flag4j.arrays.sparse.CooCMatrix
Copies and reshapes matrix if possible.
reshape(Shape) - Method in class org.flag4j.arrays.sparse.CooCTensor
Copies and reshapes tensor if possible.
reshape(Shape) - Method in class org.flag4j.arrays.sparse.CooCVector
Copies and reshapes tensor if possible.
reshape(Shape) - Method in class org.flag4j.arrays.sparse.CooMatrix
Copies and reshapes matrix if possible.
reshape(Shape) - Method in class org.flag4j.arrays.sparse.CooTensor
Copies and reshapes tensor if possible.
reshape(Shape) - Method in class org.flag4j.arrays.sparse.CooVector
Copies and reshapes tensor if possible.
reshape(Shape) - Method in class org.flag4j.arrays.sparse.CsrCMatrix
Copies and reshapes matrix if possible.
reshape(Shape) - Method in class org.flag4j.arrays.sparse.CsrMatrix
Copies and reshapes matrix if possible.
reshape(Shape) - Method in class org.flag4j.core.dense_base.ComplexDenseTensorBase
Copies and reshapes tensor if possible.
reshape(Shape) - Method in class org.flag4j.core.dense_base.RealDenseTensorBase
Copies and reshapes tensor if possible.
reshape(Shape) - Method in interface org.flag4j.core.TensorManipulationsMixin
Copies and reshapes tensor if possible.
rightMult(CMatrix) - Method in class org.flag4j.arrays.sparse.PermutationMatrix
Right multiplies this permutation matrix to the specified matrix.
rightMult(CVector) - Method in class org.flag4j.arrays.sparse.PermutationMatrix
Right multiplies this permutation matrix to the specified vector.
rightMult(Matrix) - Method in class org.flag4j.arrays.sparse.PermutationMatrix
Right multiplies this permutation matrix to the specified matrix.
rightMult(Vector) - Method in class org.flag4j.arrays.sparse.PermutationMatrix
Right multiplies this permutation matrix to the specified vector.
rightMult2x2Rotator(CMatrix, CMatrix, int, CNumber[]) - Static method in class org.flag4j.linalg.transformations.Givens
Right multiplies a 2x2 Givens rotator to a matrix at the specified row.
rightMult2x2Rotator(Matrix, Matrix, int, double[]) - Static method in class org.flag4j.linalg.transformations.Givens
Right multiplies a 2x2 Givens rotator to a matrix at the specified row.
rightMultReflector(CMatrix, CVector, CNumber, int, int, int) - Static method in class org.flag4j.linalg.transformations.Householder
Right multiplies a Householder matrix H=I-invalid input: '&alpha'vvH, represented by the vector v, to another matrix A.
rightMultReflector(CMatrix, CNumber[], CNumber, int, int, int) - Static method in class org.flag4j.linalg.transformations.Householder
Right multiplies a Householder matrix H=I-invalid input: '&alpha'vvH, represented by the vector v, to another matrix A.
rightMultReflector(Matrix, double[], double, int, int, int) - Static method in class org.flag4j.linalg.transformations.Householder
Right multiplies a Householder matrix H=I-invalid input: '&alpha'vvT, represented by the vector v, to another matrix A.
rightMultReflector(Matrix, Vector, double, int, int, int) - Static method in class org.flag4j.linalg.transformations.Householder
Right multiplies a Householder matrix H=I-invalid input: '&alpha'vvT, represented by the vector v, to another matrix A.
rng - Variable in class org.flag4j.linalg.decompositions.schur.Schur
Random number generator to be used when computing a random exceptional shift.
rng - Variable in class org.flag4j.rng.RandomArray
Random number generator to use when creating random arrays.
ROOT_THREE - Static variable in class org.flag4j.complex_numbers.CNumber
The double value closer than any other to the square root of 3
ROOT_TWO - Static variable in class org.flag4j.complex_numbers.CNumber
The double value closer than any other to the square root of 2
round() - Method in class org.flag4j.arrays.dense.CMatrix
Rounds this matrix to the nearest whole number.
round() - Method in class org.flag4j.core.dense_base.ComplexDenseTensorBase
 
round() - Method in class org.flag4j.core.dense_base.RealDenseTensorBase
 
round() - Method in class org.flag4j.core.sparse_base.ComplexSparseTensorBase
 
round() - Method in class org.flag4j.core.sparse_base.RealSparseTensorBase
 
round() - Method in interface org.flag4j.core.TensorManipulationsMixin
Rounds each entry of this tensor to the nearest whole number.
round(double[]) - Static method in class org.flag4j.operations.common.real.RealOperations
Rounds the values of a tensor to the nearest integer.
round(double[], int) - Static method in class org.flag4j.operations.common.real.RealOperations
Rounds the values of a tensor with specified precision.
round(int) - Method in class org.flag4j.arrays.dense.CMatrix
Rounds a matrix to the nearest whole number.
round(int) - Method in class org.flag4j.core.dense_base.ComplexDenseTensorBase
 
round(int) - Method in class org.flag4j.core.dense_base.RealDenseTensorBase
 
round(int) - Method in class org.flag4j.core.sparse_base.ComplexSparseTensorBase
 
round(int) - Method in class org.flag4j.core.sparse_base.RealSparseTensorBase
 
round(int) - Method in interface org.flag4j.core.TensorManipulationsMixin
Rounds each entry in this tensor to the nearest whole number.
round(CNumber) - Static method in class org.flag4j.complex_numbers.CNumber
Rounds both components of a complex number to the nearest respective integer.
round(CNumber[]) - Static method in class org.flag4j.operations.common.complex.ComplexOperations
Rounds the values of a tensor to the nearest integer.
round(CNumber[], int) - Static method in class org.flag4j.operations.common.complex.ComplexOperations
Rounds the values of a tensor with specified precision.
round(CNumber, int) - Static method in class org.flag4j.complex_numbers.CNumber
Rounds number to specified number of decimal places.
roundToZero() - Method in class org.flag4j.arrays.dense.CMatrix
Rounds values which are close to zero in absolute value to zero.
roundToZero() - Method in class org.flag4j.core.dense_base.ComplexDenseTensorBase
 
roundToZero() - Method in class org.flag4j.core.dense_base.RealDenseTensorBase
 
roundToZero() - Method in class org.flag4j.core.sparse_base.ComplexSparseTensorBase
 
roundToZero() - Method in class org.flag4j.core.sparse_base.RealSparseTensorBase
 
roundToZero() - Method in interface org.flag4j.core.TensorManipulationsMixin
Rounds values in this tensor which are close to zero in absolute value to zero.
roundToZero(double) - Method in class org.flag4j.arrays.dense.CMatrix
Rounds values which are close to zero in absolute value to zero.
roundToZero(double) - Method in class org.flag4j.core.dense_base.ComplexDenseTensorBase
 
roundToZero(double) - Method in class org.flag4j.core.dense_base.RealDenseTensorBase
 
roundToZero(double) - Method in class org.flag4j.core.sparse_base.ComplexSparseTensorBase
 
roundToZero(double) - Method in class org.flag4j.core.sparse_base.RealSparseTensorBase
 
roundToZero(double) - Method in interface org.flag4j.core.TensorManipulationsMixin
Rounds values which are close to zero in absolute value to zero.
roundToZero(double[], double) - Static method in class org.flag4j.operations.common.real.RealOperations
Rounds values which are close to zero in absolute value to zero.
roundToZero(CNumber[], double) - Static method in class org.flag4j.operations.common.complex.ComplexOperations
Rounds values which are close to zero in absolute value to zero.
roundToZero(CNumber, double) - Static method in class org.flag4j.complex_numbers.CNumber
Rounds a complex numbers to zero if its magnitude within the specified tolerance from zero.
row() - Static method in enum class org.flag4j.util.Axis2D
Get the ordinal of the row axis in 2D.
ROW - Enum constant in enum class org.flag4j.util.Axis2D
Row of 2D tensor.
RowEchelon - Class in org.flag4j.linalg
This class contains several methods for computing row echelon, reduced row echelon, and extended reduced row echelon forms of a matrix.
RowEchelon() - Constructor for class org.flag4j.linalg.RowEchelon
 
rowIndices - Variable in class org.flag4j.arrays.sparse.CooCMatrix
Row indices of the non-zero entries of the sparse matrix.
rowIndices - Variable in class org.flag4j.arrays.sparse.CooMatrix
Row indices of the non-zero entries of the sparse matrix.
rowPermute - Variable in class org.flag4j.linalg.solvers.exact.ExactSolver
Row permutation matrix for LU decomposition.
rowPointers - Variable in class org.flag4j.arrays.sparse.CsrCMatrix
Row indices of the non-zero entries of the sparse matrix.
rowPointers - Variable in class org.flag4j.arrays.sparse.CsrMatrix
Row indices of the non-zero entries of the sparse matrix.
rowSwaps - Variable in class org.flag4j.linalg.decompositions.lu.LU
 
rowToString(int, int, List<Integer>) - Method in class org.flag4j.arrays.dense.CMatrix
Gets row of matrix formatted as a human-readable String.
rowToString(int, int, List<Integer>) - Method in class org.flag4j.arrays.dense.Matrix
Gets row of matrix formatted as a human-readable String.
rref(CMatrix) - Static method in class org.flag4j.linalg.RowEchelon
Computes the reduced row echelon form of a matrix.
rref(Matrix) - Static method in class org.flag4j.linalg.RowEchelon
Computes the reduced row echelon form of a matrix.
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