42 #ifndef ALAP_DIRECT_SPARSE_SOLVER_MA28_H
43 #define ALAP_DIRECT_SPARSE_SOLVER_MA28_H
55 namespace AbstractLinAlgPack {
110 ,
const std::string& output_file_name =
""
143 ,
const Vector& v_rhs2)
const ;
179 std::valarray<index_type>
icn_;
200 std::valarray<value_type>
a_;
291 #endif // ALAP_DIRECT_SPARSE_SOLVER_MA28_H
DirectSparseSolverMA28(value_type estimated_fillin_ratio=10.0, value_type u=0.1, bool grow=false, value_type tol=0.0, index_type nsrch=4, bool lbig=false, bool print_ma28_outputs=false, const std::string &output_file_name="")
Default constructor.
Teuchos::RCP< const Teuchos::AbstractFactory< BasisMatrix > > basis_matrix_factory_ptr_t
Abstract interface for immutable, finite dimensional, coordinate vectors {abstract}.
Stores the factorization nonzeros for MA28.
RTOp_index_type index_type
const Teuchos::RCP< FactorizationNonzeros > create_fact_nonzeros() const
Concreate sparse solver subclass that uses MA28.
void print_ma28_outputs(bool ma28ad_bd, index_type iflag, const FactorizationStructureMA28 &fs, const value_type w[], std::ostream *out)
RTOp_value_type value_type
Teuchos::RCP< BasisMatrixImp > create_matrix() const
const Teuchos::RCP< FactorizationStructure > create_fact_struc() const
void V_InvMtV(VectorMutable *v_lhs, BLAS_Cpp::Transp trans_rhs1, const Vector &v_rhs2) const
MA28_Cpp::MA28Solver ma28_
std::valarray< index_type > jvect_
std::valarray< index_type > ivect_
const basis_matrix_factory_ptr_t basis_matrix_factory() const
E_IFlag
Enumeration for iflag.
value_type estimated_fillin_ratio_
const f_int f_dbl_prec const f_int f_int const f_int f_int const f_dbl_prec f_int f_int f_dbl_prec w[]
RTOp_index_type size_type
void imp_factor(const AbstractLinAlgPack::MatrixConvertToSparse &A, const FactorizationStructure &fact_struc, FactorizationNonzeros *fact_nonzeros, std::ostream *out)
Mix-in interface for extracing explicit elements from a sparse matrix in one of several Fortran compa...
std::valarray< index_type > icn_
std::valarray< index_type > ikeep_
const f_int f_dbl_prec const f_int f_int const f_int f_int const f_dbl_prec f_int f_int f_dbl_prec f_int * iflag
Implementation node class for DirectSparseSolver that takes care of the memory management details...
FactorizationStructureMA28()
Teuchos::RCP< std::ostream > output_file_
FactorizationStructure * fact_struc
Abstract class for objects that represent the factorization structure of a particular matrix...
matrix_scaling_ptr_t matrix_scaling_
Implements the BasisMatrix object for MA28.
void set_ma28_parameters(FactorizationStructureMA28 *fs)
Abstract interface for mutable coordinate vectors {abstract}.
void estimated_fillin_ratio(value_type estimated_fillin_ratio)
Stores the factorization structure for MA28.
Abstract class for objects that represent the factorization nonzeros of a particular matrix...
void ThrowIFlagException(index_type iflag)
STANDARD_MEMBER_COMPOSITION_MEMBERS(value_type, u)
Pivot tolerance versus sparsity.
std::valarray< value_type > a_
const f_int f_dbl_prec const f_int f_int const f_int f_int const f_dbl_prec & u
MA28 Basic Encapsulation Class.
Teuchos::RCP< MatrixScaling_Strategy > matrix_scaling_ptr_t
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)