Xpetra  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Macros Pages
Xpetra::TpetraVector< Scalar, int, long long, EpetraNode > Class Template Reference

#include <Xpetra_TpetraVector_def.hpp>

Inheritance diagram for Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >:
Xpetra::Vector< Scalar, int, long long, EpetraNode > Xpetra::TpetraMultiVector< Scalar, int, long long, EpetraNode > Xpetra::MultiVector< Scalar, int, long long, EpetraNode > Xpetra::MultiVector< Scalar, int, long long, EpetraNode > Xpetra::DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > Xpetra::DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node >

Public Member Functions

Scalar dot (const Vector &a) const
 Computes dot product of this Vector against input Vector x. More...
 
- Public Member Functions inherited from Xpetra::Vector< Scalar, int, long long, EpetraNode >
std::conditional< std::is_same
< typename
dual_view_type::t_dev_um::execution_space::memory_space,
typename
TargetDeviceType::memory_space >
::value, typename
dual_view_type::t_dev_um,
typename
dual_view_type::t_host_um >
::type 
getLocalView (AccessType access_type) const
 
virtual ~Vector ()
 Destructor. More...
 
virtual Scalar dot (const Vector< Scalar, int, long long, EpetraNode > &a) const =0
 Computes dot product of this Vector against input Vector x. More...
 
- Public Member Functions inherited from Xpetra::MultiVector< Scalar, int, long long, EpetraNode >
virtual void Xpetra_randomize ()
 Set multi-vector values to random numbers. XPetra implementation. More...
 
virtual void Xpetra_randomize (const Scalar &minVal, const Scalar &maxVal)
 Set multi-vector values to random numbers. XPetra implementation. More...
 
virtual
dual_view_type::t_host_const_um 
getHostLocalView (Access::ReadOnlyStruct) const
 
virtual dual_view_type::t_host_um getHostLocalView (Access::OverwriteAllStruct) const
 
virtual dual_view_type::t_host_um getHostLocalView (Access::ReadWriteStruct) const
 
virtual
dual_view_type::t_dev_const_um 
getDeviceLocalView (Access::ReadOnlyStruct) const
 
virtual dual_view_type::t_dev_um getDeviceLocalView (Access::OverwriteAllStruct) const
 
virtual dual_view_type::t_dev_um getDeviceLocalView (Access::ReadWriteStruct) const
 
virtual ~MultiVector ()
 Destructor. More...
 
MultiVector< Scalar, int, long
long, EpetraNode > & 
operator= (const MultiVector< Scalar, int, long long, EpetraNode > &rhs)
 Assignment operator: Does a deep copy. More...
 
virtual void replaceMap (const RCP< const Map< int, long long, EpetraNode >> &map)=0
 
- Public Member Functions inherited from Xpetra::DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node >
virtual ~DistObject ()
 Destructor. More...
 
virtual void doImport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)=0
 Import data into this object using an Import object ("forward mode"). More...
 
virtual void beginImport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)
 Import data into this object using an Import object ("forward mode"). More...
 
virtual void endImport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)
 Import data into this object using an Import object ("forward mode"). More...
 
virtual void doExport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM)=0
 Export data into this object using an Export object ("forward mode"). More...
 
virtual void beginExport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM)
 Export data into this object using an Export object ("forward mode"). More...
 
virtual void endExport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM)
 Export data into this object using an Export object ("forward mode"). More...
 
virtual void doImport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM)=0
 Import data into this object using an Export object ("reverse mode"). More...
 
virtual void beginImport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM)
 Import data into this object using an Export object ("reverse mode"). More...
 
virtual void endImport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM)
 Import data into this object using an Export object ("reverse mode"). More...
 
virtual void doExport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)=0
 Export data into this object using an Import object ("reverse mode"). More...
 
virtual void beginExport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)
 Export data into this object using an Import object ("reverse mode"). More...
 
virtual void endExport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)
 Export data into this object using an Import object ("reverse mode"). More...
 
- Public Member Functions inherited from Xpetra::TpetraMultiVector< Scalar, int, long long, EpetraNode >
void elementWiseMultiply (Scalar scalarAB, const Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &B, Scalar scalarThis)
 Element-wise multiply of a Vector A with a TpetraMultiVector B. More...
 
