|
enum | { ColsAtCompileTime = MatrixType::ColsAtCompileTime
, MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime
} |
|
typedef _MatrixType | MatrixType |
|
typedef _OrderingType | OrderingType |
|
typedef MatrixType::Scalar | Scalar |
|
typedef MatrixType::RealScalar | RealScalar |
|
typedef MatrixType::StorageIndex | StorageIndex |
|
typedef SparseMatrix< Scalar, ColMajor, StorageIndex > | NCMatrix |
|
typedef internal::MappedSuperNodalMatrix< Scalar, StorageIndex > | SCMatrix |
|
typedef Matrix< Scalar, Dynamic, 1 > | ScalarVector |
|
typedef Matrix< StorageIndex, Dynamic, 1 > | IndexVector |
|
typedef PermutationMatrix< Dynamic, Dynamic, StorageIndex > | PermutationType |
|
typedef internal::SparseLUImpl< Scalar, StorageIndex > | Base |
|
typedef Matrix< _MatrixType::Scalar, Dynamic, 1 > | ScalarVector |
|
typedef Matrix< _MatrixType::StorageIndex, Dynamic, 1 > | IndexVector |
|
typedef Matrix< _MatrixType::Scalar, Dynamic, Dynamic, ColMajor > | ScalarMatrix |
|
typedef Map< ScalarMatrix, 0, OuterStride<> > | MappedMatrixBlock |
|
typedef ScalarVector::RealScalar | RealScalar |
|
typedef Ref< Matrix< _MatrixType::Scalar, Dynamic, 1 > > | BlockScalarVector |
|
typedef Ref< Matrix< _MatrixType::StorageIndex, Dynamic, 1 > > | BlockIndexVector |
|
typedef LU_GlobalLU_t< IndexVector, ScalarVector > | GlobalLU_t |
|
typedef SparseMatrix< _MatrixType::Scalar, ColMajor, _MatrixType::StorageIndex > | MatrixType |
|
|
| SparseLU () |
|
| SparseLU (const MatrixType &matrix) |
|
| ~SparseLU () |
|
void | analyzePattern (const MatrixType &matrix) |
| Compute the column permutation to minimize the fill-in. More...
|
|
void | factorize (const MatrixType &matrix) |
|
void | simplicialfactorize (const MatrixType &matrix) |
|
void | compute (const MatrixType &matrix) |
| Compute the symbolic and numeric factorization of the input sparse matrix. More...
|
|
const SparseLUTransposeView< false, SparseLU< _MatrixType, _OrderingType > > | transpose () |
|
const SparseLUTransposeView< true, SparseLU< _MatrixType, _OrderingType > > | adjoint () |
|
Index | rows () const |
|
Index | cols () const |
|
void | isSymmetric (bool sym) |
| Indicate that the pattern of the input matrix is symmetric. More...
|
|
SparseLUMatrixLReturnType< SCMatrix > | matrixL () const |
|
SparseLUMatrixUReturnType< SCMatrix, MappedSparseMatrix< Scalar, ColMajor, StorageIndex > > | matrixU () const |
|
const PermutationType & | rowsPermutation () const |
|
const PermutationType & | colsPermutation () const |
|
void | setPivotThreshold (const RealScalar &thresh) |
| Set the threshold used for a diagonal entry to be an acceptable pivot. More...
|
|
ComputationInfo | info () const |
| Reports whether previous computation was successful. More...
|
|
std::string | lastErrorMessage () const |
|
template<typename Rhs , typename Dest > |
bool | _solve_impl (const MatrixBase< Rhs > &B, MatrixBase< Dest > &X_base) const |
|
Scalar | absDeterminant () |
|
Scalar | logAbsDeterminant () const |
|
Scalar | signDeterminant () |
|
Scalar | determinant () |
|
Index | nnzL () const |
|
Index | nnzU () const |
|
| SparseSolverBase () |
| Default constructor. More...
|
|
| ~SparseSolverBase () |
|
SparseLU< _MatrixType, _OrderingType > & | derived () |
|
const SparseLU< _MatrixType, _OrderingType > & | derived () const |
|
const Solve< SparseLU< _MatrixType, _OrderingType >, Rhs > | solve (const MatrixBase< Rhs > &b) const |
|
const Solve< SparseLU< _MatrixType, _OrderingType >, Rhs > | solve (const SparseMatrixBase< Rhs > &b) const |
|
void | _solve_impl (const SparseMatrixBase< Rhs > &b, SparseMatrixBase< Dest > &dest) const |
|
|
void | initperfvalues () |
|
Index | expand (VectorType &vec, Index &length, Index nbElts, Index keep_prev, Index &num_expansions) |
| Expand the existing storage to accommodate more fill-ins. More...
|
|
Index | memInit (Index m, Index n, Index annz, Index lwork, Index fillratio, Index panel_size, GlobalLU_t &glu) |
| Allocate various working space for the numerical factorization phase. More...
|
|
Index | memXpand (VectorType &vec, Index &maxlen, Index nbElts, MemType memtype, Index &num_expansions) |
| Expand the existing storage. More...
|
|
void | heap_relax_snode (const Index n, IndexVector &et, const Index relax_columns, IndexVector &descendants, IndexVector &relax_end) |
| Identify the initial relaxed supernodes. More...
|
|
void | relax_snode (const Index n, IndexVector &et, const Index relax_columns, IndexVector &descendants, IndexVector &relax_end) |
| Identify the initial relaxed supernodes. More...
|
|
Index | snode_dfs (const Index jcol, const Index kcol, const MatrixType &mat, IndexVector &xprune, IndexVector &marker, GlobalLU_t &glu) |
|
Index | snode_bmod (const Index jcol, const Index fsupc, ScalarVector &dense, GlobalLU_t &glu) |
|
Index | pivotL (const Index jcol, const RealScalar &diagpivotthresh, IndexVector &perm_r, IndexVector &iperm_c, Index &pivrow, GlobalLU_t &glu) |
| Performs the numerical pivotin on the current column of L, and the CDIV operation. More...
|
|
void | dfs_kernel (const _MatrixType::StorageIndex jj, IndexVector &perm_r, Index &nseg, IndexVector &panel_lsub, IndexVector &segrep, Ref< IndexVector > repfnz_col, IndexVector &xprune, Ref< IndexVector > marker, IndexVector &parent, IndexVector &xplore, GlobalLU_t &glu, Index &nextl_col, Index krow, Traits &traits) |
|
void | panel_dfs (const Index m, const Index w, const Index jcol, MatrixType &A, IndexVector &perm_r, Index &nseg, ScalarVector &dense, IndexVector &panel_lsub, IndexVector &segrep, IndexVector &repfnz, IndexVector &xprune, IndexVector &marker, IndexVector &parent, IndexVector &xplore, GlobalLU_t &glu) |
| Performs a symbolic factorization on a panel of columns [jcol, jcol+w) More...
|
|
void | panel_bmod (const Index m, const Index w, const Index jcol, const Index nseg, ScalarVector &dense, ScalarVector &tempv, IndexVector &segrep, IndexVector &repfnz, GlobalLU_t &glu) |
| Performs numeric block updates (sup-panel) in topological order. More...
|
|
Index | column_dfs (const Index m, const Index jcol, IndexVector &perm_r, Index maxsuper, Index &nseg, BlockIndexVector lsub_col, IndexVector &segrep, BlockIndexVector repfnz, IndexVector &xprune, IndexVector &marker, IndexVector &parent, IndexVector &xplore, GlobalLU_t &glu) |
| Performs a symbolic factorization on column jcol and decide the supernode boundary. More...
|
|
Index | column_bmod (const Index jcol, const Index nseg, BlockScalarVector dense, ScalarVector &tempv, BlockIndexVector segrep, BlockIndexVector repfnz, Index fpanelc, GlobalLU_t &glu) |
| Performs numeric block updates (sup-col) in topological order. More...
|
|
Index | copy_to_ucol (const Index jcol, const Index nseg, IndexVector &segrep, BlockIndexVector repfnz, IndexVector &perm_r, BlockScalarVector dense, GlobalLU_t &glu) |
| Performs numeric block updates (sup-col) in topological order. More...
|
|
void | pruneL (const Index jcol, const IndexVector &perm_r, const Index pivrow, const Index nseg, const IndexVector &segrep, BlockIndexVector repfnz, IndexVector &xprune, GlobalLU_t &glu) |
| Prunes the L-structure. More...
|
|
void | countnz (const Index n, Index &nnzL, Index &nnzU, GlobalLU_t &glu) |
| Count Nonzero elements in the factors. More...
|
|
void | fixupL (const Index n, const IndexVector &perm_r, GlobalLU_t &glu) |
| Fix up the data storage lsub for L-subscripts. More...
|
|
template<typename _MatrixType, typename _OrderingType>
class Eigen::SparseLU< _MatrixType, _OrderingType >
Sparse supernodal LU factorization for general matrices.
This class implements the supernodal LU factorization for general matrices. It uses the main techniques from the sequential SuperLU package (http://crd-legacy.lbl.gov/~xiaoye/SuperLU/). It handles transparently real and complex arithmetic with single and double precision, depending on the scalar type of your input matrix. The code has been optimized to provide BLAS-3 operations during supernode-panel updates. It benefits directly from the built-in high-performant Eigen BLAS routines. Moreover, when the size of a supernode is very small, the BLAS calls are avoided to enable a better optimization from the compiler. For best performance, you should compile it with NDEBUG flag to avoid the numerous bounds checking on vectors.
An important parameter of this class is the ordering method. It is used to reorder the columns (and eventually the rows) of the matrix to reduce the number of new elements that are created during numerical factorization. The cheapest method available is COLAMD. See the OrderingMethods module for the list of built-in and external ordering methods.
Simple example with key steps
Definition: Ordering.h:115
Sparse supernodal LU factorization for general matrices.
Definition: SparseLU.h:132
void factorize(const MatrixType &matrix)
Definition: SparseLU.h:595
void analyzePattern(const MatrixType &matrix)
Compute the column permutation to minimize the fill-in.
Definition: SparseLU.h:510
A versatible sparse matrix representation.
Definition: SparseMatrix.h:98
const Solve< Derived, Rhs > solve(const MatrixBase< Rhs > &b) const
Definition: SparseSolverBase.h:88
- Warning
- The input matrix A should be in a compressed and column-major form. Otherwise an expensive copy will be made. You can call the inexpensive makeCompressed() to get a compressed matrix.
- Note
- Unlike the initial SuperLU implementation, there is no step to equilibrate the matrix. For badly scaled matrices, this step can be useful to reduce the pivoting during factorization. If this is the case for your matrices, you can try the basic scaling method at "unsupported/Eigen/src/IterativeSolvers/Scaling.h"
- Template Parameters
-
_MatrixType | The type of the sparse matrix. It must be a column-major SparseMatrix<> |
_OrderingType | The ordering method to use, either AMD, COLAMD or METIS. Default is COLMAD |
\implsparsesolverconcept
- See also
- TutorialSparseSolverConcept
-
OrderingMethods module