42 #ifndef MATRIX_VAR_REDUCT_IMPLICIT_H
43 #define MATRIX_VAR_REDUCT_IMPLICIT_H
52 namespace ConstrainedOptPack {
205 std::ostream&
output(std::ostream&)
const;
246 #ifdef DOXYGEN_COMPILE
305 #endif // MATRIX_VAR_REDUCT_IMPLICIT_H
AbstractLinAlgPack::size_type size_type
AbstractLinAlgPack::MatrixOp * N
Teuchos::RCP< const MatrixOp > mat_ptr_t
const mat_nonsing_ptr_t & C_ptr() const
Return the smart pointer to the aggregate basis matrix object C.
virtual void initialize(const mat_nonsing_ptr_t &C, const mat_ptr_t &N, const mat_ptr_t &D_direct)
Initialize this matrix object.
std::ostream & output(std::ostream &) const
void assert_initialized() const
void Vp_StPtMtV(VectorMutable *v_lhs, value_type alpha, const GenPermMatrixSlice &P_rhs1, BLAS_Cpp::Transp P_rhs1_trans, BLAS_Cpp::Transp M_rhs2_trans, const Vector &v_rhs3, value_type beta) const
const mat_ptr_t & D_direct_ptr() const
Return the smart pointer to the aggregate precomputed matrix object D_direct (if set).
const VectorSpace & space_cols() const
const mat_ptr_t & N_ptr() const
Return the smart pointer to the aggregate nonbasis matrix object N.
const LAPACK_C_Decl::f_int & M
Base class for all matrices that support basic matrix operations.
SparseVectorSlice< SparseElement< index_type, value_type > > SpVectorSlice
void Vp_StMtV(VectorMutable *v_lhs, value_type alpha, BLAS_Cpp::Transp trans_rhs1, const Vector &v_rhs2, value_type beta) const
Implements D = - inv(C) * N for a variable reduction projection.
Teuchos::RCP< const MatrixOpNonsing > mat_nonsing_ptr_t
AbstractLinAlgPack::value_type value_type
const VectorSpace & space_rows() const
Abstract base class for all nonsingular polymorphic matrices that can be used to compute matrix-vecto...
AbstractLinAlgPack::MatrixOp * D_direct
MatrixOp & operator=(const MatrixOp &M)
std::vector< VectorSpace::vec_mut_ptr_t > InvCtN_rows_t
AbstractLinAlgPack::MatrixOpNonsing * C
virtual void set_uninitialized()
Set the matrix to uninitialized.
std::list< index_type > InvCtN_rows_set_list_t