Eigen::SuperLUBase< MatrixType_, Derived > Class Template Reference

The base class for the direct and incomplete LU factorization of SuperLU. More...

#include <SuperLUSupport.h>

+ Inheritance diagram for Eigen::SuperLUBase< MatrixType_, Derived >:

Public Types

enum  { ColsAtCompileTime = MatrixType::ColsAtCompileTime , MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime }
 
typedef MatrixType_ MatrixType
 
typedef MatrixType::Scalar Scalar
 
typedef MatrixType::RealScalar RealScalar
 
typedef MatrixType::StorageIndex StorageIndex
 
typedef Matrix< Scalar, Dynamic, 1 > Vector
 
typedef Matrix< int, 1, MatrixType::ColsAtCompileTime > IntRowVectorType
 
typedef Matrix< int, MatrixType::RowsAtCompileTime, 1 > IntColVectorType
 
typedef Map< PermutationMatrix< Dynamic, Dynamic, int > > PermutationMap
 
typedef SparseMatrix< ScalarLUMatrixType
 

Public Member Functions

 SuperLUBase ()
 
 ~SuperLUBase ()
 
Index rows () const
 
Index cols () const
 
superlu_options_toptions ()
 
ComputationInfo info () const
 Reports whether previous computation was successful. More...
 
void compute (const MatrixType &matrix)
 
void analyzePattern (const MatrixType &)
 
template<typename Stream >
void dumpMemory (Stream &)
 
- Public Member Functions inherited from Eigen::SparseSolverBase< Derived >
 SparseSolverBase ()
 
 SparseSolverBase (SparseSolverBase &&other)
 
 ~SparseSolverBase ()
 
Derived & derived ()
 
const Derived & derived () const
 
template<typename Rhs >
const Solve< Derived, Rhs > solve (const MatrixBase< Rhs > &b) const
 
template<typename Rhs >
const Solve< Derived, Rhs > solve (const SparseMatrixBase< Rhs > &b) const
 
template<typename Rhs , typename Dest >
void _solve_impl (const SparseMatrixBase< Rhs > &b, SparseMatrixBase< Dest > &dest) const
 

Protected Types

typedef SparseSolverBase< Derived > Base
 

Protected Member Functions

void initFactorization (const MatrixType &a)
 
void init ()
 
void extractData () const
 
void clearFactors ()
 
Derived & derived ()
 
const Derived & derived () const
 

Protected Attributes

LUMatrixType m_l
 
LUMatrixType m_u
 
IntColVectorType m_p
 
IntRowVectorType m_q
 
LUMatrixType m_matrix
 
SluMatrix m_sluA
 
SuperMatrix m_sluL
 
SuperMatrix m_sluU
 
SluMatrix m_sluB
 
SluMatrix m_sluX
 
SuperLUStat_t m_sluStat
 
superlu_options_t m_sluOptions
 
std::vector< intm_sluEtree
 
Matrix< RealScalar, Dynamic, 1 > m_sluRscale
 
Matrix< RealScalar, Dynamic, 1 > m_sluCscale
 
Matrix< RealScalar, Dynamic, 1 > m_sluFerr
 
Matrix< RealScalar, Dynamic, 1 > m_sluBerr
 
char m_sluEqued
 
ComputationInfo m_info
 
int m_factorizationIsOk
 
int m_analysisIsOk
 
bool m_extractedDataAreDirty
 
bool m_isInitialized
 
- Protected Attributes inherited from Eigen::SparseSolverBase< Derived >
bool m_isInitialized
 

Private Member Functions

 SuperLUBase (SuperLUBase &)
 

Detailed Description

template<typename MatrixType_, typename Derived>
class Eigen::SuperLUBase< MatrixType_, Derived >

The base class for the direct and incomplete LU factorization of SuperLU.

Member Typedef Documentation

◆ Base

template<typename MatrixType_ , typename Derived >
typedef SparseSolverBase<Derived> Eigen::SuperLUBase< MatrixType_, Derived >::Base
protected

◆ IntColVectorType

template<typename MatrixType_ , typename Derived >
typedef Matrix<int, MatrixType::RowsAtCompileTime, 1> Eigen::SuperLUBase< MatrixType_, Derived >::IntColVectorType

◆ IntRowVectorType

template<typename MatrixType_ , typename Derived >
typedef Matrix<int, 1, MatrixType::ColsAtCompileTime> Eigen::SuperLUBase< MatrixType_, Derived >::IntRowVectorType

