42 #ifndef DIRECT_SPARSE_SOLVER_DENSE_H
43 #define DIRECT_SPARSE_SOLVER_DENSE_H
54 namespace AbstractLinAlgPack {
99 ,
const Vector& v_rhs2)
const ;
168 #endif // DIRECT_SPARSE_SOLVER_DENSE_H
void imp_factor(const AbstractLinAlgPack::MatrixConvertToSparse &A, const FactorizationStructure &fact_struc, FactorizationNonzeros *fact_nonzeros, std::ostream *out)
FortranTypes::f_int f_int
FactorizationStructureDense()
Abstract interface for immutable, finite dimensional, coordinate vectors {abstract}.
void V_InvMtV(VectorMutable *v_lhs, BLAS_Cpp::Transp trans_rhs1, const Vector &v_rhs2) const
FortranTypes::f_int f_int
RTOp_value_type value_type
Stores the factorization structure for Dense.
void estimated_fillin_ratio(value_type estimated_fillin_ratio)
Stores the factorization nonzeros for Dense.
std::valarray< f_int > ipiv_
void imp_analyze_and_factor(const AbstractLinAlgPack::MatrixConvertToSparse &A, FactorizationStructure *fact_struc, FactorizationNonzeros *fact_nonzeros, DenseLinAlgPack::IVector *row_perm, DenseLinAlgPack::IVector *col_perm, size_type *rank, std::ostream *out)
Concreate sparse solver subclass that uses the dense LAPACK routines.
FortranTypes::f_int rank_
RTOp_index_type size_type
Mix-in interface for extracing explicit elements from a sparse matrix in one of several Fortran compa...
const Teuchos::RCP< FactorizationStructure > create_fact_struc() const
const Teuchos::RCP< FactorizationNonzeros > create_fact_nonzeros() const
const basis_matrix_factory_ptr_t basis_matrix_factory() const
Implementation node class for DirectSparseSolver that takes care of the memory management details...
bool rect_analyze_and_factor_
FactorizationStructure * fact_struc
Abstract class for objects that represent the factorization structure of a particular matrix...
DirectSparseSolverDense()
Default constructor.
Abstract interface for mutable coordinate vectors {abstract}.
Implements the BasisMatrix object for Dense.
Teuchos::RCP< BasisMatrixImp > create_matrix() const
Abstract class for objects that represent the factorization nonzeros of a particular matrix...