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 >.
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. | |
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. | |
Overridden protected functions from LinearOpBase | |
typedef Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > | TpetraMultiVector_t |
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_ |
void | applyImpl (const EOpTransp M_trans, const MultiVectorBase< Scalar > &X, const Ptr< MultiVectorBase< Scalar > > &Y, const Scalar alpha, const Scalar beta) const |
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 |
Constructors/initializers | |
TpetraVector () | |
Construct to uninitialized. | |
void | initialize (const RCP< const TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVectorSpace, const RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVector) |
Initialize. | |
void | constInitialize (const RCP< const TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVectorSpace, const RCP< const Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVector) |
Initialize. | |
RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | getTpetraVector () |
Get the embedded non-const Tpetra::Vector. | |
RCP< const Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | getConstTpetraVector () const |
Get the embedded non-const Tpetra::Vector. | |
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 |
Concrete Thyra::SpmdVectorBase using Tpetra::Vector.
Definition at line 60 of file Thyra_TpetraVector_decl.hpp.
|
private |
Definition at line 240 of file Thyra_TpetraVector_decl.hpp.
Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraVector |
Construct to uninitialized.
Definition at line 56 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 61 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 71 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 82 of file Thyra_TpetraVector_def.hpp.
Referenced by Thyra::TpetraOperatorVectorExtraction< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getTpetraVector().
RCP< const Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getConstTpetraVector |
Get the embedded non-const Tpetra::Vector.
Definition at line 90 of file Thyra_TpetraVector_def.hpp.
Referenced by Thyra::TpetraOperatorVectorExtraction< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getConstTpetraVector().
RCP< const VectorSpaceBase< Scalar > > Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::domain |
Definition at line 99 of file Thyra_TpetraVector_def.hpp.
RCP< const SpmdVectorSpaceBase< Scalar > > Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::spmdSpaceImpl |
Definition at line 118 of file Thyra_TpetraVector_def.hpp.
void Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getNonconstLocalVectorDataImpl | ( | const Ptr< ArrayRCP< Scalar > > & | localValues | ) |
Definition at line 128 of file Thyra_TpetraVector_def.hpp.
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.
|
protectedvirtual |
Definition at line 147 of file Thyra_TpetraVector_def.hpp.
|
protectedvirtual |
Definition at line 168 of file Thyra_TpetraVector_def.hpp.
References nonnull().
|
protectedvirtual |
Definition at line 185 of file Thyra_TpetraVector_def.hpp.
References nonnull().
|
protectedvirtual |
Definition at line 202 of file Thyra_TpetraVector_def.hpp.
References nonnull().
|
protectedvirtual |
Definition at line 222 of file Thyra_TpetraVector_def.hpp.
References nonnull().
|
protectedvirtual |
Definition at line 245 of file Thyra_TpetraVector_def.hpp.
|
protected |
Definition at line 258 of file Thyra_TpetraVector_def.hpp.
|
protected |
Definition at line 269 of file Thyra_TpetraVector_def.hpp.
|
protected |
Definition at line 281 of file Thyra_TpetraVector_def.hpp.
|
protectedvirtual |
Definition at line 294 of file Thyra_TpetraVector_def.hpp.
|
protectedvirtual |
Definition at line 301 of file Thyra_TpetraVector_def.hpp.
References nonnull().
|
protectedvirtual |
Definition at line 317 of file Thyra_TpetraVector_def.hpp.
|
protectedvirtual |
Definition at line 324 of file Thyra_TpetraVector_def.hpp.
References nonnull().
|
protectedvirtual |
Definition at line 343 of file Thyra_TpetraVector_def.hpp.
References Teuchos::Array< typename T >::begin(), Teuchos::ArrayView< class T >::begin(), Teuchos::Copy, Teuchos::Array< typename T >::end(), Teuchos::RCP< class T >::is_null(), nonnull(), Teuchos::rcp(), Teuchos::Array< typename T >::size(), Teuchos::ArrayView< class T >::size(), and TEUCHOS_ASSERT_EQUALITY.
|
protectedvirtual |
Definition at line 419 of file Thyra_TpetraVector_def.hpp.
References nonnull().
|
protectedvirtual |
Definition at line 437 of file Thyra_TpetraVector_def.hpp.
|
protectedvirtual |
Definition at line 446 of file Thyra_TpetraVector_def.hpp.
|
protectedvirtual |
Definition at line 455 of file Thyra_TpetraVector_def.hpp.
|
protected |
Definition at line 464 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 515 of file Thyra_TpetraVector_def.hpp.
References nonnull(), and TEUCHOS_ASSERT.
|
private |
Definition at line 532 of file Thyra_TpetraVector_def.hpp.
References nonnull().
|
private |
Definition at line 555 of file Thyra_TpetraVector_def.hpp.
References nonnull().
|
private |
Definition at line 578 of file Thyra_TpetraVector_def.hpp.
References nonnull().
|
private |
Definition at line 593 of file Thyra_TpetraVector_def.hpp.
References nonnull().
|
related |
Nonmember constructor for TpetraVector.
Definition at line 275 of file Thyra_TpetraVector_decl.hpp.
References Teuchos::rcp().
|
related |
Nonmember constructor for TpetraVector.
Definition at line 294 of file Thyra_TpetraVector_decl.hpp.
References Teuchos::rcp().
|
private |
Definition at line 232 of file Thyra_TpetraVector_decl.hpp.
|
mutableprivate |
Definition at line 235 of file Thyra_TpetraVector_decl.hpp.
|
private |
Definition at line 238 of file Thyra_TpetraVector_decl.hpp.