◆ LUMatrixType

template<typename MatrixType_ , typename Derived >
typedef SparseMatrix<Scalar> Eigen::SuperLUBase< MatrixType_, Derived >::LUMatrixType

◆ MatrixType

template<typename MatrixType_ , typename Derived >
typedef MatrixType_ Eigen::SuperLUBase< MatrixType_, Derived >::MatrixType

◆ PermutationMap

template<typename MatrixType_ , typename Derived >
typedef Map<PermutationMatrix<Dynamic, Dynamic, int> > Eigen::SuperLUBase< MatrixType_, Derived >::PermutationMap

◆ RealScalar

template<typename MatrixType_ , typename Derived >
typedef MatrixType::RealScalar Eigen::SuperLUBase< MatrixType_, Derived >::RealScalar

◆ Scalar

template<typename MatrixType_ , typename Derived >
typedef MatrixType::Scalar Eigen::SuperLUBase< MatrixType_, Derived >::Scalar

◆ StorageIndex

template<typename MatrixType_ , typename Derived >
typedef MatrixType::StorageIndex Eigen::SuperLUBase< MatrixType_, Derived >::StorageIndex

◆ Vector

template<typename MatrixType_ , typename Derived >
typedef Matrix<Scalar, Dynamic, 1> Eigen::SuperLUBase< MatrixType_, Derived >::Vector

Member Enumeration Documentation

◆ anonymous enum

template<typename MatrixType_ , typename Derived >
anonymous enum
Enumerator
ColsAtCompileTime 
MaxColsAtCompileTime 
294 { ColsAtCompileTime = MatrixType::ColsAtCompileTime, MaxColsAtCompileTime = MatrixType::MaxColsAtCompileTime };
@ ColsAtCompileTime
Definition: SuperLUSupport.h:294
@ MaxColsAtCompileTime
Definition: SuperLUSupport.h:294

Constructor & Destructor Documentation

◆ SuperLUBase() [1/2]

template<typename MatrixType_ , typename Derived >
Eigen::SuperLUBase< MatrixType_, Derived >::SuperLUBase ( )
inline
297 {}

◆ ~SuperLUBase()

template<typename MatrixType_ , typename Derived >
Eigen::SuperLUBase< MatrixType_, Derived >::~SuperLUBase ( )
inline
299 { clearFactors(); }
void clearFactors()
Definition: SuperLUSupport.h:377

References Eigen::SuperLUBase< MatrixType_, Derived >::clearFactors().

◆ SuperLUBase() [2/2]

template<typename MatrixType_ , typename Derived >
Eigen::SuperLUBase< MatrixType_, Derived >::SuperLUBase ( SuperLUBase< MatrixType_, Derived > &  )
inlineprivate
411 {}

Member Function Documentation

◆ analyzePattern()

template<typename MatrixType_ , typename Derived >
void Eigen::SuperLUBase< MatrixType_, Derived >::analyzePattern ( const MatrixType )
inline

Performs a symbolic decomposition on the sparcity of matrix.

This function is particularly useful when solving for several problems having the same structure.

See also
factorize()
329  {
330  m_isInitialized = true;
331  m_info = Success;
332  m_analysisIsOk = true;
333  m_factorizationIsOk = false;
334  }
int m_analysisIsOk
Definition: SuperLUSupport.h:407
int m_factorizationIsOk
Definition: SuperLUSupport.h:406
bool m_isInitialized
Definition: SparseSolverBase.h:110
ComputationInfo m_info
Definition: SuperLUSupport.h:405
@ Success
Definition: Constants.h:440

References Eigen::SuperLUBase< MatrixType_, Derived >::m_analysisIsOk, Eigen::SuperLUBase< MatrixType_, Derived >::m_factorizationIsOk, Eigen::SuperLUBase< MatrixType_, Derived >::m_info, Eigen::SuperLUBase< MatrixType_, Derived >::m_isInitialized, and Eigen::Success.

Referenced by Eigen::SuperLU< MatrixType_ >::analyzePattern().

◆ clearFactors()

