Thyra  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Related Functions | List of all members
Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > Class Template Reference

Concrete Thyra::SpmdVectorBase using Tpetra::Vector. More...

#include <Thyra_TpetraVector_decl.hpp>

Inheritance diagram for Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >:
Inheritance graph
[legend]

Related Functions

(Note that these are not member functions.)

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
RCP< TpetraVector< Scalar,
LocalOrdinal, GlobalOrdinal,
Node > > 
tpetraVector (const RCP< const TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVectorSpace, const RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVector)
 Nonmember constructor for TpetraVector. More...
 
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
RCP< const TpetraVector
< Scalar, LocalOrdinal,
GlobalOrdinal, Node > > 
constTpetraVector (const RCP< const TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVectorSpace, const RCP< const Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVector)
 Nonmember constructor for TpetraVector. More...
 

Constructors/initializers

 TpetraVector ()
 Construct to uninitialized. More...
 
void initialize (const RCP< const TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVectorSpace, const RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVector)
 Initialize. More...
 
void constInitialize (const RCP< const TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVectorSpace, const RCP< const Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVector)
 Initialize. More...
 
RCP< Tpetra::Vector< Scalar,
LocalOrdinal, GlobalOrdinal,
Node > > 
getTpetraVector ()
 Get the embedded non-const Tpetra::Vector. More...
 
RCP< const Tpetra::Vector
< Scalar, LocalOrdinal,
GlobalOrdinal, Node > > 
getConstTpetraVector () const
 Get the embedded non-const Tpetra::Vector. More...
 

Overridden from VectorDefaultBase

RCP< const VectorSpaceBase
< Scalar > > 
domain () const
 

Overridden from SpmdMultiVectorBase

RCP< const SpmdVectorSpaceBase
< Scalar > > 
spmdSpaceImpl () const
 

Overridden from SpmdVectorBase

void getNonconstLocalVectorDataImpl (const Ptr< ArrayRCP< Scalar > > &localValues)
 
void getLocalVectorDataImpl (const Ptr< ArrayRCP< const Scalar > > &localValues) const
 

Overridden protected functions from VectorBase

virtual void randomizeImpl (Scalar l, Scalar u)
 
virtual void absImpl (const VectorBase< Scalar > &x)
 
virtual void reciprocalImpl (const VectorBase< Scalar > &x)
 
virtual void eleWiseScaleImpl (const VectorBase< Scalar > &x)
 
virtual Teuchos::ScalarTraits
< Scalar >::magnitudeType 
norm2WeightedImpl (const VectorBase< Scalar > &x) const
 
virtual void applyOpImpl (const RTOpPack::RTOpT< Scalar > &op, const ArrayView< const Ptr< const VectorBase< Scalar > > > &vecs, const ArrayView< const Ptr< VectorBase< Scalar > > > &targ_vecs, const Ptr< RTOpPack::ReductTarget > &reduct_obj, const Ordinal global_offset) const
 
void acquireDetachedVectorViewImpl (const Range1D &rng, RTOpPack::ConstSubVectorView< Scalar > *sub_vec) const
 
void acquireNonconstDetachedVectorViewImpl (const Range1D &rng, RTOpPack::SubVectorView< Scalar > *sub_vec)
 
void commitNonconstDetachedVectorViewImpl (RTOpPack::SubVectorView< Scalar > *sub_vec)
 

Overridden protected functions from MultiVectorBase

virtual void assignImpl (Scalar alpha)
 
virtual void assignMultiVecImpl (const MultiVectorBase< Scalar > &mv)
 
virtual void scaleImpl (Scalar alpha)
 
virtual void updateImpl (Scalar alpha, const MultiVectorBase< Scalar > &mv)
 
virtual void linearCombinationImpl (const ArrayView< const Scalar > &alpha, const ArrayView< const Ptr< const MultiVectorBase< Scalar > > > &mv, const Scalar &beta)
 
virtual void dotsImpl (const MultiVectorBase< Scalar > &mv, const ArrayView< Scalar > &prods) const
 
virtual void norms1Impl (const ArrayView< typename ScalarTraits< Scalar >::magnitudeType > &norms) const
 
virtual void norms2Impl (const ArrayView< typename ScalarTraits< Scalar >::magnitudeType > &norms) const
 
