| 
    Thyra
    Version of the Day
    
   | 
 
Concrete implementation of Thyra::MultiVector in terms of Tpetra::MultiVector. More...
#include <Thyra_TpetraMultiVector_decl.hpp>

Related Functions | |
(Note that these are not member functions.)  | |
| template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
| RCP< TpetraMultiVector< Scalar,  LocalOrdinal, GlobalOrdinal, Node > >  | tpetraMultiVector (const RCP< const TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVectorSpace, const RCP< const ScalarProdVectorSpaceBase< Scalar > > &domainSpace, const RCP< Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraMultiVector) | 
| Nonmember constructor for non-const TpetraMultiVector.  More... | |
| template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
| RCP< const TpetraMultiVector < Scalar, LocalOrdinal, GlobalOrdinal, Node > >  | constTpetraMultiVector (const RCP< const TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVectorSpace, const RCP< const ScalarProdVectorSpaceBase< Scalar > > &domainSpace, const RCP< const Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraMultiVector) | 
| Nonmember constructor for const TpetraMultiVector.  More... | |
  Related Functions inherited from Thyra::MultiVectorBase< Scalar > | |
| template<class Scalar > | |
| 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=0) | 
| Apply a reduction/transformation operator column by column and return an array of the reduction objects.  More... | |
| template<class Scalar > | |
| 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=0) | 
| Apply a reduction/transformation operator column by column and reduce the intermediate reduction objects into one reduction object.  More... | |
| template<class Scalar > | |
| void | norms (const MultiVectorBase< Scalar > &V, const ArrayView< typename ScalarTraits< Scalar >::magnitudeType > &norms) | 
| Column-wise multi-vector natural norm.  More... | |
| template<class Scalar , class NormOp > | |
| void | reductions (const MultiVectorBase< Scalar > &V, const NormOp &op, const ArrayView< typename ScalarTraits< Scalar >::magnitudeType > &norms) | 
| Column-wise multi-vector reductions.  More... | |
| template<class Scalar > | |
| void | norms_1 (const MultiVectorBase< Scalar > &V, const ArrayView< typename ScalarTraits< Scalar >::magnitudeType > &norms) | 
| Column-wise multi-vector one norm.  More... | |
| template<class Scalar > | |
| void | norms_2 (const MultiVectorBase< Scalar > &V, const ArrayView< typename ScalarTraits< Scalar >::magnitudeType > &norms) | 
| Column-wise multi-vector 2 (Euclidean) norm.  More... | |
| template<class Scalar > | |
| void | norms_inf (const MultiVectorBase< Scalar > &V, const ArrayView< typename ScalarTraits< Scalar >::magnitudeType > &norms) | 
| Column-wise multi-vector infinity norm.  More... | |
| template<class Scalar > | |
| Array< typename ScalarTraits < Scalar >::magnitudeType >  | norms_inf (const MultiVectorBase< Scalar > &V) | 
| Column-wise multi-vector infinity norm.  More... | |
| template<class Scalar > | |
| void | dots (const MultiVectorBase< Scalar > &V1, const MultiVectorBase< Scalar > &V2, const ArrayView< Scalar > &dots) | 
| Multi-vector dot product.  More... | |
| template<class Scalar > | |
| void | sums (const MultiVectorBase< Scalar > &V, const ArrayView< Scalar > &sums) | 
| Multi-vector column sum.  More... | |
| template<class Scalar > | |
| ScalarTraits< Scalar > ::magnitudeType  | norm_1 (const MultiVectorBase< Scalar > &V) | 
| Take the induced matrix one norm of a multi-vector.  More... | |
| template<class Scalar > | |
| void | scale (Scalar alpha, const Ptr< MultiVectorBase< Scalar > > &V) | 
| V = alpha*V.  More... | |
| template<class Scalar > | |
| void | scaleUpdate (const VectorBase< Scalar > &a, const MultiVectorBase< Scalar > &U, const Ptr< MultiVectorBase< Scalar > > &V) | 
| A*U + V -> V (where A is a diagonal matrix with diagonal a).  More... | |
| template<class Scalar > | |
| void | assign (const Ptr< MultiVectorBase< Scalar > > &V, Scalar alpha) | 
| V = alpha.  More... | |
| template<class Scalar > | |
| void | assign (const Ptr< MultiVectorBase< Scalar > > &V, const MultiVectorBase< Scalar > &U) | 
| V = U.  More... | |
| template<class Scalar > | |
| void | update (Scalar alpha, const MultiVectorBase< Scalar > &U, const Ptr< MultiVectorBase< Scalar > > &V) | 
| alpha*U + V -> V.  More... | |
| template<class Scalar > | |
| void | update (const ArrayView< const Scalar > &alpha, Scalar beta, const MultiVectorBase< Scalar > &U, const Ptr< MultiVectorBase< Scalar > > &V) | 
| alpha[j]*beta*U(j) + V(j) - > V(j), for j = 0 ,,,  More... | |
| template<class Scalar > | |
| void | update (const MultiVectorBase< Scalar > &U, const ArrayView< const Scalar > &alpha, Scalar beta, const Ptr< MultiVectorBase< Scalar > > &V) | 
| U(j) + alpha[j]*beta*V(j) - > V(j), for j = 0 ,,, U.domain()->dim()-1.  More... | |
| template<class Scalar > | |
| void | linear_combination (const ArrayView< const Scalar > &alpha, const ArrayView< const Ptr< const MultiVectorBase< Scalar > > > &X, const Scalar &beta, const Ptr< MultiVectorBase< Scalar > > &Y) | 
Y.col(j)(i) = beta*Y.col(j)(i) + sum( alpha[k]*X[k].col(j)(i), k=0...m-1 ), for i = 0...Y->range()->dim()-1, j = 0...Y->domain()->dim()-1.  More... | |
| template<class Scalar > | |
| void | randomize (Scalar l, Scalar u, const Ptr< MultiVectorBase< Scalar > > &V) | 
| Generate a random multi-vector with elements uniformly distributed elements.  More... | |
| template<class Scalar > | |
| void | Vt_S (const Ptr< MultiVectorBase< Scalar > > &Z, const Scalar &alpha) | 
Z(i,j) *= alpha, i = 0...Z->range()->dim()-1, j = 0...Z->domain()->dim()-1.  More... | |
| template<class Scalar > | |
| void | Vp_S (const Ptr< MultiVectorBase< Scalar > > &Z, const Scalar &alpha) | 
Z(i,j) += alpha, i = 0...Z->range()->dim()-1, j = 0...Z->domain()->dim()-1.  More... | |
| template<class Scalar > | |
| void | Vp_V (const Ptr< MultiVectorBase< Scalar > > &Z, const MultiVectorBase< Scalar > &X) | 
Z(i,j) += X(i,j), i = 0...Z->range()->dim()-1, j = 0...Z->domain()->dim()-1.  More... | |
| template<class Scalar > | |
| void | V_VpV (const Ptr< MultiVectorBase< Scalar > > &Z, const MultiVectorBase< Scalar > &X, const MultiVectorBase< Scalar > &Y) | 
Z(i,j) = X(i,j) + Y(i,j), i = 0...Z->range()->dim()-1, j = 0...Z->domain()->dim()-1.  More... | |
| template<class Scalar > | |
| void | V_VmV (const Ptr< MultiVectorBase< Scalar > > &Z, const MultiVectorBase< Scalar > &X, const MultiVectorBase< Scalar > &Y) | 
Z(i,j) = X(i,j) - Y(i,j), i = 0...Z->range()->dim()-1, j = 0...Z->domain()->dim()-1.  More... | |
| template<class Scalar > | |
| void | V_StVpV (const Ptr< MultiVectorBase< Scalar > > &Z, const Scalar &alpha, const MultiVectorBase< Scalar > &X, const MultiVectorBase< Scalar > &Y) | 
Z(i,j) = alpha*X(i,j) + Y(i), i = 0...z->space()->dim()-1, , j = 0...Z->domain()->dim()-1.  More... | |
  Related Functions inherited from Thyra::LinearOpBase< Scalar > | |