template<typename MatrixType_ , typename Derived >
void Eigen::SuperLUBase< MatrixType_, Derived >::clearFactors ( )
inlineprotected
377  {
380 
381  m_sluL.Store = 0;
382  m_sluU.Store = 0;
383 
384  memset(&m_sluL, 0, sizeof m_sluL);
385  memset(&m_sluU, 0, sizeof m_sluU);
386  }
SuperMatrix m_sluL
Definition: SuperLUSupport.h:396
SuperMatrix m_sluU
Definition: SuperLUSupport.h:396
void Destroy_CompCol_Matrix(SuperMatrix *)
void Destroy_SuperNode_Matrix(SuperMatrix *)
void * Store
Definition: oomph_superlu_4.3/supermatrix.h:51

References Destroy_CompCol_Matrix(), Destroy_SuperNode_Matrix(), Eigen::SuperLUBase< MatrixType_, Derived >::m_sluL, Eigen::SuperLUBase< MatrixType_, Derived >::m_sluU, and SuperMatrix::Store.

Referenced by Eigen::SuperLUBase< MatrixType_, Derived >::initFactorization(), and Eigen::SuperLUBase< MatrixType_, Derived >::~SuperLUBase().

◆ cols()

◆ compute()

template<typename MatrixType_ , typename Derived >
void Eigen::SuperLUBase< MatrixType_, Derived >::compute ( const MatrixType matrix)
inline

Computes the sparse Cholesky decomposition of matrix

318  {
319  derived().analyzePattern(matrix);
320  derived().factorize(matrix);
321  }
Derived & derived()
Definition: SparseSolverBase.h:76
Eigen::Map< Eigen::Matrix< T, Eigen::Dynamic, Eigen::Dynamic, Eigen::ColMajor >, 0, Eigen::OuterStride<> > matrix(T *data, int rows, int cols, int stride)
Definition: common.h:85

References Eigen::SuperLUBase< MatrixType_, Derived >::derived(), and matrix().

Referenced by Eigen::SuperLU< MatrixType_ >::SuperLU().

◆ derived() [1/2]

template<typename MatrixType_ , typename Derived >
Derived& Eigen::SparseSolverBase< Derived >::derived
inlineprotected
76 { return *static_cast<Derived*>(this); }

Referenced by Eigen::SuperLUBase< MatrixType_, Derived >::compute().

◆ derived() [2/2]

template<typename MatrixType_ , typename Derived >
const Derived& Eigen::SparseSolverBase< Derived >::derived
inlineprotected
77 { return *static_cast<const Derived*>(this); }

◆ dumpMemory()

template<typename MatrixType_ , typename Derived >
template<typename Stream >
void Eigen::SuperLUBase< MatrixType_, Derived >::dumpMemory ( Stream )
inline
337 {}

◆ extractData()

