Thyra Package Browser (Single Doxygen Collection)  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Private Types | Private Member Functions | Private Attributes | 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>

Inherits SpmdVectorDefaultBase< Scalar >.

Private Types

typedef Tpetra::MultiVector
< Scalar, LocalOrdinal,
GlobalOrdinal, Node > 
TpetraMultiVector_t
 

Private Member Functions

template<class TpetraVector_t >
void initializeImpl (const RCP< const TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVectorSpace, const RCP< TpetraVector_t > &tpetraVector)
 
RCP< Tpetra::MultiVector
< Scalar, LocalOrdinal,
GlobalOrdinal, Node > > 
getTpetraMultiVector (const RCP< MultiVectorBase< Scalar > > &mv) const
 
RCP< const Tpetra::MultiVector
< Scalar, LocalOrdinal,
GlobalOrdinal, Node > > 
getConstTpetraMultiVector (const RCP< const MultiVectorBase< Scalar > > &mv) const
 
RCP< Tpetra::Vector< Scalar,
LocalOrdinal, GlobalOrdinal,
Node > > 
getTpetraVector (const RCP< VectorBase< Scalar > > &v) const
 
RCP< const Tpetra::Vector
< Scalar, LocalOrdinal,
GlobalOrdinal, Node > > 
getConstTpetraVector (const RCP< const VectorBase< Scalar > > &v) const
 

Private Attributes

RCP< const TpetraVectorSpace
< Scalar, LocalOrdinal,
GlobalOrdinal, Node > > 
tpetraVectorSpace_
 
RCP< const TpetraVectorSpace
< Scalar, LocalOrdinal,
GlobalOrdinal, Node > > 
domainSpace_
 
Teuchos::ConstNonconstObjectContainer
< Tpetra::Vector< Scalar,
LocalOrdinal, GlobalOrdinal,
Node > > 
tpetraVector_
 

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
 

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.

Member Typedef Documentation

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
typedef Tpetra::MultiVector<Scalar, LocalOrdinal,GlobalOrdinal,Node> Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraMultiVector_t
private

Definition at line 240 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

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

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)

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

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

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

Definition at line 168 of file Thyra_TpetraVector_def.hpp.

References nonnull().

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

Definition at line 185 of file Thyra_TpetraVector_def.hpp.

References nonnull().

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

Definition at line 202 of file Thyra_TpetraVector_def.hpp.

References nonnull().

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

Definition at line 222 of file Thyra_TpetraVector_def.hpp.

References nonnull().

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

Definition at line 245 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
protected

Definition at line 259 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 
)
protected

Definition at line 270 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)
protected

Definition at line 282 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

Definition at line 294 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

Definition at line 302 of file Thyra_TpetraVector_def.hpp.

References nonnull().

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

Definition at line 317 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

Definition at line 324 of file Thyra_TpetraVector_def.hpp.

References nonnull().

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
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

Definition at line 419 of file Thyra_TpetraVector_def.hpp.

References nonnull().

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

Definition at line 437 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

Definition at line 446 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

Definition at line 455 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
protected
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
template<class TpetraVector_t >
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::initializeImpl ( const RCP< const TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &  tpetraVectorSpace,
const RCP< TpetraVector_t > &  tpetraVector 
)
private

Definition at line 515 of file Thyra_TpetraVector_def.hpp.

References nonnull(), and TEUCHOS_ASSERT.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
RCP< Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getTpetraMultiVector ( const RCP< MultiVectorBase< Scalar > > &  mv) const
private

Definition at line 533 of file Thyra_TpetraVector_def.hpp.

References nonnull(), and Teuchos::null.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
RCP< const Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getConstTpetraMultiVector ( const RCP< const MultiVectorBase< Scalar > > &  mv) const
private

Definition at line 556 of file Thyra_TpetraVector_def.hpp.

References nonnull(), and Teuchos::null.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getTpetraVector ( const RCP< VectorBase< Scalar > > &  v) const
private

Definition at line 579 of file Thyra_TpetraVector_def.hpp.

References nonnull(), and Teuchos::null.

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 RCP< const VectorBase< Scalar > > &  v) const
private

Definition at line 594 of file Thyra_TpetraVector_def.hpp.

References nonnull(), and Teuchos::null.

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.

References Teuchos::rcp().

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.

References Teuchos::rcp().

Member Data Documentation

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
RCP<const TpetraVectorSpace<Scalar,LocalOrdinal,GlobalOrdinal,Node> > Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::tpetraVectorSpace_
private

Definition at line 232 of file Thyra_TpetraVector_decl.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
RCP<const TpetraVectorSpace<Scalar,LocalOrdinal,GlobalOrdinal,Node> > Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::domainSpace_
mutableprivate

Definition at line 235 of file Thyra_TpetraVector_decl.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::ConstNonconstObjectContainer<Tpetra::Vector<Scalar, LocalOrdinal,GlobalOrdinal,Node> > Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::tpetraVector_
private

Definition at line 238 of file Thyra_TpetraVector_decl.hpp.


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