void randomize (bool bUseXpetraImplementation=false)
 Set multi-vector values to random numbers. More...
 
void randomize (const Scalar &minVal, const Scalar &maxVal, bool bUseXpetraImplementation=false)
 Set multi-vector values to random numbers. More...
 
Teuchos::RCP< const Map
< LocalOrdinal, GlobalOrdinal,
Node > > 
getMap () const
 The Map describing the parallel distribution of this object. More...
 
void doImport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)
 
void beginImport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)
 
void endImport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)
 
void doExport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &dest, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)
 
void beginExport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &dest, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)
 
void endExport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &dest, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)
 
void doImport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM)
 
void beginImport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM)
 
void endImport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM)
 
void doExport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &dest, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM)
 
void beginExport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &dest, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM)
 
void endExport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &dest, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM)
 
void replaceMap (const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &map)
 
 TpetraMultiVector (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &map, size_t NumVectors, bool zeroOut=true)
 Basic constuctor. More...
 
 TpetraMultiVector (const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &source, const Teuchos::DataAccess copyOrView)
 Copy constructor (performs a deep copy). More...
 
 TpetraMultiVector (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &map, const Teuchos::ArrayView< const Scalar > &A, size_t LDA, size_t NumVectors)
 Create multivector by copying two-dimensional array of local data. More...
 
 TpetraMultiVector (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &map, const Teuchos::ArrayView< const Teuchos::ArrayView< const Scalar > > &ArrayOfPtrs, size_t NumVectors)
 Create multivector by copying array of views of local data. More...
 
virtual ~TpetraMultiVector ()
 Destructor (virtual for memory safety of derived classes). More...
 
void replaceGlobalValue (GlobalOrdinal globalRow, size_t vectorIndex, const Scalar &value)
 Replace value, using global (row) index. More...
 
void sumIntoGlobalValue (GlobalOrdinal globalRow, size_t vectorIndex, const Scalar &value)
 Add value to existing value, using global (row) index. More...
 
void replaceLocalValue (LocalOrdinal myRow, size_t vectorIndex, const Scalar &value)
 Replace value, using local (row) index. More...
 
void sumIntoLocalValue (LocalOrdinal myRow, size_t vectorIndex, const Scalar &value)
 Add value to existing value, using local (row) index. More...
 
void putScalar (const Scalar &value)
 Set all values in the multivector with the given value. More...
 
void reduce ()
 Sum values of a locally replicated multivector across all processes. More...
 
Teuchos::RCP< const Vector
< Scalar, LocalOrdinal,
GlobalOrdinal, Node > > 
getVector (size_t j) const
 Return a Vector which is a const view of column j. More...
 
Teuchos::RCP< Vector< Scalar,
LocalOrdinal, GlobalOrdinal,
Node > > 
getVectorNonConst (size_t j)
 Return a Vector which is a nonconst view of column j. More...
 
Teuchos::ArrayRCP< const Scalar > getData (size_t j) const
 Const view of the local values in a particular vector of this multivector. More...
 
Teuchos::ArrayRCP< Scalar > getDataNonConst (size_t j)
 View of the local values in a particular vector of this multivector. More...
 
void get1dCopy (Teuchos::ArrayView< Scalar > A, size_t LDA) const
 Fill the given array with a copy of this multivector's local values. More...
 
void get2dCopy (Teuchos::ArrayView< const Teuchos::ArrayView< Scalar > > ArrayOfPtrs) const
 Fill the given array with a copy of this multivector's local values. More...
 
Teuchos::ArrayRCP< const Scalar > get1dView () const
 Const persisting (1-D) view of this multivector's local values. More...
 
Teuchos::ArrayRCP
< Teuchos::ArrayRCP< const
Scalar > > 
get2dView () const
 Return const persisting pointers to values. More...
 
Teuchos::ArrayRCP< Scalar > get1dViewNonConst ()
 Nonconst persisting (1-D) view of this multivector's local values. More...
 