virtual void normsInfImpl (const ArrayView< typename ScalarTraits< Scalar >::magnitudeType > &norms) const
 

Overridden protected functions from LinearOpBase

void applyImpl (const EOpTransp M_trans, const MultiVectorBase< Scalar > &X, const Ptr< MultiVectorBase< Scalar > > &Y, const Scalar alpha, const Scalar beta) const
 

Additional Inherited Members

- Public Member Functions inherited from Thyra::SpmdVectorDefaultBase< Scalar >
virtual void applyOpImplWithComm (const Ptr< const Teuchos::Comm< Ordinal > > &comm, const RTOpPack::RTOpT< Scalar > &op, const ArrayView< const Ptr< const VectorBase< Scalar > > > &vecs, const ArrayView< const Ptr< VectorBase< Scalar > > > &targ_vecs, const Ptr< RTOpPack::ReductTarget > &reduct_obj, const Ordinal global_offset) const
 Implementation of applyOpImpl(...) that uses an input Comm. More...
 
 SpmdVectorDefaultBase ()
 
std::string description () const
 
Teuchos::RCP< const
VectorSpaceBase< Scalar > > 
space () const
 Returns this->spmdSpace(). More...
 
- Public Member Functions inherited from Thyra::SpmdVectorBase< Scalar >
RTOpPack::SubVectorView< Scalar > getNonconstLocalSubVector ()
 Get a non-const generalized view of local vector data. More...
 
RTOpPack::ConstSubVectorView
< Scalar > 
getLocalSubVector () const
 Get a const generalized view of local vector data. More...
 
void getNonconstLocalData (const Ptr< ArrayRCP< Scalar > > &localValues)
 Returns a non-const pointer to the beginning of the local vector data. More...
 
void getLocalData (const Ptr< ArrayRCP< const Scalar > > &localValues) const
 Returns a const pointer to the beginning of the local vector data. More...
 
- Public Member Functions inherited from Thyra::VectorBase< Scalar >
void assign (const VectorBase< Scalar > &x)
 Vector assignment: More...
 
void randomize (Scalar l, Scalar u)
 Random vector generation: More...
 
void update (Scalar alpha, const VectorBase< Scalar > &x)
 AXPY: More...
 
void linear_combination (const ArrayView< const Scalar > &alpha, const ArrayView< const Ptr< const VectorBase< Scalar > > > &x, const Scalar &beta)
 Linear combination: More...
 
Scalar dot (const VectorBase< Scalar > &x) const
 Euclidean dot product: result = x^H * this. More...
 
Teuchos::ScalarTraits< Scalar >
::magnitudeType 
norm_1 () const
 One (1) norm: result = ||v||1. More...
 
Teuchos::ScalarTraits< Scalar >
::magnitudeType 
norm_2 () const
 Euclidean (2) norm: result = ||v||2. More...
 
Teuchos::ScalarTraits< Scalar >
::magnitudeType 
norm_2 (const VectorBase< Scalar > &x) const
 Weighted Euclidean (2) norm: result = ||v||2. More...
 
Teuchos::ScalarTraits< Scalar >
::magnitudeType 
norm_inf () const
 Infinity norm: result = ||v||inf. More...
 
void applyOp (const RTOpPack::RTOpT< Scalar > &op, const ArrayView< const Ptr< const VectorBase< Scalar > > > &vecs, const ArrayView< const Ptr< VectorBase< Scalar > > > &targ_vecs, const Ptr< RTOpPack::ReductTarget > &reduct_obj, const Ordinal global_offset) const
 Calls applyOpImpl(). More...
 
void acquireDetachedView (const Range1D &rng, RTOpPack::ConstSubVectorView< Scalar > *sub_vec) const
 Calls acquireDetachedVectorViewImpl(). More...
 
void releaseDetachedView (RTOpPack::ConstSubVectorView< Scalar > *sub_vec) const
 Calls releaseDetachedVectorViewImpl(). More...
 
void acquireDetachedView (const Range1D &rng, RTOpPack::SubVectorView< Scalar > *sub_vec)
 Calls acquireNonconstDetachedVectorViewImpl(). More...
 
void commitDetachedView (RTOpPack::SubVectorView< Scalar > *sub_vec)
 Calls commitDetachedView(). More...
 
void setSubVector (const RTOpPack::SparseSubVectorT< Scalar > &sub_vec)
 Calls setSubVectorImpl(). More...
 
