Thyra Package Browser (Single Doxygen Collection)
Version of the Day
|
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 |
Concrete Thyra::SpmdVectorBase using Tpetra::Vector.
Definition at line 28 of file Thyra_TpetraVector_decl.hpp.
|
private |
Definition at line 208 of file Thyra_TpetraVector_decl.hpp.
Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraVector | ( | ) |
Construct to uninitialized.
Definition at line 24 of file Thyra_TpetraVector_def.hpp.
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 29 of file Thyra_TpetraVector_def.hpp.
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 39 of file Thyra_TpetraVector_def.hpp.
RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getTpetraVector | ( | ) |
Get the embedded non-const Tpetra::Vector.
Definition at line 50 of file Thyra_TpetraVector_def.hpp.
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 58 of file Thyra_TpetraVector_def.hpp.
RCP< const VectorSpaceBase< Scalar > > Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::domain | ( | ) | const |
Definition at line 67 of file Thyra_TpetraVector_def.hpp.
RCP< const SpmdVectorSpaceBase< Scalar > > Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::spmdSpaceImpl | ( | ) | const |
Definition at line 86 of file Thyra_TpetraVector_def.hpp.
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getNonconstLocalVectorDataImpl | ( | const Ptr< ArrayRCP< Scalar > > & | localValues | ) |
Definition at line 96 of file Thyra_TpetraVector_def.hpp.
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getLocalVectorDataImpl | ( | const Ptr< ArrayRCP< const Scalar > > & | localValues | ) | const |
Definition at line 104 of file Thyra_TpetraVector_def.hpp.
|
protectedvirtual |
Definition at line 115 of file Thyra_TpetraVector_def.hpp.
|
protectedvirtual |
Definition at line 136 of file Thyra_TpetraVector_def.hpp.
References nonnull().
|
protectedvirtual |
Definition at line 153 of file Thyra_TpetraVector_def.hpp.
References nonnull().
|
protectedvirtual |
Definition at line 170 of file Thyra_TpetraVector_def.hpp.
References nonnull().
|
protectedvirtual |
Definition at line 190 of file Thyra_TpetraVector_def.hpp.
References nonnull().
|
protectedvirtual |
Definition at line 213 of file Thyra_TpetraVector_def.hpp.
|
protected |
Definition at line 227 of file Thyra_TpetraVector_def.hpp.
|
protected |
Definition at line 238 of file Thyra_TpetraVector_def.hpp.
|
protected |
Definition at line 250 of file Thyra_TpetraVector_def.hpp.
|
protectedvirtual |
Definition at line 262 of file Thyra_TpetraVector_def.hpp.
|
protectedvirtual |
Definition at line 270 of file Thyra_TpetraVector_def.hpp.
References nonnull().
|
protectedvirtual |
Definition at line 285 of file Thyra_TpetraVector_def.hpp.
|
protectedvirtual |
Definition at line 292 of file Thyra_TpetraVector_def.hpp.
References nonnull().
|
protectedvirtual |
Definition at line 311 of file Thyra_TpetraVector_def.hpp.
References Teuchos::ArrayView< T >::begin(), Teuchos::Copy, nonnull(), Teuchos::null, Teuchos::rcp(), Teuchos::ArrayView< T >::size(), and TEUCHOS_ASSERT_EQUALITY.
|
protectedvirtual |
Definition at line 387 of file Thyra_TpetraVector_def.hpp.
References nonnull().
|
protectedvirtual |
Definition at line 405 of file Thyra_TpetraVector_def.hpp.
|
protectedvirtual |
Definition at line 414 of file Thyra_TpetraVector_def.hpp.
|
protectedvirtual |
Definition at line 423 of file Thyra_TpetraVector_def.hpp.
|
protected |
Definition at line 432 of file Thyra_TpetraVector_def.hpp.
References Teuchos::CONJ_TRANS, CONJTRANS, Teuchos::NO_TRANS, nonnull(), NOTRANS, TEUCHOS_TEST_FOR_EXCEPTION, Teuchos::TRANS, and TRANS.
|
private |
Definition at line 483 of file Thyra_TpetraVector_def.hpp.
References nonnull(), and TEUCHOS_ASSERT.
|
private |
Definition at line 501 of file Thyra_TpetraVector_def.hpp.
References nonnull(), and Teuchos::null.
|
private |
Definition at line 524 of file Thyra_TpetraVector_def.hpp.
References nonnull(), and Teuchos::null.
|
private |
Definition at line 547 of file Thyra_TpetraVector_def.hpp.
References nonnull(), and Teuchos::null.
|
private |
Definition at line 562 of file Thyra_TpetraVector_def.hpp.
References nonnull(), and Teuchos::null.
|
related |
Nonmember constructor for TpetraVector.
Definition at line 243 of file Thyra_TpetraVector_decl.hpp.
References Teuchos::rcp().
|
related |
Nonmember constructor for TpetraVector.
Definition at line 262 of file Thyra_TpetraVector_decl.hpp.
References Teuchos::rcp().
|
private |
Definition at line 200 of file Thyra_TpetraVector_decl.hpp.
|
mutableprivate |
Definition at line 203 of file Thyra_TpetraVector_decl.hpp.
|
private |
Definition at line 206 of file Thyra_TpetraVector_decl.hpp.