Teuchos::ArrayRCP
< Teuchos::ArrayRCP< Scalar > > 
get2dViewNonConst ()
 Return non-const persisting pointers to values. More...
 
void dot (const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Teuchos::ArrayView< Scalar > &dots) const
 Compute dot product of each corresponding pair of vectors, dots[i] = this[i].dot(A[i]). More...
 
void abs (const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A)
 Put element-wise absolute values of input Multi-vector in target: A = abs(this). More...
 
void reciprocal (const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A)
 Put element-wise reciprocal values of input Multi-vector in target, this(i,j) = 1/A(i,j). More...
 
void scale (const Scalar &alpha)
 Scale the current values of a multi-vector, this = alpha*this. More...
 
void scale (Teuchos::ArrayView< const Scalar > alpha)
 Scale the current values of a multi-vector, this[j] = alpha[j]*this[j]. More...
 
void scale (const Scalar &alpha, const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A)
 Replace multi-vector values with scaled values of A, this = alpha*A. More...
 
void update (const Scalar &alpha, const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Scalar &beta)
 Update multi-vector values with scaled values of A, this = beta*this + alpha*A. More...
 
void update (const Scalar &alpha, const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Scalar &beta, const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &B, const Scalar &gamma)
 Update multi-vector with scaled values of A and B, this = gamma*this + alpha*A + beta*B. More...
 
void norm1 (const Teuchos::ArrayView< typename Teuchos::ScalarTraits< Scalar >::magnitudeType > &norms) const
 Compute 1-norm of each vector in multi-vector. More...
 
void norm2 (const Teuchos::ArrayView< typename Teuchos::ScalarTraits< Scalar >::magnitudeType > &norms) const
 
void normInf (const Teuchos::ArrayView< typename Teuchos::ScalarTraits< Scalar >::magnitudeType > &norms) const
 Compute Inf-norm of each vector in multi-vector. More...
 
void meanValue (const Teuchos::ArrayView< Scalar > &means) const
 Compute mean (average) value of each vector in multi-vector. The outcome of this routine is undefined for non-floating point scalar types (e.g., int). More...
 
void multiply (Teuchos::ETransp transA, Teuchos::ETransp transB, const Scalar &alpha, const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &B, const Scalar &beta)
 Matrix-matrix multiplication: this = beta*this + alpha*op(A)*op(B). More...
 
size_t getNumVectors () const
 Number of columns in the multivector. More...
 
size_t getLocalLength () const
 Local number of rows on the calling process. More...
 
global_size_t getGlobalLength () const
 Global number of rows in the multivector. More...
 
bool isSameSize (const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &vec) const
 
 TpetraMultiVector (const Teuchos::RCP< Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &vec)
 TpetraMultiVector constructor to wrap a Tpetra::MultiVector object. More...
 
RCP< Tpetra::MultiVector
< Scalar, LocalOrdinal,
GlobalOrdinal, Node > > 
getTpetra_MultiVector () const
 Get the underlying Tpetra multivector. More...
 
void setSeed (unsigned int seed)
 Set seed for Random function. More...
 

Private Types

typedef int LocalOrdinal
 
typedef long long GlobalOrdinal
 
typedef EpetraNode Node
 

Constructor/Destructor Methods

 TpetraVector (const Teuchos::RCP< const Map > &map, bool zeroOut=true)
 Sets all vector entries to zero. More...
 
 TpetraVector (const Teuchos::RCP< const Map > &map, const Teuchos::ArrayView< const Scalar > &A)
 Set multi-vector values from an array using Teuchos memory management classes. (copy) More...
 
virtual ~TpetraVector ()
 Destructor. More...
 

Post-construction modification routines

void replaceGlobalValue (GlobalOrdinal globalRow, const Scalar &value)
 Replace current value at the specified location with specified value. More...
 
void sumIntoGlobalValue (GlobalOrdinal globalRow, const Scalar &value)
 Adds specified value to existing value at the specified location. More...
 
void replaceLocalValue (LocalOrdinal myRow, const Scalar &value)
 Replace current value at the specified location with specified values. More...
 
void sumIntoLocalValue (LocalOrdinal myRow, const Scalar &value)
 Adds specified value to existing value at the specified location. More...
 

