| MOOCHO (Single Doxygen Collection)
    Version of the Day
    | 
VectorMutable adapter subclass for Thyra::VectorBase.  
 More...
#include <AbstractLinAlgPack_VectorMutableThyra.hpp>

| Private Member Functions | |
| VectorMutableThyra & | operator= (const VectorMutableThyra &) | 
|  Private Member Functions inherited from AbstractLinAlgPack::VectorApplyOpSerialBase | |
| VectorApplyOpSerialBase () | |
| void | apply_op_serial (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 | 
| Private Attributes | |
| Thyra::VectorBase< value_type > * | thyra_vector | 
| VectorSpaceThyra | space_ | 
| 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::Vetorobject.  More... | |
| Teuchos::RCP < Thyra::VectorBase < value_type > > | set_uninitialized () | 
| Set to uninitialized and return smart pointer to the internal Thyra::VectorBaseobject.  More... | |
| Teuchos::RCP< const Thyra::VectorBase< value_type > > | thyra_vec () const | 
| Return a (converted) smart pointer to the internal smart pointer to the Thyra::VectorBaseobject.  More... | |
| Methods overridden from Vector | |
| const VectorSpace & | space () 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) | 
| Additional Inherited Members | |
|  Public Types inherited from AbstractLinAlgPack::Vector | |
| typedef Teuchos::RCP< const Vector > | vec_ptr_t | 
| typedef Teuchos::RCP < VectorMutable > | vec_mut_ptr_t | 
|  Public Member Functions inherited from AbstractLinAlgPack::VectorMutable | |
| virtual VectorMutable & | operator= (value_type alpha) | 
| Assign the elements of thisvector to a scalar.  More... | |
| virtual VectorMutable & | operator= (const Vector &v) | 
| Assign the elements of a vector to this.  More... | |
| virtual VectorMutable & | operator= (const VectorMutable &v) | 
| Default implementation calls operator=((const &Vector)v).  More... | |
| virtual void | set_ele (index_type i, value_type val) | 
| Set a specific element of a vector.  More... | |
| virtual vec_mut_ptr_t | sub_view (const Range1D &rng) | 
| Create a mutable abstract view of a vector object.  More... | |
| vec_mut_ptr_t | sub_view (const index_type &l, const index_type &u) | 
| Inline member function that simply calls this->sub_view(Range1D(l,u)).  More... | |
| virtual void | zero () | 
| Zeros this vector.  More... | |
| virtual void | axpy (value_type alpha, const Vector &x) | 
| Adds a linear combination of another vector to this vector object.  More... | |
| vec_ptr_t | sub_view (const Range1D &rng) const | 
| Default implementation calls this->sub_view()(non-const) and then performs an cast tovec_ptr_t.  More... | |
|  Public Member Functions inherited from AbstractLinAlgPack::Vector | |
| Vector () | |
| virtual | ~Vector () | 
| vec_ptr_t | sub_view (const index_type &l, const index_type &u) const | 
| Inline member function that simply calls this->sub_view(Range1D(l,u)).  More... | |
| virtual void | has_changed () const | 
| Must be called by any vector subclass that modifies this vector object!  More... | |
| virtual index_type | nz () const | 
| Return the number of nonzero elements in the vector.  More... | |
| virtual std::ostream & | output (std::ostream &out, bool print_dim=true, bool newline=true, index_type global_offset=0) const | 
| Virtual output function.  More... | |
| virtual vec_mut_ptr_t | clone () const | 
| Create a clone of this vector objet.  More... | |
| virtual value_type | get_ele (index_type i) const | 
| Fetch an element in the vector.  More... | |
| virtual value_type | norm_1 () const | 
| One norm. ||v||_1 = sum( |v(i)|, i = 1,,,this->dim() )More... | |
| virtual value_type | norm_2 () const | 
| Two norm. ||v||_2 = sqrt( sum( v(i)^2, i = 1,,,this->dim() ) )More... | |
| virtual value_type | norm_inf () const | 
| Infinity norm. ||v||_inf = max( |v(i)|, i = 1,,,this->dim() )More... | |
| virtual value_type | inner_product (const Vector &v) const | 
| Return the inner product of *thiswithv.  More... | |
|  Protected Member Functions inherited from AbstractLinAlgPack::Vector | |
| virtual void | finalize_apply_op (const size_t num_targ_vecs, VectorMutable **targ_vecs) const | 
| This method usually needs to be called by subclasses at the end of the apply_op()method implementation to insure thathas_changed()is called on the transformed vector objects.  More... | |
VectorMutable adapter subclass for Thyra::VectorBase. 
Definition at line 54 of file AbstractLinAlgPack_VectorMutableThyra.hpp.
| AbstractLinAlgPack::VectorMutableThyra::VectorMutableThyra | ( | ) | 
Construct to uninitialized.
Postconditioins:
this->thyra_vec().get() == NULL 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.
| void AbstractLinAlgPack::VectorMutableThyra::initialize | ( | const Teuchos::RCP< Thyra::VectorBase< value_type > > & | thyra_vec | ) | 
Initalize given a smart pointer to a Thyra::Vetor object. 
| thyra_vec | [in] Smart pointer to Thyra vector thiswill adapt. | 
Preconditioins:
thyra_vec.get() != NULL (throw std::invalid_argument) Postconditioins:
this->thyra_vec().get() == thyra_vec.get() 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:
this->thyra_vec().get() == NULL Definition at line 83 of file AbstractLinAlgPack_VectorMutableThyra.cpp.
| 
 | 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.
| 
 | virtual | 
Implements AbstractLinAlgPack::Vector.
Definition at line 95 of file AbstractLinAlgPack_VectorMutableThyra.cpp.
| 
 | virtual | 
Implements AbstractLinAlgPack::Vector.
Definition at line 100 of file AbstractLinAlgPack_VectorMutableThyra.cpp.
| 
 | virtual | 
Reimplemented from AbstractLinAlgPack::Vector.
Definition at line 163 of file AbstractLinAlgPack_VectorMutableThyra.cpp.
| 
 | virtual | 
Reimplemented from AbstractLinAlgPack::Vector.
Definition at line 168 of file AbstractLinAlgPack_VectorMutableThyra.cpp.
| 
 | virtual | 
Reimplemented from AbstractLinAlgPack::Vector.
Definition at line 177 of file AbstractLinAlgPack_VectorMutableThyra.cpp.
| 
 | virtual | 
Reimplemented from AbstractLinAlgPack::VectorMutable.
Definition at line 188 of file AbstractLinAlgPack_VectorMutableThyra.cpp.
| 
 | virtual | 
Reimplemented from AbstractLinAlgPack::VectorMutable.
Definition at line 195 of file AbstractLinAlgPack_VectorMutableThyra.cpp.
| 
 | virtual | 
Reimplemented from AbstractLinAlgPack::VectorMutable.
Definition at line 203 of file AbstractLinAlgPack_VectorMutableThyra.cpp.
| 
 | virtual | 
Reimplemented from AbstractLinAlgPack::VectorMutable.
Definition at line 209 of file AbstractLinAlgPack_VectorMutableThyra.cpp.
| 
 | private | 
| 
 | private | 
Definition at line 149 of file AbstractLinAlgPack_VectorMutableThyra.hpp.
| 
 | private | 
Definition at line 153 of file AbstractLinAlgPack_VectorMutableThyra.hpp.
 1.8.6
 1.8.6