template<typename MatrixType , typename Derived >
void Eigen::SuperLUBase< MatrixType, Derived >::extractData
protected
621  {
623  "The decomposition is not in a valid state for extracting factors, you must first call either compute() "
624  "or analyzePattern()/factorize()");
626  int upper;
627  int fsupc, istart, nsupr;
628  int lastl = 0, lastu = 0;
629  SCformat *Lstore = static_cast<SCformat *>(m_sluL.Store);
630  NCformat *Ustore = static_cast<NCformat *>(m_sluU.Store);
631  Scalar *SNptr;
632 
633  const Index size = m_matrix.rows();
634  m_l.resize(size, size);
635  m_l.resizeNonZeros(Lstore->nnz);
636  m_u.resize(size, size);
637  m_u.resizeNonZeros(Ustore->nnz);
638 
639  int *Lcol = m_l.outerIndexPtr();
640  int *Lrow = m_l.innerIndexPtr();
641  Scalar *Lval = m_l.valuePtr();
642 
643  int *Ucol = m_u.outerIndexPtr();
644  int *Urow = m_u.innerIndexPtr();
645  Scalar *Uval = m_u.valuePtr();
646 
647  Ucol[0] = 0;
648  Ucol[0] = 0;
649 
650  /* for each supernode */
651  for (int k = 0; k <= Lstore->nsuper; ++k) {
652  fsupc = L_FST_SUPC(k);
653  istart = L_SUB_START(fsupc);
654  nsupr = L_SUB_START(fsupc + 1) - istart;
655  upper = 1;
656 
657  /* for each column in the supernode */
658  for (int j = fsupc; j < L_FST_SUPC(k + 1); ++j) {
659  SNptr = &((Scalar *)Lstore->nzval)[L_NZ_START(j)];
660 
661  /* Extract U */
662  for (int i = U_NZ_START(j); i < U_NZ_START(j + 1); ++i) {
663  Uval[lastu] = ((Scalar *)Ustore->nzval)[i];
664  /* Matlab doesn't like explicit zero. */
665  if (Uval[lastu] != 0.0) Urow[lastu++] = U_SUB(i);
666  }
667  for (int i = 0; i < upper; ++i) {
668  /* upper triangle in the supernode */
669  Uval[lastu] = SNptr[i];
670  /* Matlab doesn't like explicit zero. */
671  if (Uval[lastu] != 0.0) Urow[lastu++] = L_SUB(istart + i);
672  }
673  Ucol[j + 1] = lastu;
674 
675  /* Extract L */
676  Lval[lastl] = 1.0; /* unit diagonal */
677  Lrow[lastl++] = L_SUB(istart + upper - 1);
678  for (int i = upper; i < nsupr; ++i) {
679  Lval[lastl] = SNptr[i];
680  /* Matlab doesn't like explicit zero. */
681  if (Lval[lastl] != 0.0) Lrow[lastl++] = L_SUB(istart + i);
682  }
683  Lcol[j + 1] = lastl;
684 
685  ++upper;
686  } /* for j ... */
687 
688  } /* for k ... */
689 
690  // squeeze the matrices :
691  m_l.resizeNonZeros(lastl);
692  m_u.resizeNonZeros(lastu);
693 
694  m_extractedDataAreDirty = false;
695  }
696 }
int i
Definition: BiCGSTAB_step_by_step.cpp:9
#define eigen_assert(x)
Definition: Macros.h:910
Scalar Scalar int size
Definition: benchVecAdd.cpp:17
SCALAR Scalar
Definition: bench_gemm.cpp:45
const Scalar * valuePtr() const
Definition: SparseMatrix.h:171
void resize(Index rows, Index cols)
Definition: SparseMatrix.h:734
Index rows() const
Definition: SparseMatrix.h:159
void resizeNonZeros(Index size)
Definition: SparseMatrix.h:754
const StorageIndex * outerIndexPtr() const
Definition: SparseMatrix.h:189
const StorageIndex * innerIndexPtr() const
Definition: SparseMatrix.h:180
bool m_extractedDataAreDirty
Definition: SuperLUSupport.h:408
LUMatrixType m_l
Definition: SuperLUSupport.h:389
LUMatrixType m_u
Definition: SuperLUSupport.h:390
char char char int int * k
Definition: level2_impl.h:374
EIGEN_DEFAULT_DENSE_INDEX_TYPE Index
The Index type as used for the API.
Definition: Meta.h:83
#define L_FST_SUPC(superno)
Definition: slu_util.h:76
#define L_SUB_START(col)
Definition: slu_util.h:73
#define L_NZ_START(col)
Definition: slu_util.h:75
#define L_SUB(ptr)
Definition: slu_util.h:74
#define U_NZ_START(col)
Definition: slu_util.h:77
#define U_SUB(ptr)
Definition: slu_util.h:78
Definition: oomph_superlu_4.3/supermatrix.h:59
void * nzval
Definition: oomph_superlu_4.3/supermatrix.h:61
int_t nnz
Definition: oomph_superlu_4.3/supermatrix.h:60
Definition: oomph_superlu_4.3/supermatrix.h:85
int_t nnz
Definition: oomph_superlu_4.3/supermatrix.h:86
void * nzval
Definition: oomph_superlu_4.3/supermatrix.h:88
int_t nsuper
Definition: oomph_superlu_4.3/supermatrix.h:87
std::ptrdiff_t j
Definition: tut_arithmetic_redux_minmax.cpp:2

References eigen_assert, i, j, k, L_FST_SUPC, L_NZ_START, L_SUB, L_SUB_START, NCformat::nnz, SCformat::nnz, SCformat::nsuper, NCformat::nzval, SCformat::nzval, size, U_NZ_START, and U_SUB.

◆ info()

template<typename MatrixType_ , typename Derived >
ComputationInfo Eigen::SuperLUBase< MatrixType_, Derived >::info ( ) const
inline

Reports whether previous computation was successful.

Returns
Success if computation was successful, NumericalIssue if the matrix.appears to be negative.
312  {
313  eigen_assert(m_isInitialized && "Decomposition is not initialized.");
314  return m_info;
315  }

References eigen_assert, Eigen::SuperLUBase< MatrixType_, Derived >::m_info, and Eigen::SuperLUBase< MatrixType_, Derived >::m_isInitialized.