Mathematical methods

Teuchos::ScalarTraits< Scalar >
::magnitudeType 
norm1 () const
 Return 1-norm of this Vector. More...
 
Teuchos::ScalarTraits< Scalar >
::magnitudeType 
norm2 () const
 Compute 2-norm of this Vector. More...
 
Teuchos::ScalarTraits< Scalar >
::magnitudeType 
normInf () const
 Compute Inf-norm of this Vector. More...
 
Scalar meanValue () const
 Compute mean (average) value of this Vector. More...
 

Overridden from Teuchos::Describable

std::string description () const
 Return a simple one-line description of this object. More...
 
void describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default) const
 Print the object with some verbosity level to an FancyOStream object. More...
 

Xpetra specific

Compute Weighted 2-norm (RMS Norm) of this Vector.

 TpetraVector (const Teuchos::RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node >> &vec)
 TpetraMultiVector constructor to wrap a Tpetra::MultiVector object. More...
 
RCP< Tpetra::Vector< Scalar,
LocalOrdinal, GlobalOrdinal,
Node > > 
getTpetra_Vector () const
 Get the underlying Tpetra multivector. More...
 

Additional Inherited Members

- Public Types inherited from Xpetra::Vector< Scalar, int, long long, EpetraNode >
using scalar_type = Scalar
 
using local_ordinal_type = int
 
using global_ordinal_type = long long
 
using node_type = EpetraNode
 
typedef Xpetra::MultiVector
< Scalar, int, long long,
EpetraNode >::dual_view_type 
dual_view_type
 
- Public Types inherited from Xpetra::MultiVector< Scalar, int, long long, EpetraNode >
typedef Scalar scalar_type
 
typedef int local_ordinal_type
 
typedef long long global_ordinal_type
 
typedef EpetraNode node_type
 
using impl_scalar_type = typename Kokkos::ArithTraits< Scalar >::val_type
 
using dual_view_type = Kokkos::DualView< impl_scalar_type **, Kokkos::LayoutStride, typename node_type::device_type, Kokkos::MemoryUnmanaged >
 
using dual_view_type_const = Kokkos::DualView< const impl_scalar_type **, Kokkos::LayoutStride, typename node_type::device_type, Kokkos::MemoryUnmanaged >
 
using host_execution_space = typename dual_view_type::host_mirror_space
 
using dev_execution_space = typename dual_view_type::t_dev::execution_space
 
- Protected Member Functions inherited from Xpetra::TpetraMultiVector< Scalar, int, long long, EpetraNode >
virtual void assign (const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &rhs)
 Implementation of the assignment operator (operator=); does a deep copy. More...
 

Detailed Description

template<class Scalar>
class Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >

Definition at line 298 of file Xpetra_TpetraVector_def.hpp.

Member Typedef Documentation

template<class Scalar >
typedef int Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::LocalOrdinal
private

Definition at line 300 of file Xpetra_TpetraVector_def.hpp.

template<class Scalar >
typedef long long Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::GlobalOrdinal
private

Definition at line 301 of file Xpetra_TpetraVector_def.hpp.

template<class Scalar >
typedef EpetraNode Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::Node
private

Definition at line 302 of file Xpetra_TpetraVector_def.hpp.

Constructor & Destructor Documentation

template<class Scalar >
Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::TpetraVector ( const Teuchos::RCP< const Map > &  map,
bool  zeroOut = true 
)
inline

Sets all vector entries to zero.

Definition at line 325 of file Xpetra_TpetraVector_def.hpp.

template<class Scalar >
Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::TpetraVector ( const Teuchos::RCP< const Map > &  map,
const Teuchos::ArrayView< const Scalar > &  A 
)
inline

Set multi-vector values from an array using Teuchos memory management classes. (copy)

Definition at line 334 of file Xpetra_TpetraVector_def.hpp.

template<class Scalar >
virtual Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::~TpetraVector ( )
inlinevirtual

Destructor.

Definition at line 343 of file Xpetra_TpetraVector_def.hpp.

template<class Scalar >
Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::TpetraVector ( const Teuchos::RCP< Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node >> &  vec)
inline

