A B C D E F G H I L M N O P Q R S T U V Z 

A

AbstractIterationMonitor - Class in no.uib.cipr.matrix.sparse
Partial implementation of an iteration reporter
AbstractIterationMonitor() - Constructor for class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
Constructor for AbstractIterationMonitor.
AbstractIterativeSolver - Class in no.uib.cipr.matrix.sparse
Partial implementation of an iterative solver
AbstractIterativeSolver() - Constructor for class no.uib.cipr.matrix.sparse.AbstractIterativeSolver
Constructor for AbstractIterativeSolver.
AbstractMatrix - Class in no.uib.cipr.matrix
Partial implementation of Matrix.
AbstractMatrix(int, int) - Constructor for class no.uib.cipr.matrix.AbstractMatrix
Constructor for AbstractMatrix
AbstractMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.AbstractMatrix
Constructor for AbstractMatrix, same size as A.
AbstractVector - Class in no.uib.cipr.matrix
Partial implementation of Vector.
AbstractVector(int) - Constructor for class no.uib.cipr.matrix.AbstractVector
Constructor for AbstractVector.
AbstractVector(Vector) - Constructor for class no.uib.cipr.matrix.AbstractVector
Constructor for AbstractVector, same size as x
add(int, int, double) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
add(Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
add(double, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
add(int, double) - Method in class no.uib.cipr.matrix.AbstractVector
 
add(Vector) - Method in class no.uib.cipr.matrix.AbstractVector
 
add(double, Vector) - Method in class no.uib.cipr.matrix.AbstractVector
 
add(int, double) - Method in class no.uib.cipr.matrix.DenseVector
 
add(Vector) - Method in class no.uib.cipr.matrix.DenseVector
 
add(double, Vector) - Method in class no.uib.cipr.matrix.DenseVector
 
add(int, int[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Shifts the indices.
add(int, int[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Shifts the indices.
add(int, int, double) - Method in class no.uib.cipr.matrix.LowerSymmBandMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.LowerSymmDenseMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.LowerSymmPackMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.LowerTriangDenseMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.LowerTriangPackMatrix
 
add(int, int, double) - Method in interface no.uib.cipr.matrix.Matrix
A(row,column) += value
add(Matrix) - Method in interface no.uib.cipr.matrix.Matrix
A = B + A.
add(double, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
A = alpha*B + A.
add(int, int, double) - Method in class no.uib.cipr.matrix.sparse.CompColMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.sparse.CompDiagMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.sparse.CompRowMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.sparse.FlexCompColMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.sparse.FlexCompRowMatrix
 
add(int, double) - Method in class no.uib.cipr.matrix.sparse.SparseVector
 
add(int, int, double) - Method in class no.uib.cipr.matrix.SymmTridiagMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.TridiagMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.UnitLowerTriangBandMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.UnitLowerTriangDenseMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.UnitLowerTriangPackMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.UnitUpperTriangBandMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.UnitUpperTriangDenseMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.UnitUpperTriangPackMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.UpperSymmBandMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.UpperSymmDenseMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.UpperSymmPackMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.UpperTriangDenseMatrix
 
add(int, int, double) - Method in class no.uib.cipr.matrix.UpperTriangPackMatrix
 
add(int, double) - Method in interface no.uib.cipr.matrix.Vector
x(index) += value
add(Vector) - Method in interface no.uib.cipr.matrix.Vector
x = y + x
add(double, Vector) - Method in interface no.uib.cipr.matrix.Vector
x = alpha*y + x
AMG - Class in no.uib.cipr.matrix.sparse
Algebraic multigrid preconditioner.
AMG(double, double, double, double, int, int, int, int, double) - Constructor for class no.uib.cipr.matrix.sparse.AMG
Sets up the algebraic multigrid preconditioner
AMG(double, double, int, int, int, int, double) - Constructor for class no.uib.cipr.matrix.sparse.AMG
Sets up the algebraic multigrid preconditioner.
AMG() - Constructor for class no.uib.cipr.matrix.sparse.AMG
Sets up the algebraic multigrid preconditioner using some default parameters.
apply(Matrix, int, int, int) - Method in class no.uib.cipr.matrix.GivensRotation
Applies the Givens rotation to two elements in a matrix column
apply(Vector, int, int) - Method in class no.uib.cipr.matrix.GivensRotation
Applies the Givens rotation to two elements of a vector
apply(Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.AMG
 
apply(Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.DiagonalPreconditioner
 
apply(Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.ICC
 
apply(Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.ILU
 
apply(Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.ILUT
 
apply(Vector, Vector) - Method in interface no.uib.cipr.matrix.sparse.Preconditioner
Solves the approximate problem with the given right hand side.
apply(Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.SSOR
 
ArpackSym - Class in no.uib.cipr.matrix.sparse
Uses ARPACK to partially solve symmetric eigensystems (ARPACK is designed to compute a subset of eigenvalues/eigenvectors).
ArpackSym(Matrix) - Constructor for class no.uib.cipr.matrix.sparse.ArpackSym
 
ArpackSym.Ritz - Enum in no.uib.cipr.matrix.sparse
 

B

BandCholesky - Class in no.uib.cipr.matrix
Banded Cholesky decomposition
BandCholesky(int, int, boolean) - Constructor for class no.uib.cipr.matrix.BandCholesky
Constructor for BandCholesky
BandLU - Class in no.uib.cipr.matrix
Banded LU decomposition
BandLU(int, int, int) - Constructor for class no.uib.cipr.matrix.BandLU
Constructor for BandLU
BandMatrix - Class in no.uib.cipr.matrix
Banded matrix.
BandMatrix(int, int, int) - Constructor for class no.uib.cipr.matrix.BandMatrix
Constructor for BandMatrix
BandMatrix(Matrix, int, int) - Constructor for class no.uib.cipr.matrix.BandMatrix
Constructor for BandMatrix
BandMatrix(Matrix, int, int, boolean) - Constructor for class no.uib.cipr.matrix.BandMatrix
Constructor for BandMatrix
BiCG - Class in no.uib.cipr.matrix.sparse
BiCG solver.
BiCG(Vector) - Constructor for class no.uib.cipr.matrix.sparse.BiCG
Constructor for BiCG.
BiCGstab - Class in no.uib.cipr.matrix.sparse
BiCG stablized solver.
BiCGstab(Vector) - Constructor for class no.uib.cipr.matrix.sparse.BiCGstab
Constructor for BiCGstab.

C

cardinality(Vector) - Static method in class no.uib.cipr.matrix.Matrices
Returns the number of non-zero entries in the given vector
cardinality(Matrix) - Static method in class no.uib.cipr.matrix.Matrices
Returns the number of non-zero entries in the given matrix
CG - Class in no.uib.cipr.matrix.sparse
Conjugate Gradients solver.
CG(Vector) - Constructor for class no.uib.cipr.matrix.sparse.CG
Constructor for CG.
CGS - Class in no.uib.cipr.matrix.sparse
Conjugate Gradients squared solver.
CGS(Vector) - Constructor for class no.uib.cipr.matrix.sparse.CGS
Constructor for CGS.
Chebyshev - Class in no.uib.cipr.matrix.sparse
Chebyshev solver.
Chebyshev(Vector, double, double) - Constructor for class no.uib.cipr.matrix.sparse.Chebyshev
Constructor for Chebyshev.
check(int, int) - Method in class no.uib.cipr.matrix.AbstractMatrix
Checks the passed row and column indices
check(int) - Method in class no.uib.cipr.matrix.AbstractVector
Checks the index
checkMultAdd(Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
Checks the arguments to mult and multAdd
checkMultAdd(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
Checks the arguments to mult and multAdd
checkRank1(Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
Checks that a vector rank1 update is possible for the given vectors
checkRank1(Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
Checks that a matrix rank1 update is possible for the given matrix
checkRank2(Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
Checks that a vector rank2 update is legal with the given vectors
checkRank2(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
Checks that a rank2 update is legal for the given arguments
checkSize(Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
Checks that the sizes of this matrix and the given conform
checkSize(Vector) - Method in class no.uib.cipr.matrix.AbstractVector
Checks for conformant sizes
checkSizes(Matrix, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.AbstractIterativeSolver
Checks sizes of input data for IterativeSolver.solve(Matrix, Vector, Vector).
checkSolve(Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
Checks that a matrix inversion is legal for the given arguments.
checkSolve(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
Checks that a matrix inversion is legal for the given arguments.
checkTransABmultAdd(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
Checks the arguments to transABmultAdd and transABmultAdd
checkTransAmultAdd(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
Checks the arguments to transAmult and transAmultAdd
checkTransBmultAdd(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
Checks the arguments to transBmult and transBmultAdd
checkTransMultAdd(Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
Checks the arguments to transMult and transMultAdd
checkTranspose() - Method in class no.uib.cipr.matrix.AbstractMatrix
Checks that the matrix may be transposed
checkTranspose(Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
Checks that this matrix can be transposed into the given matrix
checkTransRank1(Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
Checks that a transposed rank1 update is leagal with the given argument
checkTransRank2(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
Checks that a transposed rank2 update is leagal with the given arguments
column() - Method in interface no.uib.cipr.matrix.MatrixEntry
Returns the current column index
columnBandwidth(Matrix) - Static method in class no.uib.cipr.matrix.Matrices
Finds the number of non-zero entries on each column
compact() - Method in class no.uib.cipr.matrix.sparse.FlexCompColMatrix
Tries to store the matrix as compactly as possible
compact() - Method in class no.uib.cipr.matrix.sparse.FlexCompRowMatrix
Tries to store the matrix as compactly as possible
compact() - Method in class no.uib.cipr.matrix.sparse.SparseVector
Compacts the vector
CompColMatrix - Class in no.uib.cipr.matrix.sparse
Compressed column storage (CCS) matrix
CompColMatrix(MatrixVectorReader) - Constructor for class no.uib.cipr.matrix.sparse.CompColMatrix
Constructor for CompColMatrix
CompColMatrix(int, int, int[][]) - Constructor for class no.uib.cipr.matrix.sparse.CompColMatrix
Constructor for CompColMatrix
CompColMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.sparse.CompColMatrix
Constructor for CompColMatrix
CompColMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.sparse.CompColMatrix
Constructor for CompColMatrix
CompDiagMatrix - Class in no.uib.cipr.matrix.sparse
Compressed diagonal storage (CDS) matrix
CompDiagMatrix(MatrixVectorReader) - Constructor for class no.uib.cipr.matrix.sparse.CompDiagMatrix
Constructor for CompDiagMatrix
CompDiagMatrix(int, int, int[]) - Constructor for class no.uib.cipr.matrix.sparse.CompDiagMatrix
Creates a new sparse matrix with the given diagonals preallocated.
CompDiagMatrix(int, int) - Constructor for class no.uib.cipr.matrix.sparse.CompDiagMatrix
Creates a new sparse matrix without preallocation
CompDiagMatrix(Matrix, int[], boolean) - Constructor for class no.uib.cipr.matrix.sparse.CompDiagMatrix
Creates a new sparse matrix copied from the given matrix.
CompDiagMatrix(Matrix, int[]) - Constructor for class no.uib.cipr.matrix.sparse.CompDiagMatrix
Creates a new sparse matrix copied from the given matrix.
CompDiagMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.sparse.CompDiagMatrix
Creates a new sparse matrix copied from the given matrix.
CompDiagMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.sparse.CompDiagMatrix
Creates a new sparse matrix copied from the given matrix.
CompRowMatrix - Class in no.uib.cipr.matrix.sparse
Compressed row storage (CRS) matrix
CompRowMatrix(MatrixVectorReader) - Constructor for class no.uib.cipr.matrix.sparse.CompRowMatrix
Constructor for CompRowMatrix
CompRowMatrix(int, int, int[][]) - Constructor for class no.uib.cipr.matrix.sparse.CompRowMatrix
Constructor for CompRowMatrix
CompRowMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.sparse.CompRowMatrix
Constructor for CompRowMatrix
CompRowMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.sparse.CompRowMatrix
Constructor for CompRowMatrix
converged(Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
 
converged(double, Vector) - Method in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
 
converged(double) - Method in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
 
converged(Vector) - Method in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
 
converged(Vector, Vector) - Method in interface no.uib.cipr.matrix.sparse.IterationMonitor
Checks for convergence
converged(double, Vector) - Method in interface no.uib.cipr.matrix.sparse.IterationMonitor
Checks for convergence
converged(double) - Method in interface no.uib.cipr.matrix.sparse.IterationMonitor
Checks for convergence
converged(Vector) - Method in interface no.uib.cipr.matrix.sparse.IterationMonitor
Checks for convergence
convergedI(double, Vector) - Method in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
 
convergedI(double) - Method in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
 
convergedI(double) - Method in class no.uib.cipr.matrix.sparse.DefaultIterationMonitor
 
convergedI(double, Vector) - Method in class no.uib.cipr.matrix.sparse.DefaultIterationMonitor
 
convergedI(double, Vector) - Method in class no.uib.cipr.matrix.sparse.MatrixIterationMonitor
 
convergedI(double) - Method in class no.uib.cipr.matrix.sparse.MatrixIterationMonitor
 
copy() - Method in class no.uib.cipr.matrix.AbstractMatrix
 
copy() - Method in class no.uib.cipr.matrix.AbstractVector
 
copy() - Method in class no.uib.cipr.matrix.BandMatrix
 
copy() - Method in class no.uib.cipr.matrix.DenseMatrix
 
copy() - Method in class no.uib.cipr.matrix.DenseVector
 
copy() - Method in class no.uib.cipr.matrix.DenseVectorSub
 
copy() - Method in class no.uib.cipr.matrix.LowerSPDBandMatrix
 
copy() - Method in class no.uib.cipr.matrix.LowerSPDDenseMatrix
 
copy() - Method in class no.uib.cipr.matrix.LowerSPDPackMatrix
 
copy() - Method in class no.uib.cipr.matrix.LowerSymmBandMatrix
 
copy() - Method in class no.uib.cipr.matrix.LowerSymmDenseMatrix
 
copy() - Method in class no.uib.cipr.matrix.LowerSymmPackMatrix
 
copy() - Method in class no.uib.cipr.matrix.LowerTriangBandMatrix
 
copy() - Method in class no.uib.cipr.matrix.LowerTriangDenseMatrix
 
copy() - Method in class no.uib.cipr.matrix.LowerTriangPackMatrix
 
copy() - Method in interface no.uib.cipr.matrix.Matrix
Creates a deep copy of the matrix
copy() - Method in class no.uib.cipr.matrix.sparse.CompColMatrix
 
copy() - Method in class no.uib.cipr.matrix.sparse.CompDiagMatrix
 
copy() - Method in class no.uib.cipr.matrix.sparse.CompRowMatrix
 
copy() - Method in class no.uib.cipr.matrix.sparse.FlexCompColMatrix
 
copy() - Method in class no.uib.cipr.matrix.sparse.FlexCompRowMatrix
 
copy() - Method in class no.uib.cipr.matrix.sparse.LinkedSparseMatrix
 
copy() - Method in class no.uib.cipr.matrix.sparse.SparseVector
 
copy() - Method in class no.uib.cipr.matrix.SPDTridiagMatrix
 
copy() - Method in class no.uib.cipr.matrix.SymmTridiagMatrix
 
copy() - Method in class no.uib.cipr.matrix.TridiagMatrix
 
copy() - Method in class no.uib.cipr.matrix.UnitLowerTriangBandMatrix
 
copy() - Method in class no.uib.cipr.matrix.UnitLowerTriangDenseMatrix
 
copy() - Method in class no.uib.cipr.matrix.UnitLowerTriangPackMatrix
 
copy() - Method in class no.uib.cipr.matrix.UnitUpperTriangBandMatrix
 
copy() - Method in class no.uib.cipr.matrix.UnitUpperTriangDenseMatrix
 
copy() - Method in class no.uib.cipr.matrix.UnitUpperTriangPackMatrix
 
copy() - Method in class no.uib.cipr.matrix.UpperSPDBandMatrix
 
copy() - Method in class no.uib.cipr.matrix.UpperSPDDenseMatrix
 
copy() - Method in class no.uib.cipr.matrix.UpperSPDPackMatrix
 
copy() - Method in class no.uib.cipr.matrix.UpperSymmBandMatrix
 
copy() - Method in class no.uib.cipr.matrix.UpperSymmDenseMatrix
 
copy() - Method in class no.uib.cipr.matrix.UpperSymmPackMatrix
 
copy() - Method in class no.uib.cipr.matrix.UpperTriangBandMatrix
 
copy() - Method in class no.uib.cipr.matrix.UpperTriangDenseMatrix
 
copy() - Method in class no.uib.cipr.matrix.UpperTriangPackMatrix
 
copy() - Method in interface no.uib.cipr.matrix.Vector
Creates a deep copy of the vector

D

DefaultIterationMonitor - Class in no.uib.cipr.matrix.sparse
Default iteration monitor.
DefaultIterationMonitor(int, double, double, double) - Constructor for class no.uib.cipr.matrix.sparse.DefaultIterationMonitor
Constructor for DefaultIterationMonitor
DefaultIterationMonitor() - Constructor for class no.uib.cipr.matrix.sparse.DefaultIterationMonitor
Constructor for DefaultIterationMonitor.
DenseCholesky - Class in no.uib.cipr.matrix
Dense Cholesky decomposition
DenseCholesky(int, boolean) - Constructor for class no.uib.cipr.matrix.DenseCholesky
Constructor for DenseCholesky
DenseLU - Class in no.uib.cipr.matrix
Dense Partial Pivot LU decomposition: A = P * L * U.
DenseLU(int, int) - Constructor for class no.uib.cipr.matrix.DenseLU
Constructor for DenseLU
DenseMatrix - Class in no.uib.cipr.matrix
Dense matrix.
DenseMatrix(MatrixVectorReader) - Constructor for class no.uib.cipr.matrix.DenseMatrix
Constructor for DenseMatrix
DenseMatrix(int, int) - Constructor for class no.uib.cipr.matrix.DenseMatrix
Constructor for DenseMatrix
DenseMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.DenseMatrix
Constructor for DenseMatrix
DenseMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.DenseMatrix
Constructor for DenseMatrix
DenseMatrix(Vector, boolean) - Constructor for class no.uib.cipr.matrix.DenseMatrix
Constructor for DenseMatrix.
DenseMatrix(Vector) - Constructor for class no.uib.cipr.matrix.DenseMatrix
Constructor for DenseMatrix.
DenseMatrix(Vector[]) - Constructor for class no.uib.cipr.matrix.DenseMatrix
Constructor for DenseMatrix.
DenseMatrix(double[][]) - Constructor for class no.uib.cipr.matrix.DenseMatrix
Constructor for DenseMatrix.
DenseVector - Class in no.uib.cipr.matrix
Dense vector.
DenseVector(MatrixVectorReader) - Constructor for class no.uib.cipr.matrix.DenseVector
Constructor for DenseVector
DenseVector(int) - Constructor for class no.uib.cipr.matrix.DenseVector
Constructor for DenseVector
DenseVector(Vector) - Constructor for class no.uib.cipr.matrix.DenseVector
Constructor for DenseVector
DenseVector(Vector, boolean) - Constructor for class no.uib.cipr.matrix.DenseVector
Constructor for DenseVector
DenseVector(double[], boolean) - Constructor for class no.uib.cipr.matrix.DenseVector
Constructor for DenseVector
DenseVector(double[]) - Constructor for class no.uib.cipr.matrix.DenseVector
Constructor for DenseVector
DenseVectorSub - Class in no.uib.cipr.matrix
Wraps a DenseVector, allowing easy access to a sub array of the original without taking copies.
DenseVectorSub(DenseVector, int, int) - Constructor for class no.uib.cipr.matrix.DenseVectorSub
 
DiagonalPreconditioner - Class in no.uib.cipr.matrix.sparse
Diagonal preconditioner.
DiagonalPreconditioner(int) - Constructor for class no.uib.cipr.matrix.sparse.DiagonalPreconditioner
Constructor for DiagonalPreconditioner
dot(Vector) - Method in class no.uib.cipr.matrix.AbstractVector
 
dot(Vector) - Method in class no.uib.cipr.matrix.DenseVector
 
dot(Vector) - Method in class no.uib.cipr.matrix.sparse.SparseVector
 
dot(Vector) - Method in interface no.uib.cipr.matrix.Vector
xT*y

E

EVD - Class in no.uib.cipr.matrix
Computes eigenvalue decompositions of general matrices
EVD(int) - Constructor for class no.uib.cipr.matrix.EVD
Creates an empty eigenvalue decomposition which will compute all the eigenvalues and eigenvectors (left and right)
EVD(int, boolean, boolean) - Constructor for class no.uib.cipr.matrix.EVD
Creates an empty eigenvalue decomposition

F

factor(LowerSPDBandMatrix) - Method in class no.uib.cipr.matrix.BandCholesky
Creates a Cholesky decomposition of the given matrix
factor(UpperSPDBandMatrix) - Method in class no.uib.cipr.matrix.BandCholesky
Creates a Cholesky decomposition of the given matrix
factor(BandMatrix, boolean) - Method in class no.uib.cipr.matrix.BandLU
Creates an LU decomposition of the given matrix
factor(BandMatrix) - Method in class no.uib.cipr.matrix.BandLU
Creates an LU decomposition of the given matrix
factor(LowerSPDDenseMatrix) - Method in class no.uib.cipr.matrix.DenseCholesky
Calculates a Cholesky decomposition
factor(UpperSPDDenseMatrix) - Method in class no.uib.cipr.matrix.DenseCholesky
Calculates a Cholesky decomposition
factor(DenseMatrix) - Method in class no.uib.cipr.matrix.DenseLU
Creates an LU decomposition of the given matrix
factor(DenseMatrix) - Method in class no.uib.cipr.matrix.EVD
Computes the eigenvalue decomposition of the given matrix
factor(DenseMatrix) - Method in class no.uib.cipr.matrix.LQ
 
factor(LowerSPDPackMatrix) - Method in class no.uib.cipr.matrix.PackCholesky
Calculates a Cholesky decomposition
factor(UpperSPDPackMatrix) - Method in class no.uib.cipr.matrix.PackCholesky
Calculates a Cholesky decomposition
factor(DenseMatrix) - Method in class no.uib.cipr.matrix.QL
 
factor(DenseMatrix) - Method in class no.uib.cipr.matrix.QR
 
factor(Matrix) - Method in class no.uib.cipr.matrix.QRP
Executes a QR factorization for the given matrix.
factor(DenseMatrix) - Method in class no.uib.cipr.matrix.RQ
 
factor(DenseMatrix) - Method in class no.uib.cipr.matrix.SVD
Computes an SVD
factor(LowerSymmBandMatrix) - Method in class no.uib.cipr.matrix.SymmBandEVD
Computes the eigenvalue decomposition of the given matrix
factor(UpperSymmBandMatrix) - Method in class no.uib.cipr.matrix.SymmBandEVD
Computes the eigenvalue decomposition of the given matrix
factor(LowerSymmDenseMatrix) - Method in class no.uib.cipr.matrix.SymmDenseEVD
Computes the eigenvalue decomposition of the given matrix
factor(UpperSymmDenseMatrix) - Method in class no.uib.cipr.matrix.SymmDenseEVD
Computes the eigenvalue decomposition of the given matrix
factor(LowerSymmPackMatrix) - Method in class no.uib.cipr.matrix.SymmPackEVD
Computes the eigenvalue decomposition of the given matrix
factor(UpperSymmPackMatrix) - Method in class no.uib.cipr.matrix.SymmPackEVD
Computes the eigenvalue decomposition of the given matrix
factor(SymmTridiagMatrix) - Method in class no.uib.cipr.matrix.SymmTridiagEVD
Computes the eigenvalue decomposition of the given matrix
factorize(LowerSPDBandMatrix) - Static method in class no.uib.cipr.matrix.BandCholesky
Creates a Cholesky decomposition of the given matrix
factorize(UpperSPDBandMatrix) - Static method in class no.uib.cipr.matrix.BandCholesky
Creates a Cholesky decomposition of the given matrix
factorize(BandMatrix) - Static method in class no.uib.cipr.matrix.BandLU
Creates an LU decomposition of the given matrix
factorize(Matrix) - Static method in class no.uib.cipr.matrix.DenseCholesky
Calculates a Cholesky decomposition
factorize(Matrix) - Static method in class no.uib.cipr.matrix.DenseLU
Creates an LU decomposition of the given matrix
factorize(Matrix) - Static method in class no.uib.cipr.matrix.EVD
Convenience method for computing the complete eigenvalue decomposition of the given matrix
factorize(Matrix) - Static method in class no.uib.cipr.matrix.LQ
Convenience method to compute a LQ decomposition
factorize(Matrix) - Static method in class no.uib.cipr.matrix.PackCholesky
Calculates a Cholesky decomposition
factorize(Matrix) - Static method in class no.uib.cipr.matrix.QL
Convenience method to compute a QL decomposition
factorize(Matrix) - Static method in class no.uib.cipr.matrix.QR
Convenience method to compute a QR decomposition
factorize(Matrix) - Static method in class no.uib.cipr.matrix.QRP
Convenience method to compute a QR decomposition
factorize(Matrix) - Static method in class no.uib.cipr.matrix.RQ
Convenience method to compute an RQ decomposition
factorize(Matrix) - Static method in class no.uib.cipr.matrix.SVD
Convenience method for computing a full SVD
factorize(Matrix, int) - Static method in class no.uib.cipr.matrix.SymmBandEVD
Convenience method for computing the full eigenvalue decomposition of the given matrix
factorize(Matrix) - Static method in class no.uib.cipr.matrix.SymmDenseEVD
Convenience method for computing the full eigenvalue decomposition of the given matrix
factorize(Matrix) - Static method in class no.uib.cipr.matrix.SymmPackEVD
Convenience method for computing the full eigenvalue decomposition of the given matrix
factorize(Matrix) - Static method in class no.uib.cipr.matrix.SymmTridiagEVD
Convenience method for computing the full eigenvalue decomposition of the given matrix
FlexCompColMatrix - Class in no.uib.cipr.matrix.sparse
Matrix stored column-wise into sparse vectors
FlexCompColMatrix(int, int) - Constructor for class no.uib.cipr.matrix.sparse.FlexCompColMatrix
Constructor for FlexCompColMatrix
FlexCompColMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.sparse.FlexCompColMatrix
Constructor for FlexCompColMatrix
FlexCompColMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.sparse.FlexCompColMatrix
Constructor for FlexCompColMatrix
FlexCompRowMatrix - Class in no.uib.cipr.matrix.sparse
Matrix stored row-wise into sparse vectors
FlexCompRowMatrix(int, int) - Constructor for class no.uib.cipr.matrix.sparse.FlexCompRowMatrix
Constructor for FlexCompRowMatrix
FlexCompRowMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.sparse.FlexCompRowMatrix
Constructor for FlexCompRowMatrix
FlexCompRowMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.sparse.FlexCompRowMatrix
Constructor for FlexCompRowMatrix
fromPartialPivots(int[]) - Static method in class no.uib.cipr.matrix.PermutationMatrix
The sequential row permutations to perform, e.g.

G

get(int, int) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
get(int) - Method in class no.uib.cipr.matrix.AbstractVector
 
get(int) - Method in class no.uib.cipr.matrix.DenseVector
 
get(int) - Method in class no.uib.cipr.matrix.DenseVectorSub
 
get(int, int) - Method in class no.uib.cipr.matrix.LowerSymmBandMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.LowerSymmDenseMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.LowerSymmPackMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.LowerTriangDenseMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.LowerTriangPackMatrix
 
get(int, int) - Method in interface no.uib.cipr.matrix.Matrix
Returns A(row,column)
get() - Method in interface no.uib.cipr.matrix.MatrixEntry
Returns the value at the current index
get(int, int) - Method in class no.uib.cipr.matrix.PermutationMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.sparse.CompColMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.sparse.CompDiagMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.sparse.CompRowMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.sparse.FlexCompColMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.sparse.FlexCompRowMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.sparse.LinkedSparseMatrix
 
get(int) - Method in class no.uib.cipr.matrix.sparse.SparseVector
 
get(int, int) - Method in class no.uib.cipr.matrix.SymmTridiagMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.TridiagMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.UnitLowerTriangBandMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.UnitLowerTriangDenseMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.UnitLowerTriangPackMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.UnitUpperTriangBandMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.UnitUpperTriangDenseMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.UnitUpperTriangPackMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.UpperSymmBandMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.UpperSymmDenseMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.UpperSymmPackMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.UpperTriangDenseMatrix
 
get(int, int) - Method in class no.uib.cipr.matrix.UpperTriangPackMatrix
 
get(int) - Method in interface no.uib.cipr.matrix.Vector
Returns x(index)
get() - Method in interface no.uib.cipr.matrix.VectorEntry
Returns the value at the current index
getArray(Matrix) - Static method in class no.uib.cipr.matrix.Matrices
Returns an array of arrays containing a copy of the given matrix.
getArray(Vector) - Static method in class no.uib.cipr.matrix.Matrices
Returns a dense array containing a copy of the given vector
getColumn(Matrix, int) - Static method in class no.uib.cipr.matrix.Matrices
 
getColumn(int) - Method in class no.uib.cipr.matrix.sparse.FlexCompColMatrix
Returns the given column
getColumnIndices() - Method in class no.uib.cipr.matrix.sparse.CompRowMatrix
Returns the column indices
getColumnPointers() - Method in class no.uib.cipr.matrix.sparse.CompColMatrix
Returns the column pointers
getData() - Method in class no.uib.cipr.matrix.DenseVector
Returns the internal vector contents.
getData() - Method in class no.uib.cipr.matrix.sparse.CompColMatrix
Returns the internal data storage
getData() - Method in class no.uib.cipr.matrix.sparse.CompRowMatrix
Returns the internal data storage
getData() - Method in class no.uib.cipr.matrix.sparse.SparseVector
Returns the internal data
getDiagonal() - Method in class no.uib.cipr.matrix.SymmTridiagMatrix
Returns the diagonal entries.
getDiagonal() - Method in class no.uib.cipr.matrix.TridiagMatrix
Returns the diagonal entries.
getDiagonals() - Method in class no.uib.cipr.matrix.sparse.CompDiagMatrix
Returns the internal diagonal storage
getImaginaryEigenvalues() - Method in class no.uib.cipr.matrix.EVD
Gets the imaginary part of the eigenvalues
getIndex() - Method in class no.uib.cipr.matrix.sparse.CompDiagMatrix
Returns the diagonal offsets
getIndex() - Method in interface no.uib.cipr.matrix.sparse.ISparseVector
Returns the indices
getIndex() - Method in class no.uib.cipr.matrix.sparse.SparseVector
Returns the indices
getIterationMonitor() - Method in class no.uib.cipr.matrix.sparse.AbstractIterativeSolver
 
getIterationMonitor() - Method in interface no.uib.cipr.matrix.sparse.IterativeSolver
Gets the iteration monitor
getIterationReporter() - Method in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
 
getIterationReporter() - Method in interface no.uib.cipr.matrix.sparse.IterationMonitor
Returns current iteration reporter
getIterations() - Method in exception no.uib.cipr.matrix.sparse.IterativeSolverNotConvergedException
Gets the number of iterations used when this exception was thrown
getL() - Method in class no.uib.cipr.matrix.BandCholesky
Returns the decomposition matrix.
getL() - Method in class no.uib.cipr.matrix.BandLU
Returns the lower triangular factor
getL() - Method in class no.uib.cipr.matrix.DenseCholesky
Returns the decomposition matrix.
getL() - Method in class no.uib.cipr.matrix.DenseLU
Returns the lower triangular factor
getL() - Method in class no.uib.cipr.matrix.LQ
Returns the lower triangular factor
getL() - Method in class no.uib.cipr.matrix.PackCholesky
Returns the decomposition matrix.
getL() - Method in class no.uib.cipr.matrix.QL
Returns the lower triangular factor
getLeftEigenvectors() - Method in class no.uib.cipr.matrix.EVD
Gets the left eigenvectors, if available
getLU() - Method in class no.uib.cipr.matrix.BandLU
Returns the decomposition matrix
getLU() - Method in class no.uib.cipr.matrix.DenseLU
Returns the decomposition matrix
getNormType() - Method in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
 
getNormType() - Method in interface no.uib.cipr.matrix.sparse.IterationMonitor
Returns the vector-norm in use
getNumSubDiagonals(Matrix) - Static method in class no.uib.cipr.matrix.Matrices
Finds the number of diagonals below the main diagonal.
getNumSuperDiagonals(Matrix) - Static method in class no.uib.cipr.matrix.Matrices
Finds the number of diagonals above the main diagonal.
getOffDiagonal() - Method in class no.uib.cipr.matrix.SymmTridiagMatrix
Returns the off diagonal entries.
getP() - Method in class no.uib.cipr.matrix.DenseLU
Returns the permutation matrix.
getP() - Method in class no.uib.cipr.matrix.QRP
Returns the column pivoting matrix.
getPivots() - Method in class no.uib.cipr.matrix.BandLU
Returns the row pivots
getPivots() - Method in class no.uib.cipr.matrix.DenseLU
Returns the row pivots
getPreconditioner() - Method in class no.uib.cipr.matrix.sparse.AbstractIterativeSolver
 
getPreconditioner() - Method in interface no.uib.cipr.matrix.sparse.IterativeSolver
Gets preconditioner
getPVector() - Method in class no.uib.cipr.matrix.QRP
Returns the column pivoting vector.
getQ() - Method in class no.uib.cipr.matrix.QRP
Returns the orthogonal matrix
getR() - Method in class no.uib.cipr.matrix.QR
Returns the upper triangular factor
getR() - Method in class no.uib.cipr.matrix.QRP
Returns the upper triangular factor
getR() - Method in class no.uib.cipr.matrix.RQ
Returns the upper triangular factor
getRank() - Method in class no.uib.cipr.matrix.QRP
Returns the rank of the factored matrix
getRealEigenvalues() - Method in class no.uib.cipr.matrix.EVD
Gets the real part of the eigenvalues
getReason() - Method in exception no.uib.cipr.matrix.NotConvergedException
Returns the reason for the exception
getResidual() - Method in exception no.uib.cipr.matrix.sparse.IterativeSolverNotConvergedException
Returns final computed residual
getRightEigenvectors() - Method in class no.uib.cipr.matrix.EVD
Gets the right eigenvectors, if available
getRow(int) - Method in class no.uib.cipr.matrix.sparse.FlexCompRowMatrix
Returns the given row
getRowIndices() - Method in class no.uib.cipr.matrix.sparse.CompColMatrix
Returns the row indices
getRowPointers() - Method in class no.uib.cipr.matrix.sparse.CompRowMatrix
Returns the row pointers
getS() - Method in class no.uib.cipr.matrix.SVD
Returns the singular values (stored in descending order)
getSubDiagonal() - Method in class no.uib.cipr.matrix.TridiagMatrix
Returns the sub diagonal entries.
getSubMatrix(Matrix, int[], int[]) - Static method in class no.uib.cipr.matrix.Matrices
Returns a view into the given matrix.
getSubVector(Vector, int[]) - Static method in class no.uib.cipr.matrix.Matrices
Returns a view into the given vector.
getSuperDiagonal() - Method in class no.uib.cipr.matrix.TridiagMatrix
Returns the super diagonal entries.
getU() - Method in class no.uib.cipr.matrix.BandCholesky
Returns the decomposition matrix.
getU() - Method in class no.uib.cipr.matrix.BandLU
Returns the upper triangular factor
getU() - Method in class no.uib.cipr.matrix.DenseCholesky
Returns the decomposition matrix.
getU() - Method in class no.uib.cipr.matrix.DenseLU
Returns the upper triangular factor
getU() - Method in class no.uib.cipr.matrix.PackCholesky
Returns the decomposition matrix.
getU() - Method in class no.uib.cipr.matrix.SVD
Returns the left singular vectors, column-wise.
getUsed() - Method in interface no.uib.cipr.matrix.sparse.ISparseVector
Number of entries used in the sparse structure
getUsed() - Method in class no.uib.cipr.matrix.sparse.SparseVector
Number of entries used in the sparse structure
getVt() - Method in class no.uib.cipr.matrix.SVD
Returns the right singular vectors, row-wise.
GivensRotation - Class in no.uib.cipr.matrix
Givens plane rotation
GivensRotation(double, double) - Constructor for class no.uib.cipr.matrix.GivensRotation
Constructs a Givens plane rotation for a given 2-vector
GMRES - Class in no.uib.cipr.matrix.sparse
GMRES solver.
GMRES(Vector) - Constructor for class no.uib.cipr.matrix.sparse.GMRES
Constructor for GMRES.
GMRES(Vector, int) - Constructor for class no.uib.cipr.matrix.sparse.GMRES
Constructor for GMRES.

H

hasInfo() - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Checks if a Matrix Market header is present ("%%MatrixMarket")
hasLeftEigenvectors() - Method in class no.uib.cipr.matrix.EVD
True if the left eigenvectors have been computed
hasRightEigenvectors() - Method in class no.uib.cipr.matrix.EVD
True if the right eigenvectors have been computed
hasSingularVectors() - Method in class no.uib.cipr.matrix.SVD
True if singular vectors are stored

I

ICC - Class in no.uib.cipr.matrix.sparse
Incomplete Cholesky preconditioner without fill-in using a compressed row matrix as internal storage
ICC(CompRowMatrix) - Constructor for class no.uib.cipr.matrix.sparse.ICC
Sets up the ICC preconditioner
identity(int) - Static method in class no.uib.cipr.matrix.Matrices
Returns the identity matrix of the given size
ILU - Class in no.uib.cipr.matrix.sparse
ILU(0) preconditioner using a compressed row matrix as internal storage
ILU(CompRowMatrix) - Constructor for class no.uib.cipr.matrix.sparse.ILU
Sets up the ILU preconditioner
ILUT - Class in no.uib.cipr.matrix.sparse
ILU preconditioner with fill-in.
ILUT(FlexCompRowMatrix, double, int) - Constructor for class no.uib.cipr.matrix.sparse.ILUT
Sets up the preconditioner for the given matrix
ILUT(FlexCompRowMatrix) - Constructor for class no.uib.cipr.matrix.sparse.ILUT
Sets up the preconditioner for the given matrix.
index(int, int) - Static method in class no.uib.cipr.matrix.Matrices
Creates a continuous linear index.
index(int, int, int) - Static method in class no.uib.cipr.matrix.Matrices
Creates a strided linear index.
index() - Method in interface no.uib.cipr.matrix.VectorEntry
Returns the current index
IR - Class in no.uib.cipr.matrix.sparse
Iterative Refinement.
IR(Vector) - Constructor for class no.uib.cipr.matrix.sparse.IR
Constructor for IR.
isArray() - Method in class no.uib.cipr.matrix.io.MatrixInfo
Returns true if the matrix is in array format, else false
isArray() - Method in class no.uib.cipr.matrix.io.VectorInfo
Returns true if the vector is in array format, else false
isComplex() - Method in class no.uib.cipr.matrix.io.MatrixInfo
Returns true if the matrix stores complex numbers, else false
isComplex() - Method in class no.uib.cipr.matrix.io.VectorInfo
Returns true if the vector stores complex numbers, else false
isCoordinate() - Method in class no.uib.cipr.matrix.io.MatrixInfo
Returns true if the matrix is in coordinate format, else false
isCoordinate() - Method in class no.uib.cipr.matrix.io.VectorInfo
Returns true if the vector is in coordinate format, else false
isDense() - Method in class no.uib.cipr.matrix.io.MatrixInfo
Returns true if the matrix is in array format, else false
isDense() - Method in class no.uib.cipr.matrix.io.VectorInfo
Returns true if the vector is in array format, else false
isFirst() - Method in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
 
isFirst() - Method in interface no.uib.cipr.matrix.sparse.IterationMonitor
Returns true for the first iteration
isGeneral() - Method in class no.uib.cipr.matrix.io.MatrixInfo
Returns true if the matrix form is general, else false
isHermitian() - Method in class no.uib.cipr.matrix.io.MatrixInfo
Returns true if the matrix is Hermitian, else false
isInteger() - Method in class no.uib.cipr.matrix.io.MatrixInfo
Returns true if the matrix stores integers, else false
isInteger() - Method in class no.uib.cipr.matrix.io.VectorInfo
Returns true if the vector stores integers, else false
ISparseVector - Interface in no.uib.cipr.matrix.sparse
 
isPattern() - Method in class no.uib.cipr.matrix.io.MatrixInfo
Returns true if the matrix does not store any numbers, else false
isPattern() - Method in class no.uib.cipr.matrix.io.VectorInfo
Returns true if the vector does not store any numbers, else false
isReal() - Method in class no.uib.cipr.matrix.io.MatrixInfo
Returns true if the matrix stores real numbers, else false
isReal() - Method in class no.uib.cipr.matrix.io.VectorInfo
Returns true if the vector stores real numbers, else false
isSingular() - Method in class no.uib.cipr.matrix.BandLU
Checks for singularity
isSingular() - Method in class no.uib.cipr.matrix.DenseLU
Checks for singularity
isSkewSymmetric() - Method in class no.uib.cipr.matrix.io.MatrixInfo
Returns true if the matrix is skew-symmetrical, else false
isSparse() - Method in class no.uib.cipr.matrix.io.MatrixInfo
Returns true if the matrix is in coordinate format, else false
isSparse() - Method in class no.uib.cipr.matrix.io.VectorInfo
Returns true if the vector is in coordinate format, else false
isSPD() - Method in class no.uib.cipr.matrix.BandCholesky
Returns true if the matrix decomposed is symmetrical, positive definite
isSPD() - Method in class no.uib.cipr.matrix.DenseCholesky
Returns true if the matrix decomposed is symmetrical, positive definite
isSPD() - Method in class no.uib.cipr.matrix.PackCholesky
Returns true if the matrix decomposed is symmetrical, positive definite
isSquare() - Method in class no.uib.cipr.matrix.AbstractMatrix
 
isSquare() - Method in class no.uib.cipr.matrix.io.MatrixSize
Returns true if the matrix is square, else false
isSquare() - Method in interface no.uib.cipr.matrix.Matrix
Returns true if the matrix is square
isSymmetric() - Method in class no.uib.cipr.matrix.io.MatrixInfo
Returns true if the matrix is symmetrical, else false
iter - Variable in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
Iteration number
iter - Variable in class no.uib.cipr.matrix.sparse.AbstractIterativeSolver
Iteration monitor
IterationMonitor - Interface in no.uib.cipr.matrix.sparse
Monitors the iterative solution process for convergence and divergence.
IterationReporter - Interface in no.uib.cipr.matrix.sparse
Reports on the progress of an iterative solver
iterations() - Method in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
 
iterations() - Method in interface no.uib.cipr.matrix.sparse.IterationMonitor
Number of iterations performed
IterativeSolver - Interface in no.uib.cipr.matrix.sparse
Iterative linear solver.
IterativeSolverNotConvergedException - Exception in no.uib.cipr.matrix.sparse
Exception for lack of convergence in a linear problem.
IterativeSolverNotConvergedException(NotConvergedException.Reason, String, IterationMonitor) - Constructor for exception no.uib.cipr.matrix.sparse.IterativeSolverNotConvergedException
Constructor for IterativeSolverNotConvergedException
IterativeSolverNotConvergedException(NotConvergedException.Reason, IterationMonitor) - Constructor for exception no.uib.cipr.matrix.sparse.IterativeSolverNotConvergedException
Constructor for IterativeSolverNotConvergedException
iterator() - Method in class no.uib.cipr.matrix.AbstractMatrix
 
iterator() - Method in class no.uib.cipr.matrix.AbstractVector
 
iterator() - Method in class no.uib.cipr.matrix.sparse.CompColMatrix
 
iterator() - Method in class no.uib.cipr.matrix.sparse.CompDiagMatrix
 
iterator() - Method in class no.uib.cipr.matrix.sparse.CompRowMatrix
 
iterator() - Method in class no.uib.cipr.matrix.sparse.FlexCompColMatrix
 
iterator() - Method in class no.uib.cipr.matrix.sparse.FlexCompRowMatrix
 
iterator() - Method in class no.uib.cipr.matrix.sparse.LinkedSparseMatrix
 
iterator() - Method in class no.uib.cipr.matrix.sparse.SparseVector
 
iterator() - Method in class no.uib.cipr.matrix.SymmTridiagMatrix
 
iterator() - Method in class no.uib.cipr.matrix.TridiagMatrix
 

L

LinkedSparseMatrix - Class in no.uib.cipr.matrix.sparse
A Linked List (with shortcuts to important nodes) implementation of an n x m Matrix with z elements that has a typical O(z / m) insertion / lookup cost and an iterator that traverses columns then rows: a good fit for unstructured sparse matrices.
LinkedSparseMatrix(int, int) - Constructor for class no.uib.cipr.matrix.sparse.LinkedSparseMatrix
 
LinkedSparseMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.sparse.LinkedSparseMatrix
 
LinkedSparseMatrix(MatrixVectorReader) - Constructor for class no.uib.cipr.matrix.sparse.LinkedSparseMatrix
 
LowerSPDBandMatrix - Class in no.uib.cipr.matrix
Lower symmetrical positive definite banded matrix.
LowerSPDBandMatrix(int, int) - Constructor for class no.uib.cipr.matrix.LowerSPDBandMatrix
Constructor for LowerSPDBandMatrix
LowerSPDBandMatrix(Matrix, int) - Constructor for class no.uib.cipr.matrix.LowerSPDBandMatrix
Constructor for LowerSPDBandMatrix
LowerSPDBandMatrix(Matrix, int, boolean) - Constructor for class no.uib.cipr.matrix.LowerSPDBandMatrix
Constructor for LowerSPDBandMatrix
LowerSPDDenseMatrix - Class in no.uib.cipr.matrix
Lower symmetrical positive definite dense matrix.
LowerSPDDenseMatrix(int) - Constructor for class no.uib.cipr.matrix.LowerSPDDenseMatrix
Constructor for LowerSPDDenseMatrix
LowerSPDDenseMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.LowerSPDDenseMatrix
Constructor for LowerSPDDenseMatrix
LowerSPDDenseMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.LowerSPDDenseMatrix
Constructor for LowerSPDDenseMatrix
LowerSPDPackMatrix - Class in no.uib.cipr.matrix
Lower symmetrical positive definite packed matrix.
LowerSPDPackMatrix(int) - Constructor for class no.uib.cipr.matrix.LowerSPDPackMatrix
Constructor for LowerSPDPackMatrix
LowerSPDPackMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.LowerSPDPackMatrix
Constructor for LowerSPDPackMatrix
LowerSPDPackMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.LowerSPDPackMatrix
Constructor for LowerSPDPackMatrix
LowerSymmBandMatrix - Class in no.uib.cipr.matrix
Lower symmetrical banded matrix.
LowerSymmBandMatrix(int, int) - Constructor for class no.uib.cipr.matrix.LowerSymmBandMatrix
Constructor for LowerSymmBandMatrix
LowerSymmBandMatrix(Matrix, int) - Constructor for class no.uib.cipr.matrix.LowerSymmBandMatrix
Constructor for LowerSymmBandMatrix
LowerSymmBandMatrix(Matrix, int, boolean) - Constructor for class no.uib.cipr.matrix.LowerSymmBandMatrix
Constructor for LowerSymmBandMatrix
LowerSymmDenseMatrix - Class in no.uib.cipr.matrix
Lower symmetric dense matrix.
LowerSymmDenseMatrix(int) - Constructor for class no.uib.cipr.matrix.LowerSymmDenseMatrix
Constructor for LowerSymmDenseMatrix
LowerSymmDenseMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.LowerSymmDenseMatrix
Constructor for LowerSymmDenseMatrix
LowerSymmDenseMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.LowerSymmDenseMatrix
Constructor for LowerSymmDenseMatrix
LowerSymmPackMatrix - Class in no.uib.cipr.matrix
Lower symmetric packed matrix.
LowerSymmPackMatrix(int) - Constructor for class no.uib.cipr.matrix.LowerSymmPackMatrix
Constructor for LowerSymmPackMatrix
LowerSymmPackMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.LowerSymmPackMatrix
Constructor for LowerSymmPackMatrix
LowerSymmPackMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.LowerSymmPackMatrix
Constructor for LowerSymmPackMatrix
LowerTriangBandMatrix - Class in no.uib.cipr.matrix
Lower triangular banded matrix.
LowerTriangBandMatrix(int, int) - Constructor for class no.uib.cipr.matrix.LowerTriangBandMatrix
Constructor for LowerTriangBandMatrix
LowerTriangBandMatrix(Matrix, int) - Constructor for class no.uib.cipr.matrix.LowerTriangBandMatrix
Constructor for LowerTriangBandMatrix
LowerTriangBandMatrix(Matrix, int, boolean) - Constructor for class no.uib.cipr.matrix.LowerTriangBandMatrix
Constructor for LowerTriangBandMatrix
LowerTriangDenseMatrix - Class in no.uib.cipr.matrix
Lower triangular dense matrix.
LowerTriangDenseMatrix(int) - Constructor for class no.uib.cipr.matrix.LowerTriangDenseMatrix
Constructor for LowerTriangDenseMatrix
LowerTriangDenseMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.LowerTriangDenseMatrix
Constructor for LowerTriangDenseMatrix
LowerTriangDenseMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.LowerTriangDenseMatrix
Constructor for LowerTriangDenseMatrix
LowerTriangDenseMatrix(Matrix, int) - Constructor for class no.uib.cipr.matrix.LowerTriangDenseMatrix
Constructor for LowerTriangDenseMatrix
LowerTriangDenseMatrix(Matrix, int, boolean) - Constructor for class no.uib.cipr.matrix.LowerTriangDenseMatrix
Constructor for LowerTriangDenseMatrix
LowerTriangPackMatrix - Class in no.uib.cipr.matrix
Lower triangular packed matrix.
LowerTriangPackMatrix(int) - Constructor for class no.uib.cipr.matrix.LowerTriangPackMatrix
Constructor for LowerTriangPackMatrix
LowerTriangPackMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.LowerTriangPackMatrix
Constructor for LowerTriangPackMatrix
LowerTriangPackMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.LowerTriangPackMatrix
Constructor for LowerTriangPackMatrix
LQ - Class in no.uib.cipr.matrix
Computes LQ decompositions
LQ(int, int) - Constructor for class no.uib.cipr.matrix.LQ
Constructs an empty LQ decomposition

M

M - Variable in class no.uib.cipr.matrix.sparse.AbstractIterativeSolver
Preconditioner to use
Matrices - Class in no.uib.cipr.matrix
Static utility methods for matrices and vectors
Matrix - Interface in no.uib.cipr.matrix
Basic matrix interface.
Matrix.Norm - Enum in no.uib.cipr.matrix
Supported matrix-norms.
MatrixEntry - Interface in no.uib.cipr.matrix
An entry of a matrix.
MatrixInfo - Class in no.uib.cipr.matrix.io
Contains information on a matrix in the Matrix Market exchange format.
MatrixInfo(boolean, MatrixInfo.MatrixField, MatrixInfo.MatrixSymmetry) - Constructor for class no.uib.cipr.matrix.io.MatrixInfo
Creates a specific type
MatrixInfo.MatrixField - Enum in no.uib.cipr.matrix.io
What kind of numbers are stored
MatrixInfo.MatrixSymmetry - Enum in no.uib.cipr.matrix.io
Symmetry structure of the matrix, if any
MatrixIterationMonitor - Class in no.uib.cipr.matrix.sparse
Iteration monitor based on matrix norms.
MatrixIterationMonitor(double, double, int, double, double, double) - Constructor for class no.uib.cipr.matrix.sparse.MatrixIterationMonitor
Constructor for MatrixIterationMonitor
MatrixIterationMonitor(double, double) - Constructor for class no.uib.cipr.matrix.sparse.MatrixIterationMonitor
Constructor for MatrixIterationMonitor.
MatrixNotSPDException - Exception in no.uib.cipr.matrix
Matrix is not symmetrical, positive definite
MatrixNotSPDException() - Constructor for exception no.uib.cipr.matrix.MatrixNotSPDException
Constructor for MatrixNotSPDException
MatrixNotSPDException(String) - Constructor for exception no.uib.cipr.matrix.MatrixNotSPDException
Constructor for MatrixNotSPDException
MatrixSingularException - Exception in no.uib.cipr.matrix
Matrix is singular
MatrixSingularException() - Constructor for exception no.uib.cipr.matrix.MatrixSingularException
Constructor for MatrixSingularException
MatrixSingularException(String) - Constructor for exception no.uib.cipr.matrix.MatrixSingularException
Constructor for MatrixSingularException
MatrixSize - Class in no.uib.cipr.matrix.io
Contains the size of a matrix stored in the Matrix Market exchange format
MatrixSize(int, int, MatrixInfo) - Constructor for class no.uib.cipr.matrix.io.MatrixSize
Constructor for MatrixSize
MatrixSize(int, int, int) - Constructor for class no.uib.cipr.matrix.io.MatrixSize
Constructor for MatrixSize
MatrixVectorReader - Class in no.uib.cipr.matrix.io
Reads matrices and vectors
MatrixVectorReader(Reader) - Constructor for class no.uib.cipr.matrix.io.MatrixVectorReader
Constructor for MatrixVectorReader
MatrixVectorReader(Reader, int) - Constructor for class no.uib.cipr.matrix.io.MatrixVectorReader
Constructor for MatrixVectorReader
MatrixVectorWriter - Class in no.uib.cipr.matrix.io
Writes matrices and vectors
MatrixVectorWriter(OutputStream) - Constructor for class no.uib.cipr.matrix.io.MatrixVectorWriter
Constructor for MatrixVectorWriter
MatrixVectorWriter(OutputStream, boolean) - Constructor for class no.uib.cipr.matrix.io.MatrixVectorWriter
Constructor for MatrixVectorWriter
MatrixVectorWriter(Writer) - Constructor for class no.uib.cipr.matrix.io.MatrixVectorWriter
Constructor for MatrixVectorWriter
MatrixVectorWriter(Writer, boolean) - Constructor for class no.uib.cipr.matrix.io.MatrixVectorWriter
Constructor for MatrixVectorWriter
max() - Method in class no.uib.cipr.matrix.AbstractMatrix
Returns the largest absolute value
max(double[]) - Method in class no.uib.cipr.matrix.AbstractMatrix
Returns the largest element of the passed array
monitor(double, Vector, int) - Method in interface no.uib.cipr.matrix.sparse.IterationReporter
Registers current information
monitor(double, int) - Method in interface no.uib.cipr.matrix.sparse.IterationReporter
Registers current information
monitor(double, int) - Method in class no.uib.cipr.matrix.sparse.NoIterationReporter
 
monitor(double, Vector, int) - Method in class no.uib.cipr.matrix.sparse.NoIterationReporter
 
monitor(double, int) - Method in class no.uib.cipr.matrix.sparse.OutputIterationReporter
 
monitor(double, Vector, int) - Method in class no.uib.cipr.matrix.sparse.OutputIterationReporter
 
mult(Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
mult(double, Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
mult(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
mult(double, Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
mult(Vector, Vector) - Method in interface no.uib.cipr.matrix.Matrix
y = A*x
mult(double, Vector, Vector) - Method in interface no.uib.cipr.matrix.Matrix
y = alpha*A*x
mult(Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
C = A*B
mult(double, Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
C = alpha*A*B
mult(Matrix, Matrix) - Method in class no.uib.cipr.matrix.PermutationMatrix
 
mult(Matrix, DenseMatrix) - Method in class no.uib.cipr.matrix.PermutationMatrix
 
mult(Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.CompDiagMatrix
 
mult(Matrix, Matrix) - Method in class no.uib.cipr.matrix.sparse.CompRowMatrix
 
mult(Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.CompRowMatrix
 
multAdd(Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
multAdd(double, Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
multAdd(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
multAdd(double, Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
multAdd(double, Vector, Vector) - Method in class no.uib.cipr.matrix.BandMatrix
 
multAdd(double, Matrix, Matrix) - Method in class no.uib.cipr.matrix.DenseMatrix
 
multAdd(double, Vector, Vector) - Method in class no.uib.cipr.matrix.DenseMatrix
 
multAdd(Vector, Vector) - Method in interface no.uib.cipr.matrix.Matrix
y = A*x + y
multAdd(double, Vector, Vector) - Method in interface no.uib.cipr.matrix.Matrix
y = alpha*A*x + y
multAdd(Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
C = A*B + C
multAdd(double, Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
C = alpha*A*B + C
multAdd(double, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.CompColMatrix
 
multAdd(double, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.CompDiagMatrix
 
multAdd(double, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.CompRowMatrix
 
multAdd(double, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.FlexCompColMatrix
 
multAdd(double, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.FlexCompRowMatrix
 
multAdd(double, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.LinkedSparseMatrix
 
multAdd(double, Matrix, Matrix) - Method in class no.uib.cipr.matrix.sparse.LinkedSparseMatrix
 

N

netlib() - Method in enum no.uib.cipr.matrix.Matrix.Norm
 
next() - Method in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
 
next() - Method in interface no.uib.cipr.matrix.sparse.IterationMonitor
Increases iteration counter
no.uib.cipr.matrix - package no.uib.cipr.matrix
Dense and structured sparse matrices, along with matrix factorisations and solvers.
no.uib.cipr.matrix.io - package no.uib.cipr.matrix.io
I/O operations with matrices and vectors.
no.uib.cipr.matrix.sparse - package no.uib.cipr.matrix.sparse
Unstructured sparse matrices and vectors with iterative solvers and preconditioners.
NoIterationReporter - Class in no.uib.cipr.matrix.sparse
An iteration reporter which does nothing.
NoIterationReporter() - Constructor for class no.uib.cipr.matrix.sparse.NoIterationReporter
 
norm(Matrix.Norm) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
norm(Vector.Norm) - Method in class no.uib.cipr.matrix.AbstractVector
 
norm(Matrix.Norm) - Method in interface no.uib.cipr.matrix.Matrix
Computes the given norm of the matrix
norm(Vector.Norm) - Method in interface no.uib.cipr.matrix.Vector
Computes the given norm of the vector
norm1() - Method in class no.uib.cipr.matrix.AbstractMatrix
Computes the 1 norm
norm1() - Method in class no.uib.cipr.matrix.AbstractVector
 
norm1() - Method in class no.uib.cipr.matrix.DenseVector
 
norm1() - Method in class no.uib.cipr.matrix.sparse.SparseVector
 
norm2() - Method in class no.uib.cipr.matrix.AbstractVector
 
norm2() - Method in class no.uib.cipr.matrix.DenseVector
 
norm2() - Method in class no.uib.cipr.matrix.sparse.SparseVector
 
norm2_robust() - Method in class no.uib.cipr.matrix.AbstractVector
 
norm2_robust() - Method in class no.uib.cipr.matrix.DenseVector
 
norm2_robust() - Method in class no.uib.cipr.matrix.sparse.SparseVector
 
normF() - Method in class no.uib.cipr.matrix.AbstractMatrix
Computes the Frobenius norm.
normInf() - Method in class no.uib.cipr.matrix.AbstractMatrix
Computes the infinity norm
normInf() - Method in class no.uib.cipr.matrix.AbstractVector
 
normInf() - Method in class no.uib.cipr.matrix.DenseVector
 
normInf() - Method in class no.uib.cipr.matrix.sparse.SparseVector
 
normType - Variable in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
Vector-norm
NotConvergedException - Exception in no.uib.cipr.matrix
Signals lack of convergence of an iterative process
NotConvergedException(NotConvergedException.Reason, String) - Constructor for exception no.uib.cipr.matrix.NotConvergedException
Constructor for NotConvergedException
NotConvergedException(NotConvergedException.Reason) - Constructor for exception no.uib.cipr.matrix.NotConvergedException
Constructor for NotConvergedException.
NotConvergedException.Reason - Enum in no.uib.cipr.matrix
Possible reasons for lack of convergence
numColumns - Variable in class no.uib.cipr.matrix.AbstractMatrix
Number of columns
numColumns() - Method in class no.uib.cipr.matrix.AbstractMatrix
 
numColumns() - Method in class no.uib.cipr.matrix.io.MatrixSize
Returns the number of columns in the matrix
numColumns() - Method in interface no.uib.cipr.matrix.Matrix
Number of columns in the matrix
numEntries() - Method in class no.uib.cipr.matrix.io.MatrixSize
Returns the number of entries stored
numEntries() - Method in class no.uib.cipr.matrix.io.VectorSize
Returns the number of entries in the vector
numRows - Variable in class no.uib.cipr.matrix.AbstractMatrix
Number of rows
numRows() - Method in class no.uib.cipr.matrix.AbstractMatrix
 
numRows() - Method in class no.uib.cipr.matrix.io.MatrixSize
Returns the number of rows in the matrix
numRows() - Method in interface no.uib.cipr.matrix.Matrix
Number of rows in the matrix

O

OutputIterationReporter - Class in no.uib.cipr.matrix.sparse
Outputs iteration information to an output stream.
OutputIterationReporter(OutputStream) - Constructor for class no.uib.cipr.matrix.sparse.OutputIterationReporter
Constructor for OutputIterationReporter
OutputIterationReporter() - Constructor for class no.uib.cipr.matrix.sparse.OutputIterationReporter
Constructor for OutputIterationReporter, using System.err.

P

PackCholesky - Class in no.uib.cipr.matrix
Packed Cholesky decomposition
PackCholesky(int, boolean) - Constructor for class no.uib.cipr.matrix.PackCholesky
Constructor for DenseCholesky
PermutationMatrix - Class in no.uib.cipr.matrix
Matrix that represents a permutation of another matrix's rows / columns.
PermutationMatrix(int[]) - Constructor for class no.uib.cipr.matrix.PermutationMatrix
 
Preconditioner - Interface in no.uib.cipr.matrix.sparse
Preconditioner interface.
printArray(float[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints an array to the underlying stream.
printArray(double[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints an array to the underlying stream.
printArray(float[], float[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints an array to the underlying stream.
printArray(double[], double[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints an array to the underlying stream.
printArray(int[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints an array to the underlying stream.
printArray(long[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints an array to the underlying stream.
printComments(String[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints all the comments.
printCoordinate(int[], float[], int) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], double[], int) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], int) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], long[], int) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], float[], int) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], double[], int) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], float[], float[], int) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], double[], double[], int) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], float[], float[], int) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], double[], double[], int) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], int[], int) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], long[], int) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], float[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], double[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], float[], float[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], double[], double[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], int[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], long[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], float[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], double[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], float[], float[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], double[], double[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], long[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printMatrixInfo(MatrixInfo) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the matrix info
printMatrixSize(MatrixSize, MatrixInfo) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the matrix size
printMatrixSize(MatrixSize) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the matrix size.
printPattern(int[], int[], int) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinates to the underlying stream.
printPattern(int[], int) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinates to the underlying stream.
printPattern(int[], int[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinates to the underlying stream.
printPattern(int[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the coordinates to the underlying stream.
printVectorInfo(VectorInfo) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the vector info
printVectorSize(VectorSize, VectorInfo) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the vector size
printVectorSize(VectorSize) - Method in class no.uib.cipr.matrix.io.MatrixVectorWriter
Prints the vector size.

Q

QL - Class in no.uib.cipr.matrix
Computes QL decompositions
QL(int, int) - Constructor for class no.uib.cipr.matrix.QL
Constructs an empty QL decomposition
QMR - Class in no.uib.cipr.matrix.sparse
Quasi-Minimal Residual method.
QMR(Vector) - Constructor for class no.uib.cipr.matrix.sparse.QMR
Constructor for QMR.
QMR(Vector, Preconditioner, Preconditioner) - Constructor for class no.uib.cipr.matrix.sparse.QMR
Constructor for QMR.
QR - Class in no.uib.cipr.matrix
Computers QR decompositions
QR(int, int) - Constructor for class no.uib.cipr.matrix.QR
Constructs an empty QR decomposition
QRP - Class in no.uib.cipr.matrix
Computes QR decompositions with column pivoting: A*P = Q*R where A(m,n), Q(m,m), and R(m,n), more generally: A*P = [Q1 Q2] * [R11, R12; 0 R22] and R22 elements are negligible.
QRP(int, int) - Constructor for class no.uib.cipr.matrix.QRP
Constructs an empty QR decomposition

R

random(int) - Static method in class no.uib.cipr.matrix.Matrices
Creates a random vector.
random(Vector) - Static method in class no.uib.cipr.matrix.Matrices
Populates a vector with random numbers drawn from a uniform distribution between 0 and 1
random(int, int) - Static method in class no.uib.cipr.matrix.Matrices
Creates a random matrix.
random(Matrix) - Static method in class no.uib.cipr.matrix.Matrices
Populates a matrix with random numbers drawn from a uniform distribution between 0 and 1
rank1(Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
rank1(double, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
rank1(Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
rank1(double, Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
rank1(Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
rank1(double, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
rank1(double, Vector, Vector) - Method in class no.uib.cipr.matrix.DenseMatrix
 
rank1(Vector) - Method in interface no.uib.cipr.matrix.Matrix
A = x*xT + A.
rank1(double, Vector) - Method in interface no.uib.cipr.matrix.Matrix
A = alpha*x*xT + A.
rank1(Vector, Vector) - Method in interface no.uib.cipr.matrix.Matrix
A = x*yT + A.
rank1(double, Vector, Vector) - Method in interface no.uib.cipr.matrix.Matrix
A = alpha*x*yT + A.
rank1(Matrix) - Method in interface no.uib.cipr.matrix.Matrix
A = C*CT + A.
rank1(double, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
A = alpha*C*CT + A.
rank2(Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
rank2(double, Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
rank2(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
rank2(double, Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
rank2(Vector, Vector) - Method in interface no.uib.cipr.matrix.Matrix
A = x*yT + y*xT + A.
rank2(double, Vector, Vector) - Method in interface no.uib.cipr.matrix.Matrix
A = alpha*x*yT + alpha*y*xT + A.
rank2(Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
A = B*CT + C*BT + A.
rank2(double, Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
A = alpha*B*CT + alpha*C*BT + A.
rcond(Matrix) - Method in class no.uib.cipr.matrix.BandCholesky
Computes the reciprocal condition number
rcond(Matrix, Matrix.Norm) - Method in class no.uib.cipr.matrix.BandLU
Computes the reciprocal condition number, using either the infinity norm of the 1 norm.
rcond(Matrix) - Method in class no.uib.cipr.matrix.DenseCholesky
Computes the reciprocal condition number
rcond(Matrix, Matrix.Norm) - Method in class no.uib.cipr.matrix.DenseLU
Computes the reciprocal condition number, using either the infinity norm of the 1 norm.
rcond(Matrix) - Method in class no.uib.cipr.matrix.PackCholesky
Computes the reciprocal condition number
readArray(double[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads the array data
readArray(float[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads the array data
readArray(int[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads the array data
readArray(long[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads the array data
readArray(double[], double[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads the array data.
readArray(float[], float[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads the array data.
readArraySize() - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads in the size of an array matrix.
readComments() - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads all the comments (lines starting with '%').
readCoordinate(int[], double[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads a coordinate vector
readCoordinate(int[], float[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads a coordinate vector
readCoordinate(int[], int[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads a coordinate vector
readCoordinate(int[], long[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads a coordinate vector
readCoordinate(int[], float[], float[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads a coordinate vector.
readCoordinate(int[], double[], double[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads a coordinate vector.
readCoordinate(int[], int[], double[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads a coordinate matrix
readCoordinate(int[], int[], float[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads a coordinate matrix
readCoordinate(int[], int[], int[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads a coordinate matrix
readCoordinate(int[], int[], long[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads a coordinate matrix
readCoordinate(int[], int[], double[], double[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads a coordinate matrix.
readCoordinate(int[], int[], float[], float[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads a coordinate matrix.
readCoordinateSize() - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads in the size of a coordinate matrix.
readMatrixInfo() - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads the matrix info for the Matrix Market exchange format.
readMatrixSize(MatrixInfo) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads in the size of a matrix.
readPattern(int[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads a pattern vector
readPattern(int[], int[]) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads a pattern matrix
readVectorArraySize() - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads in the size of a dense vector.
readVectorCoordinateSize() - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads in the size of a coordinate vector.
readVectorInfo() - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads the vector info for the Matrix Market exchange format.
readVectorSize(VectorInfo) - Method in class no.uib.cipr.matrix.io.MatrixVectorReader
Reads in the size of a vector.
reason - Variable in exception no.uib.cipr.matrix.NotConvergedException
The reason for this exception
reporter - Variable in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
Iteration reporter
residual - Variable in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
Current residual
residual() - Method in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
 
residual() - Method in interface no.uib.cipr.matrix.sparse.IterationMonitor
Returns current residual
row() - Method in interface no.uib.cipr.matrix.MatrixEntry
Returns the current row index
rowBandwidth(Matrix) - Static method in class no.uib.cipr.matrix.Matrices
Finds the number of non-zero entries on each row
RQ - Class in no.uib.cipr.matrix
Computes RQ decompositions
RQ(int, int) - Constructor for class no.uib.cipr.matrix.RQ
Constructs an empty RQ decomposition

S

scale(double) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
scale(double) - Method in class no.uib.cipr.matrix.AbstractVector
 
scale(double) - Method in class no.uib.cipr.matrix.DenseVector
 
scale(double) - Method in interface no.uib.cipr.matrix.Matrix
A = alpha*A
scale(double) - Method in class no.uib.cipr.matrix.sparse.LinkedSparseMatrix
 
scale(double) - Method in class no.uib.cipr.matrix.sparse.SparseVector
 
scale(double) - Method in interface no.uib.cipr.matrix.Vector
x=alpha*x
set(int, int, double) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
set(Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
set(double, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
set(int, double) - Method in class no.uib.cipr.matrix.AbstractVector
 
set(Vector) - Method in class no.uib.cipr.matrix.AbstractVector
 
set(double, Vector) - Method in class no.uib.cipr.matrix.AbstractVector
 
set(int, double) - Method in class no.uib.cipr.matrix.DenseVector
 
set(Vector) - Method in class no.uib.cipr.matrix.DenseVector
 
set(double, Vector) - Method in class no.uib.cipr.matrix.DenseVector
 
set(int, double) - Method in class no.uib.cipr.matrix.DenseVectorSub
 
set(int, int, double) - Method in class no.uib.cipr.matrix.LowerSymmBandMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.LowerSymmDenseMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.LowerSymmPackMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.LowerTriangDenseMatrix
 
set(Matrix) - Method in class no.uib.cipr.matrix.LowerTriangDenseMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.LowerTriangPackMatrix
 
set(int, int, double) - Method in interface no.uib.cipr.matrix.Matrix
A(row,column) = value
set(Matrix) - Method in interface no.uib.cipr.matrix.Matrix
A=B.
set(double, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
A=alpha*B.
set(double) - Method in interface no.uib.cipr.matrix.MatrixEntry
Sets the value at the current index
set(int, int, double) - Method in class no.uib.cipr.matrix.sparse.CompColMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.sparse.CompDiagMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.sparse.CompRowMatrix
 
set(Matrix) - Method in class no.uib.cipr.matrix.sparse.CompRowMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.sparse.FlexCompColMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.sparse.FlexCompRowMatrix
 
set(Matrix) - Method in class no.uib.cipr.matrix.sparse.FlexCompRowMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.sparse.LinkedSparseMatrix
 
set(int, double) - Method in class no.uib.cipr.matrix.sparse.SparseVector
 
set(Vector) - Method in class no.uib.cipr.matrix.sparse.SparseVector
 
set(int, int, double) - Method in class no.uib.cipr.matrix.SymmTridiagMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.TridiagMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.UnitLowerTriangBandMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.UnitLowerTriangDenseMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.UnitLowerTriangPackMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.UnitUpperTriangBandMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.UnitUpperTriangDenseMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.UnitUpperTriangPackMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.UpperSymmBandMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.UpperSymmDenseMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.UpperSymmPackMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.UpperTriangDenseMatrix
 
set(Matrix) - Method in class no.uib.cipr.matrix.UpperTriangDenseMatrix
 
set(int, int, double) - Method in class no.uib.cipr.matrix.UpperTriangPackMatrix
 
set(int, double) - Method in interface no.uib.cipr.matrix.Vector
x(index) = value
set(Vector) - Method in interface no.uib.cipr.matrix.Vector
x=y
set(double, Vector) - Method in interface no.uib.cipr.matrix.Vector
x=alpha*y
set(double) - Method in interface no.uib.cipr.matrix.VectorEntry
Sets the value at the current index
setAbsoluteTolerance(double) - Method in class no.uib.cipr.matrix.sparse.DefaultIterationMonitor
Sets the absolute tolerance
setColumn(int, SparseVector) - Method in class no.uib.cipr.matrix.sparse.FlexCompColMatrix
Sets the given column equal the passed vector
setDivergenceTolerance(double) - Method in class no.uib.cipr.matrix.sparse.DefaultIterationMonitor
Sets the divergence tolerance
setEigenvalues(double, double) - Method in class no.uib.cipr.matrix.sparse.Chebyshev
Sets the eigenvalue estimates.
setFirst() - Method in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
 
setFirst() - Method in interface no.uib.cipr.matrix.sparse.IterationMonitor
Resets the iteration
setIterationMonitor(IterationMonitor) - Method in class no.uib.cipr.matrix.sparse.AbstractIterativeSolver
 
setIterationMonitor(IterationMonitor) - Method in interface no.uib.cipr.matrix.sparse.IterativeSolver
Sets iteration monitor
setIterationReporter(IterationReporter) - Method in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
 
setIterationReporter(IterationReporter) - Method in interface no.uib.cipr.matrix.sparse.IterationMonitor
Sets new iteration reporter
setMatrix(Matrix) - Method in class no.uib.cipr.matrix.sparse.AMG
 
setMatrix(Matrix) - Method in class no.uib.cipr.matrix.sparse.DiagonalPreconditioner
 
setMatrix(Matrix) - Method in class no.uib.cipr.matrix.sparse.ICC
 
setMatrix(Matrix) - Method in class no.uib.cipr.matrix.sparse.ILU
 
setMatrix(Matrix) - Method in class no.uib.cipr.matrix.sparse.ILUT
 
setMatrix(Matrix) - Method in interface no.uib.cipr.matrix.sparse.Preconditioner
Sets the operator matrix for the preconditioner.
setMatrix(Matrix) - Method in class no.uib.cipr.matrix.sparse.SSOR
 
setMatrixNorm(double) - Method in class no.uib.cipr.matrix.sparse.MatrixIterationMonitor
Sets the norm of the system matrix
setMaxIterations(int) - Method in class no.uib.cipr.matrix.sparse.DefaultIterationMonitor
Sets maximum number of iterations to permit
setNormType(Vector.Norm) - Method in class no.uib.cipr.matrix.sparse.AbstractIterationMonitor
 
setNormType(Vector.Norm) - Method in interface no.uib.cipr.matrix.sparse.IterationMonitor
Sets the vector-norm to calculate with
setOmega(double, double) - Method in class no.uib.cipr.matrix.sparse.SSOR
Sets the overrelaxation parameters
setPreconditioner(Preconditioner) - Method in class no.uib.cipr.matrix.sparse.AbstractIterativeSolver
 
setPreconditioner(Preconditioner) - Method in interface no.uib.cipr.matrix.sparse.IterativeSolver
Sets preconditioner
setPreconditioner(Preconditioner) - Method in class no.uib.cipr.matrix.sparse.QMR
 
setRelativeTolerance(double) - Method in class no.uib.cipr.matrix.sparse.DefaultIterationMonitor
Sets the relative tolerance
setRestart(int) - Method in class no.uib.cipr.matrix.sparse.GMRES
Sets the restart parameter
setRow(int, SparseVector) - Method in class no.uib.cipr.matrix.sparse.FlexCompRowMatrix
Sets the given row equal the passed vector
setVectorNorm(double) - Method in class no.uib.cipr.matrix.sparse.MatrixIterationMonitor
Sets the norm of the right hand side vector
size - Variable in class no.uib.cipr.matrix.AbstractVector
Size of the vector
size() - Method in class no.uib.cipr.matrix.AbstractVector
 
size() - Method in class no.uib.cipr.matrix.io.VectorSize
Returns the size of the vector
size() - Method in interface no.uib.cipr.matrix.Vector
Size of the vector
solve(Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
solve(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
solve(DenseMatrix) - Method in class no.uib.cipr.matrix.BandCholesky
Computes A\B, overwriting B
solve(DenseMatrix) - Method in class no.uib.cipr.matrix.BandLU
Computes A\B, overwriting B
solve(Matrix, Matrix) - Method in class no.uib.cipr.matrix.BandMatrix
 
solve(Vector, Vector) - Method in class no.uib.cipr.matrix.BandMatrix
 
solve(DenseMatrix) - Method in class no.uib.cipr.matrix.DenseCholesky
Solves for B, overwriting it on return
solve(DenseMatrix) - Method in class no.uib.cipr.matrix.DenseLU
Computes A\B, overwriting B
solve(Matrix, Matrix) - Method in class no.uib.cipr.matrix.DenseMatrix
 
solve(Vector, Vector) - Method in class no.uib.cipr.matrix.DenseMatrix
 
solve(Matrix, Matrix) - Method in class no.uib.cipr.matrix.LowerSPDBandMatrix
 
solve(Matrix, Matrix) - Method in class no.uib.cipr.matrix.LowerSPDDenseMatrix
 
solve(Matrix, Matrix) - Method in class no.uib.cipr.matrix.LowerSPDPackMatrix
 
solve(Vector, Vector) - Method in interface no.uib.cipr.matrix.Matrix
x = A\b.
solve(Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
X = A\B.
solve(DenseMatrix) - Method in class no.uib.cipr.matrix.PackCholesky
Solves for B, overwriting it on return
solve(int, ArpackSym.Ritz) - Method in class no.uib.cipr.matrix.sparse.ArpackSym
Solve the eigensystem for the number of eigenvalues requested.
solve(Matrix, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.BiCG
 
solve(Matrix, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.BiCGstab
 
solve(Matrix, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.CG
 
solve(Matrix, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.CGS
 
solve(Matrix, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.Chebyshev
 
solve(Matrix, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.GMRES
 
solve(Matrix, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.IR
 
solve(Matrix, Vector, Vector) - Method in interface no.uib.cipr.matrix.sparse.IterativeSolver
Solves the given problem, writing result into the vector.
solve(Matrix, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.QMR
 
solve(Matrix, Matrix) - Method in class no.uib.cipr.matrix.SPDTridiagMatrix
 
solve(Matrix, Matrix) - Method in class no.uib.cipr.matrix.SymmTridiagMatrix
 
solve(Vector, Vector) - Method in class no.uib.cipr.matrix.SymmTridiagMatrix
 
solve(Matrix, Matrix) - Method in class no.uib.cipr.matrix.TridiagMatrix
 
solve(Vector, Vector) - Method in class no.uib.cipr.matrix.TridiagMatrix
 
solve(Matrix, Matrix) - Method in class no.uib.cipr.matrix.UpperSPDBandMatrix
 
solve(Matrix, Matrix) - Method in class no.uib.cipr.matrix.UpperSPDDenseMatrix
 
solve(Matrix, Matrix) - Method in class no.uib.cipr.matrix.UpperSPDPackMatrix
 
SparseVector - Class in no.uib.cipr.matrix.sparse
Sparse vector
SparseVector(int, int) - Constructor for class no.uib.cipr.matrix.sparse.SparseVector
Constructor for SparseVector.
SparseVector(Vector, boolean) - Constructor for class no.uib.cipr.matrix.sparse.SparseVector
Constructor for SparseVector, and copies the contents from the supplied vector.
SparseVector(Vector) - Constructor for class no.uib.cipr.matrix.sparse.SparseVector
Constructor for SparseVector, and copies the contents from the supplied vector.
SparseVector(int) - Constructor for class no.uib.cipr.matrix.sparse.SparseVector
Constructor for SparseVector.
SparseVector(int, int[], double[], boolean) - Constructor for class no.uib.cipr.matrix.sparse.SparseVector
Constructor for SparseVector
SparseVector(int, int[], double[]) - Constructor for class no.uib.cipr.matrix.sparse.SparseVector
Constructor for SparseVector
SPDTridiagMatrix - Class in no.uib.cipr.matrix
Symmetrical positive definite tridiagonal matrix.
SPDTridiagMatrix(int) - Constructor for class no.uib.cipr.matrix.SPDTridiagMatrix
Constructor for SPDTridiagMatrix
SPDTridiagMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.SPDTridiagMatrix
Constructor for SPDTridiagMatrix
SPDTridiagMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.SPDTridiagMatrix
Constructor for SPDTridiagMatrix
SSOR - Class in no.uib.cipr.matrix.sparse
SSOR preconditioner.
SSOR(CompRowMatrix, boolean, double, double) - Constructor for class no.uib.cipr.matrix.sparse.SSOR
Constructor for SSOR
SSOR(CompRowMatrix) - Constructor for class no.uib.cipr.matrix.sparse.SSOR
Constructor for SSOR.
SVD - Class in no.uib.cipr.matrix
Computes singular value decompositions
SVD(int, int) - Constructor for class no.uib.cipr.matrix.SVD
Creates an empty SVD which will compute all singular values and vectors
SVD(int, int, boolean) - Constructor for class no.uib.cipr.matrix.SVD
Creates an empty SVD
SymmBandEVD - Class in no.uib.cipr.matrix
Computes eigenvalues of symmetrical, banded matrices
SymmBandEVD(int, boolean) - Constructor for class no.uib.cipr.matrix.SymmBandEVD
Sets up an eigenvalue decomposition for symmetrical, banded matrices.
SymmBandEVD(int, boolean, boolean) - Constructor for class no.uib.cipr.matrix.SymmBandEVD
Sets up an eigenvalue decomposition for symmetrical, banded matrices
SymmDenseEVD - Class in no.uib.cipr.matrix
Computes eigenvalues of symmetrical, dense matrices
SymmDenseEVD(int, boolean) - Constructor for class no.uib.cipr.matrix.SymmDenseEVD
Sets up an eigenvalue decomposition for symmetrical, dense matrices.
SymmDenseEVD(int, boolean, double) - Constructor for class no.uib.cipr.matrix.SymmDenseEVD
Sets up an eigenvalue decomposition for symmetrical, dense matrices.
SymmDenseEVD(int, boolean, boolean) - Constructor for class no.uib.cipr.matrix.SymmDenseEVD
Sets up an eigenvalue decomposition for symmetrical, dense matrices.
SymmDenseEVD(int, boolean, boolean, double) - Constructor for class no.uib.cipr.matrix.SymmDenseEVD
Sets up an eigenvalue decomposition for symmetrical, dense matrices
SymmPackEVD - Class in no.uib.cipr.matrix
Computes eigenvalues of symmetrical, packed matrices
SymmPackEVD(int, boolean) - Constructor for class no.uib.cipr.matrix.SymmPackEVD
Sets up an eigenvalue decomposition for symmetrical, packed matrices.
SymmPackEVD(int, boolean, boolean) - Constructor for class no.uib.cipr.matrix.SymmPackEVD
Sets up an eigenvalue decomposition for symmetrical, packed matrices
SymmTridiagEVD - Class in no.uib.cipr.matrix
Computes eigenvalues of symmetrical, tridiagonal matrices
SymmTridiagEVD(int) - Constructor for class no.uib.cipr.matrix.SymmTridiagEVD
Sets up an eigenvalue decomposition for symmetrical, tridiagonal matrices.
SymmTridiagEVD(int, double) - Constructor for class no.uib.cipr.matrix.SymmTridiagEVD
Sets up an eigenvalue decomposition for symmetrical, tridiagonal matrices.
SymmTridiagEVD(int, boolean) - Constructor for class no.uib.cipr.matrix.SymmTridiagEVD
Sets up an eigenvalue decomposition for symmetrical, tridiagonal matrices.
SymmTridiagEVD(int, boolean, double) - Constructor for class no.uib.cipr.matrix.SymmTridiagEVD
Sets up an eigenvalue decomposition for symmetrical, tridiagonal matrices
SymmTridiagMatrix - Class in no.uib.cipr.matrix
Symmetrical tridiagonal matrix.
SymmTridiagMatrix(double[], double[], int) - Constructor for class no.uib.cipr.matrix.SymmTridiagMatrix
Constructor for SymmTridiagMatrix
SymmTridiagMatrix(double[], double[]) - Constructor for class no.uib.cipr.matrix.SymmTridiagMatrix
Constructor for SymmTridiagMatrix
SymmTridiagMatrix(int) - Constructor for class no.uib.cipr.matrix.SymmTridiagMatrix
Constructor for SymmTridiagMatrix
SymmTridiagMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.SymmTridiagMatrix
Constructor for SymmTridiagMatrix
SymmTridiagMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.SymmTridiagMatrix
Constructor for SymmTridiagMatrix
synchronizedMatrix(Matrix) - Static method in class no.uib.cipr.matrix.Matrices
Returns a synchronized matrix which wraps the given matrix.
synchronizedMatrixByColumns(Matrix) - Static method in class no.uib.cipr.matrix.Matrices
Returns a synchronized matrix which wraps the given matrix.
synchronizedMatrixByRows(Matrix) - Static method in class no.uib.cipr.matrix.Matrices
Returns a synchronized matrix which wraps the given matrix.
synchronizedVector(Vector) - Static method in class no.uib.cipr.matrix.Matrices
Returns a synchronized vector which wraps the given vector.

T

toString() - Method in class no.uib.cipr.matrix.AbstractMatrix
 
toString() - Method in class no.uib.cipr.matrix.AbstractVector
 
toString() - Method in class no.uib.cipr.matrix.io.MatrixInfo
Returns a string representation of the specifier.
toString() - Method in class no.uib.cipr.matrix.io.VectorInfo
Returns a string representation of the specifier.
transABmult(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transABmult(double, Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transABmult(Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
C = AT*BT
transABmult(double, Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
C = alpha*AT*BT
transABmultAdd(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transABmultAdd(double, Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transABmultAdd(double, Matrix, Matrix) - Method in class no.uib.cipr.matrix.DenseMatrix
 
transABmultAdd(Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
C = AT*BT + C
transABmultAdd(double, Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
C = alpha*AT*BT + C
transABmultAdd(double, Matrix, Matrix) - Method in class no.uib.cipr.matrix.sparse.LinkedSparseMatrix
 
transAmult(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transAmult(double, Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transAmult(Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
C = AT*B
transAmult(double, Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
C = alpha*AT*B
transAmult(Matrix, Matrix) - Method in class no.uib.cipr.matrix.PermutationMatrix
 
transAmult(Matrix, DenseMatrix) - Method in class no.uib.cipr.matrix.PermutationMatrix
 
transAmultAdd(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transAmultAdd(double, Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transAmultAdd(double, Matrix, Matrix) - Method in class no.uib.cipr.matrix.DenseMatrix
 
transAmultAdd(Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
C = AT*B + C
transAmultAdd(double, Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
C = alpha*AT*B + C
transAmultAdd(double, Matrix, Matrix) - Method in class no.uib.cipr.matrix.sparse.LinkedSparseMatrix
 
transApply(Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.AMG
 
transApply(Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.DiagonalPreconditioner
 
transApply(Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.ICC
 
transApply(Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.ILU
 
transApply(Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.ILUT
 
transApply(Vector, Vector) - Method in interface no.uib.cipr.matrix.sparse.Preconditioner
Solves the approximate transpose problem with the given right hand side.
transApply(Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.SSOR
 
transBmult(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transBmult(double, Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transBmult(Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
C = A*BT
transBmult(double, Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
C = alpha*A*BT
transBmultAdd(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transBmultAdd(double, Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transBmultAdd(double, Matrix, Matrix) - Method in class no.uib.cipr.matrix.DenseMatrix
 
transBmultAdd(Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
C = A*BT + C
transBmultAdd(double, Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
C = alpha*A*BT + C
transBmultAdd(double, Matrix, Matrix) - Method in class no.uib.cipr.matrix.sparse.LinkedSparseMatrix
 
transMult(Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transMult(double, Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transMult(Vector, Vector) - Method in interface no.uib.cipr.matrix.Matrix
y = AT*x
transMult(double, Vector, Vector) - Method in interface no.uib.cipr.matrix.Matrix
y = alpha*AT*x
transMult(Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.CompColMatrix
 
transMult(Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.CompRowMatrix
 
transMultAdd(Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transMultAdd(double, Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transMultAdd(double, Vector, Vector) - Method in class no.uib.cipr.matrix.BandMatrix
 
transMultAdd(double, Vector, Vector) - Method in class no.uib.cipr.matrix.DenseMatrix
 
transMultAdd(Vector, Vector) - Method in interface no.uib.cipr.matrix.Matrix
y = AT*x + y
transMultAdd(double, Vector, Vector) - Method in interface no.uib.cipr.matrix.Matrix
y = alpha*AT*x + y
transMultAdd(double, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.CompColMatrix
 
transMultAdd(double, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.CompDiagMatrix
 
transMultAdd(double, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.CompRowMatrix
 
transMultAdd(double, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.FlexCompColMatrix
 
transMultAdd(double, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.FlexCompRowMatrix
 
transMultAdd(double, Vector, Vector) - Method in class no.uib.cipr.matrix.sparse.LinkedSparseMatrix
 
transpose() - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transpose(Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transpose() - Method in class no.uib.cipr.matrix.BandMatrix
 
transpose() - Method in interface no.uib.cipr.matrix.Matrix
Transposes the matrix in-place.
transpose(Matrix) - Method in interface no.uib.cipr.matrix.Matrix
Sets the tranpose of this matrix into B.
transpose() - Method in class no.uib.cipr.matrix.PermutationMatrix
 
transpose() - Method in class no.uib.cipr.matrix.sparse.LinkedSparseMatrix
 
transpose() - Method in class no.uib.cipr.matrix.SymmTridiagMatrix
 
transpose() - Method in class no.uib.cipr.matrix.TridiagMatrix
 
transRank1(Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transRank1(double, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transRank1(Matrix) - Method in interface no.uib.cipr.matrix.Matrix
A = CT*C + A The matrices must be square and of the same size
transRank1(double, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
A = alpha*CT*C + A The matrices must be square and of the same size
transRank2(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transRank2(double, Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transRank2(Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
A = BT*C + CT*B + A.
transRank2(double, Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
A = alpha*BT*C + alpha*CT*B + A.
transSolve(Vector, Vector) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transSolve(Matrix, Matrix) - Method in class no.uib.cipr.matrix.AbstractMatrix
 
transSolve(DenseMatrix) - Method in class no.uib.cipr.matrix.BandLU
Computes AT\B, overwriting B
transSolve(DenseMatrix) - Method in class no.uib.cipr.matrix.DenseLU
Computes AT\B, overwriting B
transSolve(Matrix, Matrix) - Method in class no.uib.cipr.matrix.DenseMatrix
 
transSolve(Vector, Vector) - Method in class no.uib.cipr.matrix.DenseMatrix
 
transSolve(Vector, Vector) - Method in interface no.uib.cipr.matrix.Matrix
x = AT\b.
transSolve(Matrix, Matrix) - Method in interface no.uib.cipr.matrix.Matrix
X = AT\B.
transSolve(Matrix, Matrix) - Method in class no.uib.cipr.matrix.SymmTridiagMatrix
 
transSolve(Vector, Vector) - Method in class no.uib.cipr.matrix.SymmTridiagMatrix
 
TridiagMatrix - Class in no.uib.cipr.matrix
Tridiagonal matrix.
TridiagMatrix(int) - Constructor for class no.uib.cipr.matrix.TridiagMatrix
Constructor for TridiagMatrix
TridiagMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.TridiagMatrix
Constructor for TridiagMatrix
TridiagMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.TridiagMatrix
Constructor for TridiagMatrix

U

UnitLowerTriangBandMatrix - Class in no.uib.cipr.matrix
Unit lower triangular banded matrix.
UnitLowerTriangBandMatrix(int, int) - Constructor for class no.uib.cipr.matrix.UnitLowerTriangBandMatrix
Constructor for UnitLowerTriangBandMatrix
UnitLowerTriangBandMatrix(Matrix, int) - Constructor for class no.uib.cipr.matrix.UnitLowerTriangBandMatrix
Constructor for UnitLowerTriangBandMatrix
UnitLowerTriangBandMatrix(Matrix, int, boolean) - Constructor for class no.uib.cipr.matrix.UnitLowerTriangBandMatrix
Constructor for UnitLowerTriangBandMatrix
UnitLowerTriangDenseMatrix - Class in no.uib.cipr.matrix
Unit lower triangular dense matrix.
UnitLowerTriangDenseMatrix(int) - Constructor for class no.uib.cipr.matrix.UnitLowerTriangDenseMatrix
Constructor for UnitLowerTriangDenseMatrix
UnitLowerTriangDenseMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.UnitLowerTriangDenseMatrix
Constructor for UnitLowerTriangDenseMatrix
UnitLowerTriangDenseMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.UnitLowerTriangDenseMatrix
Constructor for UnitLowerTriangDenseMatrix
UnitLowerTriangPackMatrix - Class in no.uib.cipr.matrix
Unit lower triangular packed matrix.
UnitLowerTriangPackMatrix(int) - Constructor for class no.uib.cipr.matrix.UnitLowerTriangPackMatrix
Constructor for UnitLowerTriangPackMatrix
UnitLowerTriangPackMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.UnitLowerTriangPackMatrix
Constructor for UnitLowerTriangPackMatrix
UnitLowerTriangPackMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.UnitLowerTriangPackMatrix
Constructor for UnitLowerTriangPackMatrix
UnitUpperTriangBandMatrix - Class in no.uib.cipr.matrix
Unit upper triangular banded matrix.
UnitUpperTriangBandMatrix(int, int) - Constructor for class no.uib.cipr.matrix.UnitUpperTriangBandMatrix
Constructor for UnitUpperTriangBandMatrix
UnitUpperTriangBandMatrix(Matrix, int) - Constructor for class no.uib.cipr.matrix.UnitUpperTriangBandMatrix
Constructor for UnitUpperTriangBandMatrix
UnitUpperTriangBandMatrix(Matrix, int, boolean) - Constructor for class no.uib.cipr.matrix.UnitUpperTriangBandMatrix
Constructor for UnitUpperTriangBandMatrix
UnitUpperTriangDenseMatrix - Class in no.uib.cipr.matrix
Unit upper triangular dense matrix.
UnitUpperTriangDenseMatrix(int) - Constructor for class no.uib.cipr.matrix.UnitUpperTriangDenseMatrix
Constructor for UnitUpperTriangDenseMatrix
UnitUpperTriangDenseMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.UnitUpperTriangDenseMatrix
Constructor for UnitUpperTriangDenseMatrix.
UnitUpperTriangDenseMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.UnitUpperTriangDenseMatrix
Constructor for UnitUpperTriangDenseMatrix.
UnitUpperTriangPackMatrix - Class in no.uib.cipr.matrix
Unit upper triangular packed matrix.
UnitUpperTriangPackMatrix(int) - Constructor for class no.uib.cipr.matrix.UnitUpperTriangPackMatrix
Constructor for UnitUpperTriangPackMatrix
UnitUpperTriangPackMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.UnitUpperTriangPackMatrix
Constructor for UnitUpperTriangPackMatrix
UnitUpperTriangPackMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.UnitUpperTriangPackMatrix
Constructor for UnitUpperTriangPackMatrix
UpperSPDBandMatrix - Class in no.uib.cipr.matrix
Upper symmetrical positive definite banded matrix.
UpperSPDBandMatrix(int, int) - Constructor for class no.uib.cipr.matrix.UpperSPDBandMatrix
Constructor for UpperSPDBandMatrix
UpperSPDBandMatrix(Matrix, int) - Constructor for class no.uib.cipr.matrix.UpperSPDBandMatrix
Constructor for UpperSPDBandMatrix
UpperSPDBandMatrix(Matrix, int, boolean) - Constructor for class no.uib.cipr.matrix.UpperSPDBandMatrix
Constructor for UpperSPDBandMatrix
UpperSPDDenseMatrix - Class in no.uib.cipr.matrix
Upper symmetrical positive definite dense matrix.
UpperSPDDenseMatrix(int) - Constructor for class no.uib.cipr.matrix.UpperSPDDenseMatrix
Constructor for UpperSPDDenseMatrix
UpperSPDDenseMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.UpperSPDDenseMatrix
Constructor for UpperSPDDenseMatrix
UpperSPDDenseMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.UpperSPDDenseMatrix
Constructor for UpperSPDDenseMatrix
UpperSPDPackMatrix - Class in no.uib.cipr.matrix
Upper symmetrical positive definite packed matrix.
UpperSPDPackMatrix(int) - Constructor for class no.uib.cipr.matrix.UpperSPDPackMatrix
Constructor for UpperSPDPackMatrix
UpperSPDPackMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.UpperSPDPackMatrix
Constructor for UpperSPDPackMatrix
UpperSPDPackMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.UpperSPDPackMatrix
Constructor for UpperSPDPackMatrix
UpperSymmBandMatrix - Class in no.uib.cipr.matrix
Upper symmetrical banded matrix.
UpperSymmBandMatrix(int, int) - Constructor for class no.uib.cipr.matrix.UpperSymmBandMatrix
Constructor for UpperSymmBandMatrix
UpperSymmBandMatrix(Matrix, int) - Constructor for class no.uib.cipr.matrix.UpperSymmBandMatrix
Constructor for UpperSymmBandMatrix
UpperSymmBandMatrix(Matrix, int, boolean) - Constructor for class no.uib.cipr.matrix.UpperSymmBandMatrix
Constructor for UpperSymmBandMatrix
UpperSymmDenseMatrix - Class in no.uib.cipr.matrix
Upper symmetrix dense matrix.
UpperSymmDenseMatrix(int) - Constructor for class no.uib.cipr.matrix.UpperSymmDenseMatrix
Constructor for UpperSymmDenseMatrix
UpperSymmDenseMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.UpperSymmDenseMatrix
Constructor for UpperSymmDenseMatrix
UpperSymmDenseMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.UpperSymmDenseMatrix
Constructor for UpperSymmDenseMatrix
UpperSymmPackMatrix - Class in no.uib.cipr.matrix
Upper symmetric packed matrix.
UpperSymmPackMatrix(int) - Constructor for class no.uib.cipr.matrix.UpperSymmPackMatrix
Constructor for UpperSymmPackMatrix
UpperSymmPackMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.UpperSymmPackMatrix
Constructor for UpperSymmPackMatrix
UpperSymmPackMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.UpperSymmPackMatrix
Constructor for UpperSymmPackMatrix
UpperTriangBandMatrix - Class in no.uib.cipr.matrix
Upper triangular banded matrix.
UpperTriangBandMatrix(int, int) - Constructor for class no.uib.cipr.matrix.UpperTriangBandMatrix
Constructor for UpperTriangBandMatrix
UpperTriangBandMatrix(Matrix, int) - Constructor for class no.uib.cipr.matrix.UpperTriangBandMatrix
Constructor for UpperTriangBandMatrix
UpperTriangBandMatrix(Matrix, int, boolean) - Constructor for class no.uib.cipr.matrix.UpperTriangBandMatrix
Constructor for UpperTriangBandMatrix
UpperTriangDenseMatrix - Class in no.uib.cipr.matrix
Upper triangular dense matrix.
UpperTriangDenseMatrix(int) - Constructor for class no.uib.cipr.matrix.UpperTriangDenseMatrix
Constructor for UpperTriangDenseMatrix
UpperTriangDenseMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.UpperTriangDenseMatrix
Constructor for UpperTriangDenseMatrix
UpperTriangDenseMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.UpperTriangDenseMatrix
Constructor for UpperTriangDenseMatrix
UpperTriangDenseMatrix(Matrix, int) - Constructor for class no.uib.cipr.matrix.UpperTriangDenseMatrix
Constructor for UpperTriangDenseMatrix
UpperTriangDenseMatrix(Matrix, int, boolean) - Constructor for class no.uib.cipr.matrix.UpperTriangDenseMatrix
Constructor for UpperTriangDenseMatrix
UpperTriangPackMatrix - Class in no.uib.cipr.matrix
Upper triangular packed matrix.
UpperTriangPackMatrix(int) - Constructor for class no.uib.cipr.matrix.UpperTriangPackMatrix
Constructor for UpperTriangPackMatrix
UpperTriangPackMatrix(Matrix) - Constructor for class no.uib.cipr.matrix.UpperTriangPackMatrix
Constructor for UpperTriangPackMatrix
UpperTriangPackMatrix(Matrix, boolean) - Constructor for class no.uib.cipr.matrix.UpperTriangPackMatrix
Constructor for UpperTriangPackMatrix

V

valueOf(String) - Static method in enum no.uib.cipr.matrix.io.MatrixInfo.MatrixField
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum no.uib.cipr.matrix.io.MatrixInfo.MatrixSymmetry
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum no.uib.cipr.matrix.io.VectorInfo.VectorField
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum no.uib.cipr.matrix.Matrix.Norm
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum no.uib.cipr.matrix.NotConvergedException.Reason
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum no.uib.cipr.matrix.sparse.ArpackSym.Ritz
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum no.uib.cipr.matrix.Vector.Norm
Returns the enum constant of this type with the specified name.
values() - Static method in enum no.uib.cipr.matrix.io.MatrixInfo.MatrixField
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum no.uib.cipr.matrix.io.MatrixInfo.MatrixSymmetry
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum no.uib.cipr.matrix.io.VectorInfo.VectorField
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum no.uib.cipr.matrix.Matrix.Norm
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum no.uib.cipr.matrix.NotConvergedException.Reason
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum no.uib.cipr.matrix.sparse.ArpackSym.Ritz
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum no.uib.cipr.matrix.Vector.Norm
Returns an array containing the constants of this enum type, in the order they are declared.
Vector - Interface in no.uib.cipr.matrix
Basic vector interface.
Vector.Norm - Enum in no.uib.cipr.matrix
Supported vector-norms.
VectorEntry - Interface in no.uib.cipr.matrix
An entry of a vector.
VectorInfo - Class in no.uib.cipr.matrix.io
Contains information on a vector in a variant of the Matrix Market exchange format
VectorInfo(boolean, VectorInfo.VectorField) - Constructor for class no.uib.cipr.matrix.io.VectorInfo
Creates a specific type
VectorInfo.VectorField - Enum in no.uib.cipr.matrix.io
What kind of numbers are stored
VectorSize - Class in no.uib.cipr.matrix.io
Contains the size of a vectir stored in a variant of the Matrix Market exchange format
VectorSize(int) - Constructor for class no.uib.cipr.matrix.io.VectorSize
Constructor for VectorSize.
VectorSize(int, int) - Constructor for class no.uib.cipr.matrix.io.VectorSize
Constructor for VectorSize

Z

zero() - Method in class no.uib.cipr.matrix.AbstractMatrix
 
zero() - Method in class no.uib.cipr.matrix.AbstractVector
 
zero() - Method in class no.uib.cipr.matrix.BandMatrix
 
zero() - Method in class no.uib.cipr.matrix.DenseVector
 
zero() - Method in interface no.uib.cipr.matrix.Matrix
Zeros all the entries in the matrix, while preserving any underlying structure.
zero() - Method in class no.uib.cipr.matrix.sparse.CompColMatrix
 
zero() - Method in class no.uib.cipr.matrix.sparse.CompDiagMatrix
 
zero() - Method in class no.uib.cipr.matrix.sparse.CompRowMatrix
 
zero() - Method in class no.uib.cipr.matrix.sparse.FlexCompColMatrix
 
zero() - Method in class no.uib.cipr.matrix.sparse.FlexCompRowMatrix
 
zero() - Method in class no.uib.cipr.matrix.sparse.LinkedSparseMatrix
 
zero() - Method in class no.uib.cipr.matrix.sparse.SparseVector
 
zero() - Method in class no.uib.cipr.matrix.SymmTridiagMatrix
 
zero() - Method in class no.uib.cipr.matrix.TridiagMatrix
 
zero() - Method in class no.uib.cipr.matrix.UnitLowerTriangBandMatrix
 
zero() - Method in class no.uib.cipr.matrix.UnitLowerTriangDenseMatrix
 
zero() - Method in class no.uib.cipr.matrix.UnitUpperTriangBandMatrix
 
zero() - Method in class no.uib.cipr.matrix.UnitUpperTriangDenseMatrix
 
zero() - Method in interface no.uib.cipr.matrix.Vector
Zeros all the entries in the vector, while preserving any underlying structure
zeroColumns(Matrix, double, int...) - Static method in class no.uib.cipr.matrix.Matrices
Sets the selected columns of A equal zero, and puts diagonal on the diagonal of those columns.
zeroRows(Matrix, double, int...) - Static method in class no.uib.cipr.matrix.Matrices
Sets the selected rows of A equal zero, and puts diagonal on the diagonal of those rows.
A B C D E F G H I L M N O P Q R S T U V Z 

Copyright © 2013. All Rights Reserved.