◆ init()

template<typename MatrixType_ , typename Derived >
void Eigen::SuperLUBase< MatrixType_, Derived >::init ( )
inlineprotected

◆ initFactorization()

template<typename MatrixType_ , typename Derived >
void Eigen::SuperLUBase< MatrixType_, Derived >::initFactorization ( const MatrixType a)
inlineprotected
340  {
342 
343  const Index size = a.rows();
344  m_matrix = a;
345 
347  clearFactors();
348 
349  m_p.resize(size);
350  m_q.resize(size);
353  m_sluEtree.resize(size);
354 
355  // set empty B and X
358  m_sluB.Mtype = SLU_GE;
359  m_sluB.storage.values = 0;
360  m_sluB.nrow = 0;
361  m_sluB.ncol = 0;
362  m_sluB.storage.lda = internal::convert_index<int>(size);
363  m_sluX = m_sluB;
364 
366  }
EIGEN_DEVICE_FUNC constexpr EIGEN_STRONG_INLINE void resize(Index rows, Index cols)
Definition: PlainObjectBase.h:294
Matrix< RealScalar, Dynamic, 1 > m_sluRscale
Definition: SuperLUSupport.h:401
std::vector< int > m_sluEtree
Definition: SuperLUSupport.h:400
SluMatrix m_sluB
Definition: SuperLUSupport.h:397
IntRowVectorType m_q
Definition: SuperLUSupport.h:392
SluMatrix m_sluX
Definition: SuperLUSupport.h:397
Matrix< RealScalar, Dynamic, 1 > m_sluCscale
Definition: SuperLUSupport.h:401
IntColVectorType m_p
Definition: SuperLUSupport.h:391
superlu_options_t m_sluOptions
Definition: SuperLUSupport.h:399
SluMatrix m_sluA
Definition: SuperLUSupport.h:395
const Scalar * a
Definition: level2_cplx_impl.h:32
SluMatrix asSluMatrix(MatrixType &mat)
Definition: SuperLUSupport.h:254
@ SLU_GE
Definition: oomph_superlu_4.3/supermatrix.h:32
@ SLU_DN
Definition: oomph_superlu_4.3/supermatrix.h:20
void set_default_options(superlu_options_t *options)
void * values
Definition: SuperLUSupport.h:121
void setScalarType()
Definition: SuperLUSupport.h:137
struct Eigen::SluMatrix::@890 storage
int lda
Definition: SuperLUSupport.h:119
void setStorageType(Stype_t t)
Definition: SuperLUSupport.h:126
Mtype_t Mtype
Definition: oomph_superlu_4.3/supermatrix.h:47
int_t nrow
Definition: oomph_superlu_4.3/supermatrix.h:49
int_t ncol
Definition: oomph_superlu_4.3/supermatrix.h:50

References a, Eigen::internal::asSluMatrix(), Eigen::SuperLUBase< MatrixType_, Derived >::clearFactors(), Eigen::SluMatrix::lda, Eigen::SuperLUBase< MatrixType_, Derived >::m_extractedDataAreDirty, Eigen::SuperLUBase< MatrixType_, Derived >::m_matrix, Eigen::SuperLUBase< MatrixType_, Derived >::m_p, Eigen::SuperLUBase< MatrixType_, Derived >::m_q, Eigen::SuperLUBase< MatrixType_, Derived >::m_sluA, Eigen::SuperLUBase< MatrixType_, Derived >::m_sluB, Eigen::SuperLUBase< MatrixType_, Derived >::m_sluCscale, Eigen::SuperLUBase< MatrixType_, Derived >::m_sluEtree, Eigen::SuperLUBase< MatrixType_, Derived >::m_sluOptions, Eigen::SuperLUBase< MatrixType_, Derived >::m_sluRscale, Eigen::SuperLUBase< MatrixType_, Derived >::m_sluX, SuperMatrix::Mtype, SuperMatrix::ncol, SuperMatrix::nrow, Eigen::PlainObjectBase< Derived >::resize(), set_default_options(), Eigen::SluMatrix::setScalarType(), Eigen::SluMatrix::setStorageType(), size, SLU_DN, SLU_GE, Eigen::SluMatrix::storage, and Eigen::SluMatrix::values.

◆ options()

