42 #ifndef DIRECT_SPARSE_SOLVER_DENSE_H
43 #define DIRECT_SPARSE_SOLVER_DENSE_H
49 #include "AbstractLinAlgPack_DirectSparseSolverImp.hpp"
50 #include "DenseLinAlgPack_DMatrixClass.hpp"
51 #include "DenseLinAlgPack_IVector.hpp"
54 namespace AbstractLinAlgPack {
99 ,
const Vector& v_rhs2)
const ;
112 FortranTypes::f_int m_;
113 FortranTypes::f_int n_;
114 FortranTypes::f_int nz_;
115 FortranTypes::f_int rank_;
117 IVector inv_col_perm_;
125 typedef FortranTypes::f_int f_int;
130 bool rect_analyze_and_factor_;
131 std::valarray<f_int> ipiv_;
168 #endif // DIRECT_SPARSE_SOLVER_DENSE_H
void imp_factor(const AbstractLinAlgPack::MatrixConvertToSparse &A, const FactorizationStructure &fact_struc, FactorizationNonzeros *fact_nonzeros, std::ostream *out)
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
Stores the factorization structure for Dense.
void estimated_fillin_ratio(value_type estimated_fillin_ratio)
Stores the factorization nonzeros for Dense.
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.
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...
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...