TpetraMultiVector constructor to wrap a Tpetra::MultiVector object.

Definition at line 407 of file Xpetra_TpetraVector_def.hpp.

Member Function Documentation

template<class Scalar >
void Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::replaceGlobalValue ( GlobalOrdinal  globalRow,
const Scalar &  value 
)
inlinevirtual

Replace current value at the specified location with specified value.

Implements Xpetra::Vector< Scalar, int, long long, EpetraNode >.

Definition at line 351 of file Xpetra_TpetraVector_def.hpp.

template<class Scalar >
void Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::sumIntoGlobalValue ( GlobalOrdinal  globalRow,
const Scalar &  value 
)
inlinevirtual

Adds specified value to existing value at the specified location.

Implements Xpetra::Vector< Scalar, int, long long, EpetraNode >.

Definition at line 354 of file Xpetra_TpetraVector_def.hpp.

template<class Scalar >
void Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::replaceLocalValue ( LocalOrdinal  myRow,
const Scalar &  value 
)
inlinevirtual

Replace current value at the specified location with specified values.

Implements Xpetra::Vector< Scalar, int, long long, EpetraNode >.

Definition at line 357 of file Xpetra_TpetraVector_def.hpp.

template<class Scalar >
void Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::sumIntoLocalValue ( LocalOrdinal  myRow,
const Scalar &  value 
)
inlinevirtual

Adds specified value to existing value at the specified location.

Implements Xpetra::Vector< Scalar, int, long long, EpetraNode >.

Definition at line 360 of file Xpetra_TpetraVector_def.hpp.

template<class Scalar >
Teuchos::ScalarTraits<Scalar>::magnitudeType Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::norm1 ( ) const
inlinevirtual

Return 1-norm of this Vector.

Implements Xpetra::Vector< Scalar, int, long long, EpetraNode >.

Definition at line 368 of file Xpetra_TpetraVector_def.hpp.

template<class Scalar >
Teuchos::ScalarTraits<Scalar>::magnitudeType Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::norm2 ( ) const
inlinevirtual

Compute 2-norm of this Vector.

Implements Xpetra::Vector< Scalar, int, long long, EpetraNode >.

Definition at line 373 of file Xpetra_TpetraVector_def.hpp.

template<class Scalar >
Teuchos::ScalarTraits<Scalar>::magnitudeType Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::normInf ( ) const
inlinevirtual

Compute Inf-norm of this Vector.

Implements Xpetra::Vector< Scalar, int, long long, EpetraNode >.

Definition at line 378 of file Xpetra_TpetraVector_def.hpp.

template<class Scalar >
Scalar Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::meanValue ( ) const
inlinevirtual

Compute mean (average) value of this Vector.

Implements Xpetra::Vector< Scalar, int, long long, EpetraNode >.

Definition at line 383 of file Xpetra_TpetraVector_def.hpp.

template<class Scalar >
std::string Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::description ( ) const
inlinevirtual

Return a simple one-line description of this object.

Reimplemented from Xpetra::TpetraMultiVector< Scalar, int, long long, EpetraNode >.

Definition at line 391 of file Xpetra_TpetraVector_def.hpp.

template<class Scalar >
void Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::describe ( Teuchos::FancyOStream &  out,
const Teuchos::EVerbosityLevel  verbLevel = Teuchos::Describable::verbLevel_default 
) const
inlinevirtual

Print the object with some verbosity level to an FancyOStream object.

Reimplemented from Xpetra::TpetraMultiVector< Scalar, int, long long, EpetraNode >.

Definition at line 394 of file Xpetra_TpetraVector_def.hpp.

template<class Scalar >
Scalar Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::dot ( const Vector a) const
inline

Computes dot product of this Vector against input Vector x.

Definition at line 399 of file Xpetra_TpetraVector_def.hpp.

template<class Scalar >
RCP<Tpetra::Vector<Scalar, LocalOrdinal, GlobalOrdinal, Node> > Xpetra::TpetraVector< Scalar, int, long long, EpetraNode >::getTpetra_Vector ( ) const
inline

Get the underlying Tpetra multivector.

Definition at line 416 of file Xpetra_TpetraVector_def.hpp.


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