- Public Member Functions inherited from Thyra::MultiVectorBase< Scalar >
void assign (Scalar alpha)
 V = alpha. More...
 
void assign (const MultiVectorBase< Scalar > &mv)
 V = mv. More...
 
void scale (Scalar alpha)
 
void update (Scalar alpha, const MultiVectorBase< Scalar > &mv)
 
void linear_combination (const ArrayView< const Scalar > &alpha, const ArrayView< const Ptr< const MultiVectorBase< Scalar > > > &mv, const Scalar &beta)
 Y.col(j)(i) = beta*Y.col(j)(i) + sum( alpha[k]*X[k].col(j)(i), More...
 
void dots (const MultiVectorBase< Scalar > &mv, const ArrayView< Scalar > &prods) const
 Column-wise Euclidean dot product. More...
 
void norms_1 (const ArrayView< typename ScalarTraits< Scalar >::magnitudeType > &norms) const
 Column-wise 1-norms. More...
 
void norms_2 (const ArrayView< typename ScalarTraits< Scalar >::magnitudeType > &norms) const
 Column-wise 2-norms. More...
 
void norms_inf (const ArrayView< typename ScalarTraits< Scalar >::magnitudeType > &norms) const
 Column-wise infinity-norms. More...
 
RCP< const VectorBase< Scalar > > col (Ordinal j) const
 Calls colImpl(). More...
 
RCP< VectorBase< Scalar > > col (Ordinal j)
 Calls nonconstColImpl(). More...
 
RCP< const MultiVectorBase
< Scalar > > 
subView (const Range1D &colRng) const
 Calls contigSubViewImpl(). More...
 
RCP< MultiVectorBase< Scalar > > subView (const Range1D &colRng)
 Calls nonconstContigSubViewImpl(). More...
 
RCP< const MultiVectorBase
< Scalar > > 
subView (const ArrayView< const int > &cols) const
 nonContigSubViewImpl(). More...
 
RCP< MultiVectorBase< Scalar > > subView (const ArrayView< const int > &cols)
 nonconstNonContigSubViewImpl(). More...
 
void applyOp (const RTOpPack::RTOpT< Scalar > &primary_op, const ArrayView< const Ptr< const MultiVectorBase< Scalar > > > &multi_vecs, const ArrayView< const Ptr< MultiVectorBase< Scalar > > > &targ_multi_vecs, const ArrayView< const Ptr< RTOpPack::ReductTarget > > &reduct_objs, const Ordinal primary_global_offset) const
 Calls mvMultiReductApplyOpImpl(). More...
 
void applyOp (const RTOpPack::RTOpT< Scalar > &primary_op, const RTOpPack::RTOpT< Scalar > &secondary_op, const ArrayView< const Ptr< const MultiVectorBase< Scalar > > > &multi_vecs, const ArrayView< const Ptr< MultiVectorBase< Scalar > > > &targ_multi_vecs, const Ptr< RTOpPack::ReductTarget > &reduct_obj, const Ordinal primary_global_offset) const
 mvSingleReductApplyOpImpl(). More...
 
void acquireDetachedView (const Range1D &rowRng, const Range1D &colRng, RTOpPack::ConstSubMultiVectorView< Scalar > *sub_mv) const
 Calls acquireDetachedMultiVectorViewImpl(). More...
 
void releaseDetachedView (RTOpPack::ConstSubMultiVectorView< Scalar > *sub_mv) const
 Calls releaseDetachedMultiVectorViewImpl(). More...
 
void acquireDetachedView (const Range1D &rowRng, const Range1D &colRng, RTOpPack::SubMultiVectorView< Scalar > *sub_mv)
 Calls acquireNonconstDetachedMultiVectorViewImpl(). More...
 
void commitDetachedView (RTOpPack::SubMultiVectorView< Scalar > *sub_mv)
 Calls commitNonconstDetachedMultiVectorViewImpl(). More...
 
RCP< const LinearOpBase< Scalar > > clone () const
 This function is simply overridden to return this->clone_mv(). More...
 
- Public Member Functions inherited from Thyra::LinearOpBase< Scalar >
bool opSupported (EOpTransp M_trans) const
 Return if the M_trans operation of apply() is supported or not. More...
 
void apply (const EOpTransp M_trans, const MultiVectorBase< Scalar > &X, const Ptr< MultiVectorBase< Scalar > > &Y, const Scalar alpha, const Scalar beta) const
 Apply the linear operator to a multi-vector : Y = alpha*op(M)*X + beta*Y. More...
 
- Public Member Functions inherited from Thyra::RowStatLinearOpBase< Scalar >
bool rowStatIsSupported (const RowStatLinearOpBaseUtils::ERowStat rowStat) const
 Determine if a given row stat is supported. More...
 
void getRowStat (const RowStatLinearOpBaseUtils::ERowStat rowStat, const Ptr< VectorBase< Scalar > > &rowStatVec) const
 Get some statistics about a supported row. More...
 
- Public Member Functions inherited from Thyra::ScaledLinearOpBase< Scalar >
bool supportsScaleLeft () const
 Determines if this objects supports left scaling. More...
 
bool supportsScaleRight () const
 Determines if this objects supports right scaling. More...
 
void scaleLeft (const VectorBase< Scalar > &row_scaling)
 Left scales operator with diagonal scaling operator. More...
 
void scaleRight (const VectorBase< Scalar > &col_scaling)
 Right scales operator with diagonal scaling operator. More...
 
- Public Member Functions inherited from Thyra::SpmdMultiVectorBase< Scalar >
RCP< const SpmdVectorSpaceBase
< Scalar > > 
spmdSpace () const
 Returns the SPMD vector space object for the range of *this multi-vector. More...
 
RTOpPack::SubMultiVectorView
< Scalar > 
getNonconstLocalSubMultiVector ()
 Get a non-const generalized view of local multi-vector data. More...
 
RTOpPack::ConstSubMultiVectorView
< Scalar > 
getLocalSubMultiVector () const
 Get a const generalized view of local multi-vector data. More...
 
void getNonconstLocalData (const Ptr< ArrayRCP< Scalar > > &localValues, const Ptr< Ordinal > &leadingDim)
 Returns a non-const pointer to a Fortran-style view of the local multi-vector data. More...
 
void getLocalData (const Ptr< ArrayRCP< const Scalar > > &localValues, const Ptr< Ordinal > &leadingDim) const
 Returns a const pointer to a Fortran-style view of the local multi-vector data. More...
 
- Public Member Functions inherited from Thyra::VectorDefaultBase< Scalar >
virtual void describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const
 Generates a default outputting for all vectors. More...
 
virtual RCP< const
VectorSpaceBase< Scalar > > 
range () const
 Returns this->space(). More...
 
RCP< MultiVectorBase< Scalar > > clone_mv () const
 Returns this->clone_v(). More...
 
RCP< VectorBase< Scalar > > clone_v () const
 Simply creates a new vector and copies the contents from *this. More...
 
- Protected Member Functions inherited from Thyra::SpmdVectorDefaultBase< Scalar >
void releaseDetachedVectorViewImpl (RTOpPack::ConstSubVectorView< Scalar > *sub_vec) const
 Implemented through this->freeLocalData() More...
 
RTOpPack::SubMultiVectorView
< Scalar > 
getNonconstLocalSubMultiVectorImpl ()
 
RTOpPack::ConstSubMultiVectorView
< Scalar > 
getLocalSubMultiVectorImpl () const
 
void getNonconstLocalMultiVectorDataImpl (const Ptr< ArrayRCP< Scalar > > &localValues, const Ptr< Ordinal > &leadingDim)
 
void getLocalMultiVectorDataImpl (const Ptr< ArrayRCP< const Scalar > > &localValues, const Ptr< Ordinal > &leadingDim) const
 
RTOpPack::SubVectorView< Scalar > getNonconstLocalSubVectorImpl ()
 Virtual implementation for getNonconstLocalSubVector(). More...
 
RTOpPack::ConstSubVectorView
< Scalar > 
getLocalSubVectorImpl () const
 Virtual implementation for getLocalSubVector(). More...
 
virtual void updateSpmdSpace ()
 Subclasses must call this function whenever the structure of the VectorSpaceBase changes. More...
 
- Protected Member Functions inherited from Thyra::SpmdVectorBase< Scalar >
- Protected Member Functions inherited from Thyra::VectorBase< Scalar >
- Protected Member Functions inherited from Thyra::MultiVectorBase< Scalar >
void absRowSum (const Teuchos::Ptr< Thyra::VectorBase< Scalar > > &output) const
 
void absColSum (const Teuchos::Ptr< Thyra::VectorBase< Scalar > > &output) const
 
virtual RCP< const VectorBase
< Scalar > > 
colImpl (Ordinal j) const
 Return a non-changeable view of a constituent column vector. More...
 
virtual bool rowStatIsSupportedImpl (const RowStatLinearOpBaseUtils::ERowStat rowStat) const
 
virtual void getRowStatImpl (const RowStatLinearOpBaseUtils::ERowStat rowStat, const Ptr< VectorBase< Scalar > > &rowStatVec) const
 
virtual bool supportsScaleLeftImpl () const
 
virtual bool supportsScaleRightImpl () const
 
virtual void scaleLeftImpl (const VectorBase< Scalar > &row_scaling)
 
virtual void scaleRightImpl (const VectorBase< Scalar > &col_scaling)
 
- Protected Member Functions inherited from Thyra::LinearOpBase< Scalar >
- Protected Member Functions inherited from Thyra::RowStatLinearOpBase< Scalar >
- Protected Member Functions inherited from Thyra::ScaledLinearOpBase< Scalar >
- Protected Member Functions inherited from Thyra::SpmdMultiVectorBase< Scalar >
- Protected Member Functions inherited from Thyra::VectorDefaultBase< Scalar >
virtual void assignVecImpl (const VectorBase< Scalar > &x)
 Default implementation of assign(vector) using RTOps. More...
 
virtual void updateVecImpl (Scalar alpha, const VectorBase< Scalar > &x)
 Default implementation of update using RTOps. More...
 
virtual void linearCombinationVecImpl (const ArrayView< const Scalar > &alpha, const ArrayView< const Ptr< const VectorBase< Scalar > > > &x, const Scalar &beta)
 Default implementation of linear_combination using RTOps. More...
 
virtual Scalar dotImpl (const VectorBase< Scalar > &x) const
 Default implementation of dot using RTOps. More...
 
virtual Teuchos::ScalarTraits
< Scalar >::magnitudeType 
norm1Impl () const
 Default implementation of norm_1 using RTOps. More...
 
virtual Teuchos::ScalarTraits
< Scalar >::magnitudeType 
norm2Impl () const
 Default implementation of norm_2 using RTOps. More...
 
virtual Teuchos::ScalarTraits
< Scalar >::magnitudeType 
normInfImpl () const
 Default implementation of norm_inf using RTOps. More...
 
virtual RCP< VectorBase< Scalar > > nonconstColImpl (Ordinal j)
 Returns Teuchos::rcp(this,false). More...
 
virtual RCP< const
MultiVectorBase< Scalar > > 
contigSubViewImpl (const Range1D &col_rng) const
 Returns Teuchos::rcp(this,false). More...
 
virtual RCP< MultiVectorBase
< Scalar > > 
nonconstContigSubViewImpl (const Range1D &col_rng)
 Returns Teuchos::rcp(this,false). More...
 
virtual RCP< const
MultiVectorBase< Scalar > > 
nonContigSubViewImpl (const ArrayView< const int > &cols) const
 Returns Teuchos::rcp(this,false). More...
 
virtual RCP< MultiVectorBase
< Scalar > > 
nonconstNonContigSubViewImpl (const ArrayView< const int > &cols)
 Returns Teuchos::rcp(this,false). More...
 
virtual void acquireDetachedMultiVectorViewImpl (const Range1D &rowRng, const Range1D &colRng, RTOpPack::ConstSubMultiVectorView< Scalar > *sub_mv) const
 Implemented in terms of this->acquireDetachedView(). More...
 
virtual void releaseDetachedMultiVectorViewImpl (RTOpPack::ConstSubMultiVectorView< Scalar > *sub_mv) const
 Implemented in terms of this->releaseDetachedView(). More...
 
virtual void acquireNonconstDetachedMultiVectorViewImpl (const Range1D &rowRng, const Range1D &colRng, RTOpPack::SubMultiVectorView< Scalar > *sub_mv)
 Implemented in terms of this->acquireDetachedView(). More...
 
virtual void commitNonconstDetachedMultiVectorViewImpl (RTOpPack::SubMultiVectorView< Scalar > *sub_mv)
 Implemented in terms of this->commitDetachedView(). More...
 
virtual void setSubVectorImpl (const RTOpPack::SparseSubVectorT< Scalar > &sub_vec)
 
bool opSupportedImpl (EOpTransp M_trans) const
 For complex Scalar types returns true for NOTRANS and CONJTRANS and for real types returns true for all values of M_trans. More...
 
- Protected Member Functions inherited from Thyra::MultiVectorDefaultBase< Scalar >
virtual void mvMultiReductApplyOpImpl (const RTOpPack::RTOpT< Scalar > &primary_op, const ArrayView< const Ptr< const MultiVectorBase< Scalar > > > &multi_vecs, const ArrayView< const Ptr< MultiVectorBase< Scalar > > > &targ_multi_vecs, const ArrayView< const Ptr< RTOpPack::ReductTarget > > &reduct_objs, const Ordinal primary_global_offset) const
 
virtual void mvSingleReductApplyOpImpl (const RTOpPack::RTOpT< Scalar > &primary_op, const RTOpPack::RTOpT< Scalar > &secondary_op, const ArrayView< const Ptr< const MultiVectorBase< Scalar > > > &multi_vecs, const ArrayView< const Ptr< MultiVectorBase< Scalar > > > &targ_multi_vecs, const Ptr< RTOpPack::ReductTarget > &reduct_obj, const Ordinal primary_global_offset) const
 
- Protected Member Functions inherited from Thyra::LinearOpDefaultBase< Scalar >

Detailed Description

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
class Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >

Concrete Thyra::SpmdVectorBase using Tpetra::Vector.

Definition at line 60 of file Thyra_TpetraVector_decl.hpp.

Constructor & Destructor Documentation

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraVector ( )

Construct to uninitialized.

Definition at line 56 of file Thyra_TpetraVector_def.hpp.

Member Function Documentation

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::initialize ( const RCP< const TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &  tpetraVectorSpace,
const RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &  tpetraVector 
)

Initialize.

Definition at line 61 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::constInitialize ( const RCP< const TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &  tpetraVectorSpace,
const RCP< const Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &  tpetraVector 
)

Initialize.

Definition at line 71 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getTpetraVector ( )

Get the embedded non-const Tpetra::Vector.

Definition at line 82 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
RCP< const Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getConstTpetraVector ( ) const

Get the embedded non-const Tpetra::Vector.

Definition at line 90 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
RCP< const VectorSpaceBase< Scalar > > Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::domain ( ) const
virtual

Reimplemented from Thyra::VectorDefaultBase< Scalar >.

Definition at line 99 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
RCP< const SpmdVectorSpaceBase< Scalar > > Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::spmdSpaceImpl ( ) const
virtual

Implements Thyra::SpmdMultiVectorBase< Scalar >.

Definition at line 118 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getNonconstLocalVectorDataImpl ( const Ptr< ArrayRCP< Scalar > > &  localValues)
virtual

Implements Thyra::SpmdVectorBase< Scalar >.

Definition at line 128 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getLocalVectorDataImpl ( const Ptr< ArrayRCP< const Scalar > > &  localValues) const
virtual

Implements Thyra::SpmdVectorBase< Scalar >.

Definition at line 136 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::randomizeImpl ( Scalar  l,
Scalar  u 
)
protectedvirtual

Reimplemented from Thyra::VectorDefaultBase< Scalar >.

Definition at line 147 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::absImpl ( const VectorBase< Scalar > &  x)
protectedvirtual

Reimplemented from Thyra::VectorDefaultBase< Scalar >.

Definition at line 168 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::reciprocalImpl ( const VectorBase< Scalar > &  x)
protectedvirtual

Reimplemented from Thyra::VectorDefaultBase< Scalar >.

Definition at line 188 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::eleWiseScaleImpl ( const VectorBase< Scalar > &  x)
protectedvirtual

Reimplemented from Thyra::VectorDefaultBase< Scalar >.

Definition at line 208 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::ScalarTraits< Scalar >::magnitudeType Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::norm2WeightedImpl ( const VectorBase< Scalar > &  x) const
protectedvirtual

Reimplemented from Thyra::VectorDefaultBase< Scalar >.

Definition at line 231 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::applyOpImpl ( const RTOpPack::RTOpT< Scalar > &  op,
const ArrayView< const Ptr< const VectorBase< Scalar > > > &  vecs,
const ArrayView< const Ptr< VectorBase< Scalar > > > &  targ_vecs,
const Ptr< RTOpPack::ReductTarget > &  reduct_obj,
const Ordinal  global_offset 
) const
protectedvirtual

Reimplemented from Thyra::SpmdVectorDefaultBase< Scalar >.

Definition at line 256 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::acquireDetachedVectorViewImpl ( const Range1D rng,
RTOpPack::ConstSubVectorView< Scalar > *  sub_vec 
) const
protectedvirtual

Reimplemented from Thyra::SpmdVectorDefaultBase< Scalar >.

Definition at line 288 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::acquireNonconstDetachedVectorViewImpl ( const Range1D rng,
RTOpPack::SubVectorView< Scalar > *  sub_vec 
)
protectedvirtual

Reimplemented from Thyra::SpmdVectorDefaultBase< Scalar >.

Definition at line 304 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::commitNonconstDetachedVectorViewImpl ( RTOpPack::SubVectorView< Scalar > *  sub_vec)
protectedvirtual

Reimplemented from Thyra::SpmdVectorDefaultBase< Scalar >.

Definition at line 319 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::assignImpl ( Scalar  alpha)
protectedvirtual

Reimplemented from Thyra::MultiVectorDefaultBase< Scalar >.

Definition at line 336 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::assignMultiVecImpl ( const MultiVectorBase< Scalar > &  mv)
protectedvirtual

Reimplemented from Thyra::MultiVectorDefaultBase< Scalar >.

Definition at line 344 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::scaleImpl ( Scalar  alpha)
protectedvirtual

Reimplemented from Thyra::MultiVectorDefaultBase< Scalar >.

Definition at line 362 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::updateImpl ( Scalar  alpha,
const MultiVectorBase< Scalar > &  mv 
)
protectedvirtual

Reimplemented from Thyra::MultiVectorDefaultBase< Scalar >.

Definition at line 369 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::linearCombinationImpl ( const ArrayView< const Scalar > &  alpha,
const ArrayView< const Ptr< const MultiVectorBase< Scalar > > > &  mv,
const Scalar &  beta 
)
protectedvirtual

Reimplemented from Thyra::MultiVectorDefaultBase< Scalar >.

Definition at line 391 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::dotsImpl ( const MultiVectorBase< Scalar > &  mv,
const ArrayView< Scalar > &  prods 
) const
protectedvirtual

Reimplemented from Thyra::MultiVectorDefaultBase< Scalar >.

Definition at line 470 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::norms1Impl ( const ArrayView< typename ScalarTraits< Scalar >::magnitudeType > &  norms) const
protectedvirtual

Reimplemented from Thyra::MultiVectorDefaultBase< Scalar >.

Definition at line 491 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::norms2Impl ( const ArrayView< typename ScalarTraits< Scalar >::magnitudeType > &  norms) const
protectedvirtual

Reimplemented from Thyra::MultiVectorDefaultBase< Scalar >.

Definition at line 500 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::normsInfImpl ( const ArrayView< typename ScalarTraits< Scalar >::magnitudeType > &  norms) const
protectedvirtual

Reimplemented from Thyra::MultiVectorDefaultBase< Scalar >.

Definition at line 509 of file Thyra_TpetraVector_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::applyImpl ( const EOpTransp  M_trans,
const MultiVectorBase< Scalar > &  X,
const Ptr< MultiVectorBase< Scalar > > &  Y,
const Scalar  alpha,
const Scalar  beta 
) const
protectedvirtual

Reimplemented from Thyra::VectorDefaultBase< Scalar >.

Definition at line 518 of file Thyra_TpetraVector_def.hpp.

Friends And Related Function Documentation

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
RCP< TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > tpetraVector ( const RCP< const TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &  tpetraVectorSpace,
const RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &  tpetraVector 
)
related

Nonmember constructor for TpetraVector.

Definition at line 275 of file Thyra_TpetraVector_decl.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
RCP< const TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > constTpetraVector ( const RCP< const TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &  tpetraVectorSpace,
const RCP< const Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &  tpetraVector 
)
related

Nonmember constructor for TpetraVector.

Definition at line 294 of file Thyra_TpetraVector_decl.hpp.


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