| template<class Scalar > | |
| bool | isFullyUninitialized (const LinearOpBase< Scalar > &M) | 
| Determines if a linear operator is in the "Fully Uninitialized" state or not.  More... | |
| template<class Scalar > | |
| bool | isPartiallyInitialized (const LinearOpBase< Scalar > &M) | 
| Determines if a linear operator is in the "Partially Initialized" state or not.  More... | |
| template<class Scalar > | |
| bool | isFullyInitialized (const LinearOpBase< Scalar > &M) | 
| Determines if a linear operator is in the "Fully Initialized" state or not.  More... | |
| template<class Scalar > | |
| bool | opSupported (const LinearOpBase< Scalar > &M, EOpTransp M_trans) | 
| Determines if an operation is supported for a single scalar type.  More... | |
| template<class Scalar > | |
| void | apply (const LinearOpBase< Scalar > &M, const EOpTransp M_trans, const MultiVectorBase< Scalar > &X, const Ptr< MultiVectorBase< Scalar > > &Y, const Scalar alpha=static_cast< Scalar >(1.0), const Scalar beta=static_cast< Scalar >(0.0)) | 
Non-member function call for M.apply(...).  More... | |
| void | apply (const LinearOpBase< double > &M, const EOpTransp M_trans, const MultiVectorBase< double > &X, const Ptr< MultiVectorBase< double > > &Y, const double alpha=1.0, const double beta=0.0) | 
Calls apply<double>(...).  More... | |
Constructors/initializers/accessors | |
| TpetraMultiVector () | |
| Construct to uninitialized.  More... | |
| void | initialize (const RCP< const TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVectorSpace, const RCP< const ScalarProdVectorSpaceBase< Scalar > > &domainSpace, const RCP< Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraMultiVector) | 
| Initialize.  More... | |
| void | constInitialize (const RCP< const TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraVectorSpace, const RCP< const ScalarProdVectorSpaceBase< Scalar > > &domainSpace, const RCP< const Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraMultiVector) | 
| Initialize.  More... | |
| RCP< Tpetra::MultiVector < Scalar, LocalOrdinal, GlobalOrdinal, Node > >  | getTpetraMultiVector () | 
| Extract the underlying non-const Tpetra::MultiVector object.  More... | |
| RCP< const Tpetra::MultiVector < Scalar, LocalOrdinal, GlobalOrdinal, Node > >  | getConstTpetraMultiVector () const | 
| Extract the underlying const Tpetra::MultiVector object.  More... | |
Overridden public functions form MultiVectorAdapterBase | |
| RCP< const  ScalarProdVectorSpaceBase < Scalar > >  | domainScalarProdVecSpc () const | 
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 | 
| RCP< const VectorBase< Scalar > > | colImpl (Ordinal j) const | 
| RCP< VectorBase< Scalar > > | nonconstColImpl (Ordinal j) | 
| RCP< const MultiVectorBase < Scalar > >  | contigSubViewImpl (const Range1D &colRng) const | 
| RCP< MultiVectorBase< Scalar > > | nonconstContigSubViewImpl (const Range1D &colRng) | 
| RCP< const MultiVectorBase < Scalar > >  | nonContigSubViewImpl (const ArrayView< const int > &cols_in) const | 
| RCP< MultiVectorBase< Scalar > > | nonconstNonContigSubViewImpl (const ArrayView< const int > &cols_in) | 
| 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 | 
| void | acquireDetachedMultiVectorViewImpl (const Range1D &rowRng, const Range1D &colRng, RTOpPack::ConstSubMultiVectorView< Scalar > *sub_mv) const | 
| void | acquireNonconstDetachedMultiVectorViewImpl (const Range1D &rowRng, const Range1D &colRng, RTOpPack::SubMultiVectorView< Scalar > *sub_mv) | 
| void | commitNonconstDetachedMultiVectorViewImpl (RTOpPack::SubMultiVectorView< Scalar > *sub_mv) | 
Overridden protected functions from SpmdMultiVectorBase | |
| RCP< const SpmdVectorSpaceBase < Scalar > >  | spmdSpaceImpl () 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 | 
Overridden protected functions from MultiVectorAdapterBase | |
| virtual void | euclideanApply (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::SpmdMultiVectorDefaultBase< Scalar > | |
| SpmdMultiVectorDefaultBase () | |
| RCP< const  ScalarProdVectorSpaceBase < Scalar > >  | rangeScalarProdVecSpc () const | 
Returns spmdSpace.  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::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::MultiVectorAdapterBase< Scalar > | |
| RCP< const VectorSpaceBase < Scalar > >  | range () const | 
Returns this->rangeScalarProdVecSpc()  More... | |
| RCP< const VectorSpaceBase < Scalar > >  | domain () const | 
Returns this->domainScalarProdVecSpc()  More... | |
  Public Member Functions inherited from Thyra::MultiVectorDefaultBase< Scalar > | |
| virtual RCP< MultiVectorBase < Scalar > >  | clone_mv () const | 
  Protected Member Functions inherited from Thyra::SpmdMultiVectorDefaultBase< Scalar > | |
| RTOpPack::SubMultiVectorView < Scalar >  | getNonconstLocalSubMultiVectorImpl () | 
| RTOpPack::ConstSubMultiVectorView < Scalar >  | getLocalSubMultiVectorImpl () const | 
| void | releaseDetachedMultiVectorViewImpl (RTOpPack::ConstSubMultiVectorView< Scalar > *sub_mv) const | 
| virtual void | updateSpmdSpace () | 
| Subclasses should call whenever the structure of the VectorSpaceBase changes.  More... | |
| Range1D | validateRowRange (const Range1D &rowRng) const | 
| Validate and resize the row range.  More... | |
| Range1D | validateColRange (const Range1D &rowCol) const | 
| Validate and resize the column range.  More... | |
  Protected Member Functions inherited from Thyra::SpmdMultiVectorBase< 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 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::MultiVectorAdapterBase< Scalar > | |
| bool | opSupportedImpl (EOpTransp M_trans) const | 
| void | applyImpl (const EOpTransp M_trans, const MultiVectorBase< Scalar > &X, const Ptr< MultiVectorBase< Scalar > > &Y, const Scalar alpha, const Scalar beta) const | 
  Protected Member Functions inherited from Thyra::MultiVectorDefaultBase< Scalar > | |
| 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 > | |
| std::string | description () const | 
| Default description that gives the label, type, and dimenstion .  More... | |
| void | describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const | 
| Generates a default outputting for all linear operators.  More... | |
Concrete implementation of Thyra::MultiVector in terms of Tpetra::MultiVector.
Definition at line 30 of file Thyra_TpetraMultiVector_decl.hpp.
| Thyra::TpetraMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraMultiVector | ( | ) | 
Construct to uninitialized.
Definition at line 27 of file Thyra_TpetraMultiVector_def.hpp.
| void Thyra::TpetraMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::initialize | ( | const RCP< const TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > > & | tpetraVectorSpace, | 
| const RCP< const ScalarProdVectorSpaceBase< Scalar > > & | domainSpace, | ||
| const RCP< Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > & | tpetraMultiVector | ||
| ) | 
Initialize.
Definition at line 32 of file Thyra_TpetraMultiVector_def.hpp.
| void Thyra::TpetraMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::constInitialize | ( | const RCP< const TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > > & | tpetraVectorSpace, | 
| const RCP< const ScalarProdVectorSpaceBase< Scalar > > & | domainSpace, | ||
| const RCP< const Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > & | tpetraMultiVector | ||
| ) | 
Initialize.
Definition at line 43 of file Thyra_TpetraMultiVector_def.hpp.
| RCP< Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > Thyra::TpetraMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getTpetraMultiVector | ( | ) | 
Extract the underlying non-const Tpetra::MultiVector object.
Definition at line 55 of file Thyra_TpetraMultiVector_def.hpp.
| RCP< const Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > Thyra::TpetraMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getConstTpetraMultiVector | ( | ) | const | 
Extract the underlying const Tpetra::MultiVector object.
Definition at line 63 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  virtual | 
Implements Thyra::MultiVectorAdapterBase< Scalar >.
Definition at line 74 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Implements Thyra::MultiVectorBase< Scalar >.
Definition at line 85 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Implements Thyra::MultiVectorBase< Scalar >.
Definition at line 93 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Implements Thyra::MultiVectorBase< Scalar >.
Definition at line 109 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Implements Thyra::MultiVectorBase< Scalar >.
Definition at line 116 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Implements Thyra::MultiVectorBase< Scalar >.
Definition at line 135 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Implements Thyra::MultiVectorBase< Scalar >.
Definition at line 211 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Implements Thyra::MultiVectorBase< Scalar >.
Definition at line 229 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Implements Thyra::MultiVectorBase< Scalar >.
Definition at line 238 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Implements Thyra::MultiVectorBase< Scalar >.
Definition at line 247 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Reimplemented from Thyra::MultiVectorBase< Scalar >.
Definition at line 257 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Implements Thyra::MultiVectorBase< Scalar >.
Definition at line 271 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Implements Thyra::MultiVectorBase< Scalar >.
Definition at line 285 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Implements Thyra::MultiVectorBase< Scalar >.
Definition at line 315 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Implements Thyra::MultiVectorBase< Scalar >.
Definition at line 345 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Implements Thyra::MultiVectorBase< Scalar >.
Definition at line 378 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Reimplemented from Thyra::SpmdMultiVectorDefaultBase< Scalar >.
Definition at line 411 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Reimplemented from Thyra::SpmdMultiVectorDefaultBase< Scalar >.
Definition at line 427 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Reimplemented from Thyra::SpmdMultiVectorDefaultBase< Scalar >.
Definition at line 440 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Reimplemented from Thyra::SpmdMultiVectorDefaultBase< Scalar >.
Definition at line 453 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Implements Thyra::SpmdMultiVectorBase< Scalar >.
Definition at line 512 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Implements Thyra::SpmdMultiVectorBase< Scalar >.
Definition at line 519 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Implements Thyra::SpmdMultiVectorBase< Scalar >.
Definition at line 529 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  protectedvirtual | 
Reimplemented from Thyra::SpmdMultiVectorDefaultBase< Scalar >.
Definition at line 539 of file Thyra_TpetraMultiVector_def.hpp.
      
  | 
  related | 
Nonmember constructor for non-const TpetraMultiVector.
Definition at line 240 of file Thyra_TpetraMultiVector_decl.hpp.
      
  | 
  related | 
Nonmember constructor for const TpetraMultiVector.
Definition at line 259 of file Thyra_TpetraMultiVector_decl.hpp.
 1.8.5