Uses of Class
org.flag4j.arrays.dense.CVector
Packages that use CVector
Package
Description
Provides implementations for dense tensors, matrices, and vectors.
Contains implementations for sparse tensors, matrices, and vectors.
General purpose linear algebra operations including condition number evaluations, eigenvalue/eigenvector computations, matrix
inversion, and subspace analysis.
General linear algebra operations.
Implementations of operations between real and complex sparse COO (coordinate) array objects.
Contains solvers which solve well determined linear tensor and matrix equations in an exact sense.
Contains solvers which solve well determined triangular linear matrix equations in an exact sense.
Solvers for under-, well-, or over-determined linear systems in a least-squares sense.
Utility classes for computing and applying matrix and vector transformations.
Pseudo-random generation of real/complex numbers, and arrays, vectors, matrices, and tensors.
-
Uses of CVector in org.flag4j.arrays.dense
Subclasses with type arguments of type CVector in org.flag4j.arrays.denseModifier and TypeClassDescriptionclassInstances of this class represents a complex dense matrix backed by aComplex128array.classMethods in org.flag4j.arrays.dense that return CVectorModifier and TypeMethodDescriptionComputes the element-wise sum between two tensors of the same shape.CVector.add(CooCVector b) Computes the element-wise sum between two tensors of the same shape.Computes the element-wise sum between two tensors of the same shape.Adds a complex dense vector to this vector.Vector.add(CooCVector b) Adds a complex sparse vector to this vector.Vector.add(Complex128 b) Adds a complex-valued scalar value to each entry of this tensor.Computes the vector cross product between two vectors.Computes the element-wise quotient between two tensors.Computes the element-wise quotient of this vector and a complex dense vector.Vector.div(Complex128 b) Divides this vector by a complex-valued scalar.Computes the element-wise multiplication of two tensors of the same shape.Computes the element-wise product of this vector and a complex dense vector.static CVectorCVector.getEmpty(int size) Constructs an empty vector with the specified size.CVector.makeLikeTensor(Shape shape, Complex128[] entries) Constructs a tensor of the same type as this tensor with the given theshapeanddata.CVector.makeLikeTensor(Complex128[] entries) Constructs a dense vector with the specifieddataof the same type as the vector.protected CVectorCMatrix.makeLikeVector(Shape shape, Complex128[] entries) Constructs a vector of a similar type as this matrix.protected CVectorCMatrix.makeLikeVector(Complex128[] entries) Constructs a vector of a similar type as this matrix.Computes the matrix-vector multiplication between this matrix and a vector.CMatrix.mult(CooCVector b) Computes the matrix-vector multiplication between this matrix and a vector.Computes the matrix-vector multiplication between this matrix and a vector.Computes the matrix-vector product of this matrix and a dense complex vector.Matrix.mult(CooCVector b) Computes the matrix-vector product of this matrix and a complex sparse vector.Vector.mult(Complex128 b) Multiplies this vector by a complex-valued scalar.CVector.normalize()Normalizes this vector to a unit length vector.CVector.round(int precision) Rounds all data within this vector to the specified precision.CVector.roundToZero(double tolerance) Sets all elements of this vector to zero if they are withintolof zero.Computes the element-wise difference between two tensors of the same shape.CVector.sub(CooCVector b) Computes the element-wise difference between two tensors of the same shape.Computes the element-wise difference between two tensors of the same shape.Subtracts a complex dense vector from this vector.Vector.sub(CooCVector b) Subtracts a complex sparse vector from this vector.Vector.sub(Complex128 b) Subtracts a complex-valued scalar from each entry of this vector.Vector.toComplex()Converts this real dense vector to an equivalent complex dense vector.CTensor.toVector()Converts this tensor to an equivalent vector.Methods in org.flag4j.arrays.dense with parameters of type CVectorModifier and TypeMethodDescriptionAdds a complex dense vector to this vector.Computes the vector cross product between two vectors.static CMatrixConstructs a diagonal matrix from a vector specifying the diagonal elements of the matrix.Computes the element-wise quotient of this vector and a complex dense vector.Computes the element-wise product of this vector and a complex dense vector.Computes the matrix-vector product of this matrix and a dense complex vector.Subtracts a complex dense vector from this vector.Constructors in org.flag4j.arrays.dense with parameters of type CVector -
Uses of CVector in org.flag4j.arrays.sparse
Subclasses with type arguments of type CVector in org.flag4j.arrays.sparseModifier and TypeClassDescriptionclassA complex sparse vector stored in coordinate list (COO) format.Methods in org.flag4j.arrays.sparse that return CVectorModifier and TypeMethodDescriptionLeft multiplies this permutation matrix to the specified vector.CooCVector.makeLikeDenseTensor(Shape shape, Complex128... entries) Constructs a dense vector of a similar type as this vector with the specified shape and data.CooCMatrix.mult(CooCVector b) Computes the matrix-vector multiplication of a vector with this matrix.Computes the matrix-vector multiplication of a vector with this matrix.Computes the matrix-vector multiplication of a vector with this matrix.CsrCMatrix.mult(CooCVector b) Computes the matrix-vector multiplication of a vector with this matrix.Multiplies this sparse CSR matrix with a complex dense vector.Right multiplies this permutation matrix to the specified vector.Methods in org.flag4j.arrays.sparse with parameters of type CVectorModifier and TypeMethodDescriptionComputes the element-wise division of two vectors.Left multiplies this permutation matrix to the specified vector.Computes the matrix-vector multiplication of a vector with this matrix.Multiplies this sparse CSR matrix with a complex dense vector.Right multiplies this permutation matrix to the specified vector. -
Uses of CVector in org.flag4j.linalg
Methods in org.flag4j.linalg that return CVectorModifier and TypeMethodDescriptionstatic CVectorEigen.get2x2EigenValues(CMatrix src) Computes the eigenvalues of a 2×2 matrix explicitly.static CVectorEigen.get2x2EigenValues(Matrix src) Computes the eigenvalues of a 2×2 matrix explicitly.static CVectorEigen.getEigenValues(CMatrix src) Computes the eigenvalues of a square complex dense matrix.static CVectorEigen.getEigenValues(CMatrix src, long seed) Computes the eigenvalues of a square complex dense matrix.static CVectorEigen.getEigenValues(CMatrix src, long seed, int maxIterationFactor) Computes the eigenvalues of a square complex dense matrix.static CVectorEigen.getEigenValues(Matrix src) Computes the eigenvalues of a square real dense matrix.static CVectorEigen.getEigenValues(Matrix src, long seed) Computes the eigenvalues of a square real dense matrix.static CVectorEigen.getEigenValues(Matrix src, long seed, int maxIterationFactor) Computes the eigenvalues of a square real dense matrix. -
Uses of CVector in org.flag4j.linalg.ops
Methods in org.flag4j.linalg.ops that return CVectorModifier and TypeMethodDescriptionstatic CVectorDynamically chooses the appropriate matrix-vector multiplication algorithm based on the shapes of the matrix and vector.Methods in org.flag4j.linalg.ops with parameters of type CVectorModifier and TypeMethodDescriptionstatic Complex128[]Dynamically chooses the appropriate matrix-vector multiplication algorithm based on the shapes of the matrix and vector. -
Uses of CVector in org.flag4j.linalg.ops.dense_sparse.coo.real_complex
Methods in org.flag4j.linalg.ops.dense_sparse.coo.real_complex that return CVectorModifier and TypeMethodDescriptionstatic CVectorRealComplexDenseSparseVectorOps.add(Vector src1, CooCVector src2) Adds a real dense matrix to a complex sparse matrix.static CVectorSubtracts a real sparse vector from a complex dense vector.static CVectorRealComplexDenseSparseVectorOps.sub(Vector src1, CooCVector src2) Subtracts a complex sparse vector from a real dense vector.static CVectorRealComplexDenseSparseVectorOps.sub(CooCVector src1, Vector src2) Subtracts a complex dense vector from a complex sparse vector.Methods in org.flag4j.linalg.ops.dense_sparse.coo.real_complex with parameters of type CVectorModifier and TypeMethodDescriptionstatic CooCVectorCompute the element-wise division between a sparse vector and a dense vector.static CooCVectorComputes the element-wise multiplication of a complex dense vector with a real sparse vector.static CVectorSubtracts a real sparse vector from a complex dense vector. -
Uses of CVector in org.flag4j.linalg.ops.dispatch
Subclasses with type arguments of type CVector in org.flag4j.linalg.ops.dispatchModifier and TypeClassDescriptionclassA dispatcher that selects the most suitable matrix-vector multiplication kernel for a complex matrix/vector pair.classA dispatcher that selects the most suitable matrix-vector multiplication kernel for a complex matrix/vector pair.Methods in org.flag4j.linalg.ops.dispatch that return CVectorModifier and TypeMethodDescriptionstatic CVectorDispatches the multiplication of two matrices to an appropriate implementation based on the shapes of the two matrices.Methods in org.flag4j.linalg.ops.dispatch that return types with arguments of type CVectorModifier and TypeMethodDescriptionprotected BiFunction<CMatrix, CVector, CVector> Computes the appropriate function to use when computing the matrix multiplication between two matrices.protected BiFunction<CMatrix, CVector, CVector> Computes the appropriate function to use when computing the matrix multiplication between two matrices.Methods in org.flag4j.linalg.ops.dispatch with parameters of type CVector -
Uses of CVector in org.flag4j.linalg.ops.sparse.coo.real_complex
Methods in org.flag4j.linalg.ops.sparse.coo.real_complex that return CVectorModifier and TypeMethodDescriptionstatic CVectorRealComplexSparseVectorOps.add(CooCVector src, double a) Adds a real number to each entry of a sparse vector, including the zero data.static CVectorRealComplexSparseVectorOps.add(CooVector src, Complex128 a) Adds a real number to each entry of a sparse vector, including the zero data.static CVectorRealComplexSparseVectorOps.sub(CooVector src, Complex128 a) Subtracts a real number from each entry of a sparse vector, including the zero data. -
Uses of CVector in org.flag4j.linalg.ops.sparse.csr.real_complex
Methods in org.flag4j.linalg.ops.sparse.csr.real_complex that return CVectorModifier and TypeMethodDescriptionstatic CVectorRealComplexCsrMatMult.standardVector(CsrCMatrix src1, CooVector src2) Computes the matrix-vector multiplication between a real sparse CSR matrix and a complex sparse COO vector.static CVectorRealComplexCsrMatMult.standardVector(CsrMatrix src1, CooCVector src2) Computes the matrix-vector multiplication between a real sparse CSR matrix and a complex sparse COO vector. -
Uses of CVector in org.flag4j.linalg.solvers.exact
Subclasses with type arguments of type CVector in org.flag4j.linalg.solvers.exactModifier and TypeClassDescriptionclassSolves a well determined system of equations \( Ax = b \) or \( AX = B \) in an exact sense by using aLU decompositionwhere \( A \), \( B \), and \( X \) are matrices, and \( x \) and \( b \) are vectors.classSolver for solving a real well determined linear tensor equation \( AX = B \) in an exact sense.Methods in org.flag4j.linalg.solvers.exact that return CVectorModifier and TypeMethodDescriptionprotected CVectorComplexExactTensorSolver.initVector(CTensor B) Initializes vector for equivalent linear matrix equation.protected CVectorComplexExactSolver.permuteRows(CVector b) Permute the rows of a vector using the row permutation matrix from the LU decomposition.Methods in org.flag4j.linalg.solvers.exact with parameters of type CVectorModifier and TypeMethodDescriptionprotected CVectorComplexExactSolver.permuteRows(CVector b) Permute the rows of a vector using the row permutation matrix from the LU decomposition.protected CTensorWraps solution as a tensor and reshapes to the proper shape. -
Uses of CVector in org.flag4j.linalg.solvers.exact.triangular
Subclasses with type arguments of type CVector in org.flag4j.linalg.solvers.exact.triangularModifier and TypeClassDescriptionclassThis solver solves linear systems of the form \( Ux = b \) or \( UX = B \) where \( U \) is an upper triangular matrix.classThis solver solves a complex linear system of equations where the coefficient matrix is lower triangular.Methods in org.flag4j.linalg.solvers.exact.triangular that return CVectorModifier and TypeMethodDescriptionSolves the linear system of equations given by \( Ux = b \) where the coefficient matrix \( U \) is anupper triangularmatrix.Performs forward substitution for a unit lower triangular matrix \( L \) and a vector \( b \).Methods in org.flag4j.linalg.solvers.exact.triangular with parameters of type CVectorModifier and TypeMethodDescriptionSolves the linear system of equations given by \( Ux = b \) where the coefficient matrix \( U \) is anupper triangularmatrix.Performs forward substitution for a unit lower triangular matrix \( L \) and a vector \( b \). -
Uses of CVector in org.flag4j.linalg.solvers.lstsq
Subclasses with type arguments of type CVector in org.flag4j.linalg.solvers.lstsqModifier and TypeClassDescriptionclassInstances of this class solve complex linear systems of the form \( Ax = b \) or \( AX = B \) in a least-squares sense. -
Uses of CVector in org.flag4j.linalg.transformations
Methods in org.flag4j.linalg.transformations with parameters of type CVectorModifier and TypeMethodDescriptionstatic CMatrixGivens.get2x2Rotator(CVector v) Constructs a Givens rotator \( G \) of size 2 such that for a vector \( v = \begin{bmatrix}a & b\end{bmatrix} \) we have \( G\mathbf{v} = \begin{bmatrix}r & 0\end{bmatrix} \).static CMatrixHouseholder.getReflector(CVector normal) Computes the Householder reflector which describes a reflection through a hyperplane containing the origin which is normal to the specifiednormalvector.static CMatrixGivens.getRotator(CVector v, int i) Constructs a Givens rotator \( G \) such that for a vector \( \mathbf{v} \), \[ G\mathbf{v} = \begin{bmatrix} r_1 & \cdots & r_i & \cdots r_n \end{bmatrix} \] where \( r_{i} = 0 \).static voidHouseholder.leftMultReflector(CMatrix src, CVector householderVector, Complex128 alpha, int startCol, int startRow, int endRow) Left multiplies a Householder matrix \( H = I-\alpha vv^{H} \), represented by the vector \( v \), to another matrix \( A \).static voidHouseholder.rightMultReflector(CMatrix src, CVector householderVector, Complex128 alpha, int startCol, int startRow, int endRow) Right multiplies a Householder matrix \( H = I-\alpha vv^{H} \), represented by the vector \( v \), to another matrix \( A \). -
Uses of CVector in org.flag4j.rng
Methods in org.flag4j.rng that return CVectorModifier and TypeMethodDescriptionRandomDenseTensor.randnCVector(int size) Generates a vector filled with pseudorandom values sampled from a bivariate standard Gaussian (normal) distribution with mean zero and standard deviation one along both the real and imaginary axes.RandomDenseTensor.randnCVector(int size, double mean, double std) Generates a vector filled with pseudorandom values sampled from a bivariate Gaussian (normal) distribution with specified mean and standard deviation along both the real and imaginary axes.RandomDenseTensor.randnCVector(int size, double meanRe, double stdRe, double meanIm, double stdIm, double corrCoeff) Generates a vector filled with pseudorandom values sampled from a bivariate Gaussian (normal) distribution.RandomDenseTensor.randomCVector(int size) Generates a vector filled with pseudorandom complex values uniformly distributed in the unit disk centered at the origin of the complex plane.RandomDenseTensor.randomCVector(int size, double min, double max) Generates a vector filled with pseudorandom complex values uniformly distributed in an annulus (i.e. washer) centered at the origin of the complex plane.