Search Java Classes and Packages

Search Java Frameworks and Libraries

255581 classes and counting ...
Search Tips Index Status



#Com.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype Classes and Interfaces - 61 results found.
NameDescriptionTypePackageFramework
AutoParallelMatrixMathOperationThis class uses ParallelMatrixMathOperation when the first input matrix argument's size is greater than the defined threshold; otherwise, it uses SimpleMatrixMathOperation.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.mathoperationSuanShu
BiconjugateGradientSolverThe Biconjugate Gradient method (BiCG) is useful for solving non-symmetric n-by-n linear systems.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.nonstationarySuanShu
BiconjugateGradientStabilizedSolverThe Biconjugate Gradient Stabilized (BiCGSTAB) method is useful for solving non-symmetric n-by-n linear systems.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.nonstationarySuanShu
BidiagonalMatrixA bi-diagonal matrix is either upper or lower diagonal.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.dense.diagonalSuanShu
BidiagonalMatrix .BidiagonalMatrixTypethe available types of bi-diagonal matricesa lower bi-diagonal matrix, where there are only non-zero entries on the main and subClasscom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.dense.diagonalSuanShu
BlockWinogradAlgorithmThis implementation accelerates matrix multiplication via a combination of the Strassen algorithm and block matrix multiplication.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.mathoperation.multiplicationSuanShu
ConjugateGradientNormalErrorSolverFor an under-determined system of linear equations, Ax = b, or when the coefficient matrix A is non-symmetric and nonsingular,Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.nonstationarySuanShu
ConjugateGradientNormalResidualSolverFor an under-determined system of linear equations, Ax = b, or when the coefficient matrix A is non-symmetric and nonsingular,Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.nonstationarySuanShu
ConjugateGradientSolverThe Conjugate Gradient method (CG) is useful for solving a symmetric n-by-n linear system.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.nonstationarySuanShu
ConjugateGradientSquaredSolverThe Conjugate Gradient Squared method (CGS) is useful for solving a non-symmetric n-by-n linear system.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.nonstationarySuanShu
ConvergenceFailureThis exception is thrown by IterativeLinearSystemSolver.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterativeSuanShu
ConvergenceFailure .Reasonthe reasons for the convergence failureThrown when the iterative algorithm fails to proceed during itsClasscom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterativeSuanShu
CSRSparseMatrixThe Compressed Sparse Row (CSR) format for sparse matrix has this representation: (value, col_ind, row_ptr).Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparseSuanShu
DefaultMatrixStorageThere are multiple ways to implement the storage data structure depending on the matrix type for optimization purpose.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtypeSuanShu
DenseDataThis implementation of the storage of a dense matrix stores the data of a 2D matrix as an 1D In general, computing index for a double[] is faster than that for a double[][].Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.denseSuanShu
DenseMatrixThis class implements the standard, dense, double based matrix representation.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.denseSuanShu
DenseMatrixMultiplicationMatrix operation that multiplies two matrices.Interfacecom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.mathoperation.multiplicationSuanShu
DenseMatrixMultiplicationByBlockClasscom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.mathoperation.multiplicationSuanShu
DenseMatrixMultiplicationByBlock .BlockAlgorithmInterfacecom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.mathoperation.multiplicationSuanShu
DenseMatrixMultiplicationByIjk parallel execution with multiple threads.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.mathoperation.multiplicationSuanShu
DensifiableThis interface specifies whether a matrix implementation can be efficiently converted to the standard dense matrix representation.Interfacecom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.denseSuanShu
DiagonalMatrixA diagonal matrix has non-zero entries only on the main diagonal.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.dense.diagonalSuanShu
DOKSparseMatrixThe Dictionary Of Key (DOK) format for sparse matrix uses the coordinates of non-zero entries in the matrix as keys.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparseSuanShu
GaussSeidelSolverSimilar to the Jacobi method, the Gauss-Seidel method (GS) solves each equation in sequential order.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.stationarySuanShu
GeneralizedConjugateResidualSolverThe Generalized Conjugate Residual method (GCR) is useful for solving a non-symmetric n-by-n linear system.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.nonstationarySuanShu
GeneralizedMinimalResidualSolverThe Generalized Minimal Residual method (GMRES) is useful for solving a non-symmetric n-by-n linear system.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.nonstationarySuanShu
GivensMatrixGivens rotation is a rotation in the plane spanned by two coordinates axes.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtypeSuanShu
HilbertMatrixA Hilbert matrix, H, is a symmetric matrix with entries being the unit fractions H[i][j] = 1 / (i + j -1)Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtypeSuanShu
IdentityPreconditionerThis identity preconditioner is used when no preconditioning is applied.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.preconditionerSuanShu
IterativeLinearSystemSolverAn iterative method for solving an N-by-N (or non-square) linear system Ax = b involves a sequence of matrix-vector multiplications.Interfacecom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterativeSuanShu
IterativeLinearSystemSolver .SolutionThis is the solution to a system of linear equations using an iterativeSearch for a solution that optimizes the objective function from theInterfacecom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterativeSuanShu
JacobiPreconditionerThe Jacobi (or diagonal) preconditioner is one of the simplest forms of preconditioning, such that the preconditioner is the diagonal ofClasscom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.preconditionerSuanShu
JacobiSolverThe Jacobi method solves sequentially n equations in a linear system Ax = b in isolation in each iteration.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.stationarySuanShu
LILSparseMatrixThe list of lists (LIL) format for sparse matrix stores one list per row, where each entry stores a column index and value.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparseSuanShu
LowerTriangularMatrixA lower triangular matrix has 0 entries where column index > row index.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.dense.triangleSuanShu
MatrixCoordinateThe location of a matrix entry is specified by a 2D coordinates (i, j), where i and j are the row-index and column-index of the entry respectively.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparseSuanShu
MatrixMathOperationThis interface defines some standard operations for generic matrices.Interfacecom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.mathoperationSuanShu
MinimalResidualSolverThe Minimal Residual method (MINRES) is useful for solving a symmetric n-by-n linear system (possibly indefinite or singular).Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.nonstationarySuanShu
PermutationMatrixA permutation matrix is a square matrix that has exactly one entry '1' in each row and each column and 0's elsewhere.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtypeSuanShu
PreconditionerPreconditioning reduces the condition number of the coefficient matrix of a linear system to accelerate the convergenceInterfacecom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.preconditionerSuanShu
PreconditionerFactoryThis constructs a new instance of Preconditioner for a coefficient matrix.Interfacecom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.preconditionerSuanShu
QuasiMinimalResidualSolverThe Quasi-Minimal Residual method (QMR) is useful for solving a non-symmetric n-by-n linear system.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.nonstationarySuanShu
SimpleMatrixMathOperationThis is a generic, single-threaded implementation of matrix math operations.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.mathoperationSuanShu
SORSweepThis is a building block for to perform the forward or backward sweep.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.stationarySuanShu
SparseMatrixA sparse matrix stores only non-zero values.Interfacecom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparseSuanShu
SparseMatrix .EntryThis is a (non-zero) entry in a sparse matrix.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparseSuanShu
SparseMatrix .Entry .TopLeftFirstComparatorThis Comparator sorts the matrix coordinates first from top to bottom (rows), and then from left to right (columns).Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparseSuanShu
SparseMatrixUtilsThese are the utility functions for SparseMatrix.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparseSuanShu
SparseStructureThis interface defines common operations on sparse structures such as sparse vector or sparse matrix.Interfacecom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparseSuanShu
SparseVectorA sparse vector stores only non-zero values.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparseSuanShu
SparseVector .EntryThis is an entry in a SparseVector.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparseSuanShu
SparseVector .Entry .ComparatorThis Comparator sorts the matrix coordinates first from top to bottom (rows), and then from left to right (columns).Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparseSuanShu
SparseVector .IteratorThis wrapper class overrides the Iterator.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparseSuanShu
SSORPreconditionerSSOR preconditioner is derived from a symmetric coefficient matrix A which is decomposed asClasscom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.preconditionerSuanShu
SteepestDescentSolverThe Steepest Descent method (SDM) solves a symmetric n-by-n linear system.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.nonstationarySuanShu
SubMatrixBlockSub-matrix block representation for block algorithm.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.mathoperation.multiplicationSuanShu
SuccessiveOverrelaxationSolverThe Successive Overrelaxation method (SOR), is devised by applying extrapolation to the Gauss-Seidel method.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.stationarySuanShu
SymmetricMatrixA symmetric matrix is a square matrix such that its transpose equals to itself, i.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.dense.triangleSuanShu
SymmetricSuccessiveOverrelaxationSolverThe Symmetric Successive Overrelaxation method (SSOR) is like SOR, but it performs in eachClasscom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.sparse.solver.iterative.stationarySuanShu
TridiagonalMatrixA tri-diagonal matrix has non-zero entries only on the super, main and sub diagonals.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.dense.diagonalSuanShu
UpperTriangularMatrixAn upper triangular matrix has 0 entries where row index is greater than column index.Classcom.numericalmethod.suanshu.algebra.linear.matrix.doubles.matrixtype.dense.triangleSuanShu