template<typename MatrixType_ , typename Derived >
superlu_options_t& Eigen::SuperLUBase< MatrixType_, Derived >::options ( )
inline
Returns
a reference to the Super LU option object to configure the Super LU algorithms.
305 { return m_sluOptions; }

References Eigen::SuperLUBase< MatrixType_, Derived >::m_sluOptions.

◆ rows()

Member Data Documentation

◆ m_analysisIsOk

template<typename MatrixType_ , typename Derived >
int Eigen::SuperLUBase< MatrixType_, Derived >::m_analysisIsOk
protected

◆ m_extractedDataAreDirty

template<typename MatrixType_ , typename Derived >
bool Eigen::SuperLUBase< MatrixType_, Derived >::m_extractedDataAreDirty
mutableprotected

◆ m_factorizationIsOk

template<typename MatrixType_ , typename Derived >
int Eigen::SuperLUBase< MatrixType_, Derived >::m_factorizationIsOk
protected

◆ m_info

◆ m_isInitialized

◆ m_l

template<typename MatrixType_ , typename Derived >
LUMatrixType Eigen::SuperLUBase< MatrixType_, Derived >::m_l
mutableprotected

◆ m_matrix

template<typename MatrixType_ , typename Derived >
LUMatrixType Eigen::SuperLUBase< MatrixType_, Derived >::m_matrix
mutableprotected

◆ m_p

template<typename MatrixType_ , typename Derived >
IntColVectorType Eigen::SuperLUBase< MatrixType_, Derived >::m_p
mutableprotected

◆ m_q

template<typename MatrixType_ , typename Derived >
IntRowVectorType Eigen::SuperLUBase< MatrixType_, Derived >::m_q
mutableprotected

◆ m_sluA

template<typename MatrixType_ , typename Derived >
SluMatrix Eigen::SuperLUBase< MatrixType_, Derived >::m_sluA
mutableprotected

◆ m_sluB

template<typename MatrixType_ , typename Derived >
SluMatrix Eigen::SuperLUBase< MatrixType_, Derived >::m_sluB
mutableprotected

◆ m_sluBerr

template<typename MatrixType_ , typename Derived >
Matrix<RealScalar, Dynamic, 1> Eigen::SuperLUBase< MatrixType_, Derived >::m_sluBerr
protected

◆ m_sluCscale

template<typename MatrixType_ , typename Derived >
Matrix<RealScalar, Dynamic, 1> Eigen::SuperLUBase< MatrixType_, Derived >::m_sluCscale
protected

◆ m_sluEqued

template<typename MatrixType_ , typename Derived >
char Eigen::SuperLUBase< MatrixType_, Derived >::m_sluEqued
mutableprotected

◆ m_sluEtree

template<typename MatrixType_ , typename Derived >
std::vector<int> Eigen::SuperLUBase< MatrixType_, Derived >::m_sluEtree
mutableprotected

◆ m_sluFerr

template<typename MatrixType_ , typename Derived >
Matrix<RealScalar, Dynamic, 1> Eigen::SuperLUBase< MatrixType_, Derived >::m_sluFerr
mutableprotected

◆ m_sluL

template<typename MatrixType_ , typename Derived >
SuperMatrix Eigen::SuperLUBase< MatrixType_, Derived >::m_sluL
mutableprotected

◆ m_sluOptions

template<typename MatrixType_ , typename Derived >
superlu_options_t Eigen::SuperLUBase< MatrixType_, Derived >::m_sluOptions
mutableprotected

◆ m_sluRscale

template<typename MatrixType_ , typename Derived >
Matrix<RealScalar, Dynamic, 1> Eigen::SuperLUBase< MatrixType_, Derived >::m_sluRscale
mutableprotected

◆ m_sluStat

template<typename MatrixType_ , typename Derived >
SuperLUStat_t Eigen::SuperLUBase< MatrixType_, Derived >::m_sluStat
mutableprotected

◆ m_sluU

template<typename MatrixType_ , typename Derived >
SuperMatrix Eigen::SuperLUBase< MatrixType_, Derived >::m_sluU
protected

◆ m_sluX

template<typename MatrixType_ , typename Derived >
SluMatrix Eigen::SuperLUBase< MatrixType_, Derived >::m_sluX
protected

◆ m_u

template<typename MatrixType_ , typename Derived >
LUMatrixType Eigen::SuperLUBase< MatrixType_, Derived >::m_u
mutableprotected

The documentation for this class was generated from the following file: