MOOCHO/Thyra Adapter Software  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Groups Pages
List of all members
AbstractLinAlgPack::VectorMutableThyra Class Reference

VectorMutable adapter subclass for Thyra::VectorBase. More...

#include <AbstractLinAlgPack_VectorMutableThyra.hpp>

Inheritance diagram for AbstractLinAlgPack::VectorMutableThyra:
Inheritance graph
[legend]

Constructors / Initializers

 VectorMutableThyra ()
 Construct to uninitialized. More...
 
 VectorMutableThyra (const Teuchos::RCP< Thyra::VectorBase< value_type > > &thyra_vec)
 Calls this->initialize(). More...
 
void initialize (const Teuchos::RCP< Thyra::VectorBase< value_type > > &thyra_vec)
 Initalize given a smart pointer to a Thyra::Vetor object. More...
 
Teuchos::RCP
< Thyra::VectorBase
< value_type > > 
set_uninitialized ()
 Set to uninitialized and return smart pointer to the internal Thyra::VectorBase object. More...
 
Teuchos::RCP< const
Thyra::VectorBase< value_type > > 
thyra_vec () const
 Return a (converted) smart pointer to the internal smart pointer to the Thyra::VectorBase object. More...
 

Methods overridden from Vector

const VectorSpacespace () const
 
void apply_op (const RTOpPack::RTOp &op, const size_t num_vecs, const Vector *vecs[], const size_t num_targ_vecs, VectorMutable *targ_vecs[], RTOpPack::ReductTarget *reduct_obj, const index_type first_ele, const index_type sub_dim, const index_type global_offset) const
 
index_type dim () const
 
void get_sub_vector (const Range1D &rng, RTOpPack::SubVector *sub_vec) const
 
void free_sub_vector (RTOpPack::SubVector *sub_vec) const
 

Methods overridden from VectorMutable

void get_sub_vector (const Range1D &rng, RTOpPack::MutableSubVector *sub_vec)
 
void commit_sub_vector (RTOpPack::MutableSubVector *sub_vec)
 
void set_sub_vector (const RTOpPack::SparseSubVector &sub_vec)
 
void Vp_StMtV (value_type alpha, const GenPermMatrixSlice &P, BLAS_Cpp::Transp P_trans, const Vector &x, value_type beta)
 

Detailed Description

VectorMutable adapter subclass for Thyra::VectorBase.

Definition at line 54 of file AbstractLinAlgPack_VectorMutableThyra.hpp.

Constructor & Destructor Documentation

AbstractLinAlgPack::VectorMutableThyra::VectorMutableThyra ( )

Construct to uninitialized.

Postconditioins:

Definition at line 58 of file AbstractLinAlgPack_VectorMutableThyra.cpp.

AbstractLinAlgPack::VectorMutableThyra::VectorMutableThyra ( const Teuchos::RCP< Thyra::VectorBase< value_type > > &  thyra_vec)

Calls this->initialize().

Definition at line 61 of file AbstractLinAlgPack_VectorMutableThyra.cpp.

Member Function Documentation

void AbstractLinAlgPack::VectorMutableThyra::initialize ( const Teuchos::RCP< Thyra::VectorBase< value_type > > &  thyra_vec)

Initalize given a smart pointer to a Thyra::Vetor object.

Parameters
thyra_vec[in] Smart pointer to Thyra vector this will adapt.

Preconditioins:

  • thyra_vec.get() != NULL (throw std::invalid_argument)

Postconditioins:

Definition at line 68 of file AbstractLinAlgPack_VectorMutableThyra.cpp.

Teuchos::RCP< Thyra::VectorBase< value_type > > AbstractLinAlgPack::VectorMutableThyra::set_uninitialized ( )

Set to uninitialized and return smart pointer to the internal Thyra::VectorBase object.

Postconditioins:

Definition at line 83 of file AbstractLinAlgPack_VectorMutableThyra.cpp.

Teuchos::RCP< const Thyra::VectorBase< value_type > > AbstractLinAlgPack::VectorMutableThyra::thyra_vec ( ) const
inline

Return a (converted) smart pointer to the internal smart pointer to the Thyra::VectorBase object.

If this->thyra_vec().count() == 2, then this has so ownership of the *this->thyra_vec() object.

Definition at line 166 of file AbstractLinAlgPack_VectorMutableThyra.hpp.

const VectorSpace & AbstractLinAlgPack::VectorMutableThyra::space ( ) const
virtual
void AbstractLinAlgPack::VectorMutableThyra::apply_op ( const RTOpPack::RTOp &  op,
const size_t  num_vecs,
const Vector vecs[],
const size_t  num_targ_vecs,
VectorMutable targ_vecs[],
RTOpPack::ReductTarget reduct_obj,
const index_type  first_ele,
const index_type  sub_dim,
const index_type  global_offset 
) const
virtual
index_type AbstractLinAlgPack::VectorMutableThyra::dim ( ) const
virtual

Reimplemented from AbstractLinAlgPack::Vector.

Definition at line 163 of file AbstractLinAlgPack_VectorMutableThyra.cpp.

void AbstractLinAlgPack::VectorMutableThyra::get_sub_vector ( const Range1D rng,
RTOpPack::SubVector *  sub_vec 
) const
virtual

Reimplemented from AbstractLinAlgPack::Vector.

Definition at line 168 of file AbstractLinAlgPack_VectorMutableThyra.cpp.

void AbstractLinAlgPack::VectorMutableThyra::free_sub_vector ( RTOpPack::SubVector *  sub_vec) const
virtual

Reimplemented from AbstractLinAlgPack::Vector.

Definition at line 177 of file AbstractLinAlgPack_VectorMutableThyra.cpp.

void AbstractLinAlgPack::VectorMutableThyra::get_sub_vector ( const Range1D rng,
RTOpPack::MutableSubVector *  sub_vec 
)
virtual

Reimplemented from AbstractLinAlgPack::VectorMutable.

Definition at line 188 of file AbstractLinAlgPack_VectorMutableThyra.cpp.

void AbstractLinAlgPack::VectorMutableThyra::commit_sub_vector ( RTOpPack::MutableSubVector *  sub_vec)
virtual

Reimplemented from AbstractLinAlgPack::VectorMutable.

Definition at line 195 of file AbstractLinAlgPack_VectorMutableThyra.cpp.

void AbstractLinAlgPack::VectorMutableThyra::set_sub_vector ( const RTOpPack::SparseSubVector &  sub_vec)
virtual

Reimplemented from AbstractLinAlgPack::VectorMutable.

Definition at line 203 of file AbstractLinAlgPack_VectorMutableThyra.cpp.

void AbstractLinAlgPack::VectorMutableThyra::Vp_StMtV ( value_type  alpha,
const GenPermMatrixSlice P,
BLAS_Cpp::Transp  P_trans,
const Vector x,
value_type  beta 
)
virtual

Reimplemented from AbstractLinAlgPack::VectorMutable.

Definition at line 209 of file AbstractLinAlgPack_VectorMutableThyra.cpp.


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