Xpetra  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Macros Pages
Xpetra::EpetraVectorT< GO, NO > Class Template Reference

#include <Xpetra_EpetraVector_fwd.hpp>

Inheritance diagram for Xpetra::EpetraVectorT< GO, NO >:
Xpetra::Vector< double, int, EpetraGlobalOrdinal, Node > Xpetra::EpetraMultiVectorT< EpetraGlobalOrdinal, Node > Xpetra::MultiVector< double, int, EpetraGlobalOrdinal, Node > Xpetra::MultiVector< double, int, EpetraGlobalOrdinal, Node > Xpetra::DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > Xpetra::DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node >

Public Member Functions

void norm1 (const Teuchos::ArrayView< Teuchos::ScalarTraits< Scalar >::magnitudeType > &norms) const
 Compute 1-norm of each vector in multi-vector. More...
 
void norm2 (const Teuchos::ArrayView< Teuchos::ScalarTraits< Scalar >::magnitudeType > &norms) const
 
void normInf (const Teuchos::ArrayView< 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 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 dot (const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Teuchos::ArrayView< Scalar > &dots) const
 Compute the dot product of each corresponding pair of vectors (columns) in A and B. More...
 
- Public Member Functions inherited from Xpetra::Vector< double, int, EpetraGlobalOrdinal, Node >
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...
 
- Public Member Functions inherited from Xpetra::MultiVector< double, int, EpetraGlobalOrdinal, Node >
virtual void Xpetra_randomize ()
 Set multi-vector values to random numbers. XPetra implementation. More...
 
virtual void Xpetra_randomize (const double &minVal, const double &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< double, int,
EpetraGlobalOrdinal, Node > & 
operator= (const MultiVector< double, int, EpetraGlobalOrdinal, Node > &rhs)
 Assignment operator: Does a deep copy. More...
 
virtual void norm1 (const Teuchos::ArrayView< typename Teuchos::ScalarTraits< double >::magnitudeType > &norms) const =0
 Compute 1-norm of each vector in multi-vector. More...
 
virtual void norm2 (const Teuchos::ArrayView< typename Teuchos::ScalarTraits< double >::magnitudeType > &norms) const =0
 
virtual void normInf (const Teuchos::ArrayView< typename Teuchos::ScalarTraits< double >::magnitudeType > &norms) const =0
 Compute Inf-norm of each vector in multi-vector. More...
 
virtual void replaceMap (const RCP< const Map< int, EpetraGlobalOrdinal, Node >> &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::EpetraMultiVectorT< EpetraGlobalOrdinal, Node >
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
 Implements DistObject interface. More...
 
void doImport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)
 Import. More...
 
void doExport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &dest, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)
 Export. More...
 
void doImport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM)
 Import (using an Exporter). More...
 
void doExport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &dest, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM)
 Export (using an Importer). More...
 
void replaceMap (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &map)
 Replace the underlying Map in place. More...
 
 EpetraMultiVectorT (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &map, size_t NumVectors, bool zeroOut=true)
 Basic MultiVector constuctor. More...
 
 EpetraMultiVectorT (const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &source, const Teuchos::DataAccess copyOrView=Teuchos::Copy)
 MultiVector copy constructor. More...
 
 EpetraMultiVectorT (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &map, const Teuchos::ArrayView< const Teuchos::ArrayView< const Scalar > > &ArrayOfPtrs, size_t NumVectors)
 Set multi-vector values from array of pointers using Teuchos memory management classes. (copy). More...
 
virtual ~EpetraMultiVectorT ()
 MultiVector destructor. More...
 
void putScalar (const Scalar &value)
 Set all values in the multivector with the given value. More...
 
Teuchos::RCP< const Vector
< double, int, GlobalOrdinal,
Node > > 
getVector (size_t j) const
 Return a Vector which is a const view of column j. More...
 
Teuchos::RCP< Vector< double,
int, GlobalOrdinal, Node > > 
getVectorNonConst (size_t j)
 Return a Vector which is a nonconst view of column j. More...
 
Teuchos::ArrayRCP< const ScalargetData (size_t j) const
 Const view of the local values in a particular vector of this multivector. More...
 
Teuchos::ArrayRCP< ScalargetDataNonConst (size_t j)
 View of the local values in a particular vector of this multivector. 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 in place: 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 update (const Scalar &alpha, const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Scalar &beta)
 Update: 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: this = gamma*this + alpha*A + beta*B. More...
 
void norm1 (const Teuchos::ArrayView< Teuchos::ScalarTraits< Scalar >::magnitudeType > &norms) const
 Compute 1-norm of each vector in multi-vector. More...
 
void norm2 (const Teuchos::ArrayView< Teuchos::ScalarTraits< Scalar >::magnitudeType > &norms) const
 
void normInf (const Teuchos::ArrayView< Teuchos::ScalarTraits< Scalar >::magnitudeType > &norms) const
 Compute Inf-norm of each vector in multi-vector. 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...
 
void elementWiseMultiply (Scalar scalarAB, const Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &B, Scalar scalarThis)
 Multiply a Vector A elementwise by a MultiVector 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
 
 EpetraMultiVectorT (const RCP< Epetra_MultiVector > &vec)
 EpetraMultiVectorT constructor to wrap a Epetra_MultiVector object. More...
 
RCP< Epetra_MultiVector > getEpetra_MultiVector () const
 Get the underlying Epetra multivector. More...
 
void setSeed (unsigned int seed)
 Set seed for Random function. More...
 

Private Types

typedef double Scalar
 
typedef int LocalOrdinal
 
typedef EpetraGlobalOrdinal GlobalOrdinal
 

Private Attributes

const RCP< const
Epetra_MultiVector > 
internalRefToBaseMV_
 

Constructor/Destructor Methods

 EpetraVectorT (const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &map, bool zeroOut=true)
 Sets all vector entries to zero. More...
 
virtual ~EpetraVectorT ()
 Vector copy constructor. 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

Scalar dot (const Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &a) const
 Computes dot product of this Vector against input Vector x. More...
 
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 Weighted 2-norm (RMS Norm) 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

 EpetraVectorT (const Teuchos::RCP< Epetra_Vector > &vec)
 EpetraMultiVectorT constructor to wrap a Epetra_Vector object. More...
 
Epetra_Vector * getEpetra_Vector () const
 Get the underlying Epetra vector. More...
 
 EpetraVectorT (const RCP< Epetra_MultiVector > &mv, size_t j)
 

Additional Inherited Members

- Public Types inherited from Xpetra::Vector< double, int, EpetraGlobalOrdinal, Node >
using scalar_type = double
 
using local_ordinal_type = int
 
using global_ordinal_type = EpetraGlobalOrdinal
 
using node_type = Node
 
typedef Xpetra::MultiVector
< double, int,
EpetraGlobalOrdinal, Node >
::dual_view_type 
dual_view_type
 
- Public Types inherited from Xpetra::MultiVector< double, int, EpetraGlobalOrdinal, Node >
typedef double scalar_type
 
typedef int local_ordinal_type
 
typedef EpetraGlobalOrdinal global_ordinal_type
 
typedef Node node_type
 
using impl_scalar_type = typename Kokkos::ArithTraits< double >::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::EpetraMultiVectorT< EpetraGlobalOrdinal, Node >
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 GO, class NO>
class Xpetra::EpetraVectorT< GO, NO >

Definition at line 51 of file Xpetra_EpetraVector_fwd.hpp.

Member Typedef Documentation

template<class GO , class NO >
typedef double Xpetra::EpetraVectorT< GO, NO >::Scalar
private

Definition at line 85 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
typedef int Xpetra::EpetraVectorT< GO, NO >::LocalOrdinal
private

Definition at line 86 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
typedef EpetraGlobalOrdinal Xpetra::EpetraVectorT< GO, NO >::GlobalOrdinal
private

Definition at line 87 of file Xpetra_EpetraVector.hpp.

Constructor & Destructor Documentation

template<class GO , class NO >
Xpetra::EpetraVectorT< GO, NO >::EpetraVectorT ( const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &  map,
bool  zeroOut = true 
)
inlineexplicit

Sets all vector entries to zero.

Definition at line 121 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
virtual Xpetra::EpetraVectorT< GO, NO >::~EpetraVectorT ( )
inlinevirtual

Vector copy constructor.

Destructor.

Definition at line 129 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
Xpetra::EpetraVectorT< GO, NO >::EpetraVectorT ( const Teuchos::RCP< Epetra_Vector > &  vec)
inline

EpetraMultiVectorT constructor to wrap a Epetra_Vector object.

Definition at line 188 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
Xpetra::EpetraVectorT< GO, NO >::EpetraVectorT ( const RCP< Epetra_MultiVector > &  mv,
size_t  j 
)
inline

This constructor creates a Vector which is a view of column j of the MultiVector 'mv'. It implements the logic of MultiVector::getVector/getVectorNonConst() for Epetra MultiVector. The newly created Xpetra::EpetraVectorT will remain valid after the disappearance of the references to 'mv' in user code.

Definition at line 201 of file Xpetra_EpetraVector.hpp.

Member Function Documentation

template<class GO , class NO >
void Xpetra::EpetraVectorT< GO, NO >::norm1 ( const Teuchos::ArrayView< Teuchos::ScalarTraits< Scalar >::magnitudeType > &  norms) const
inline

Compute 1-norm of each vector in multi-vector.

Definition at line 91 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraVectorT< GO, NO >::norm2 ( const Teuchos::ArrayView< Teuchos::ScalarTraits< Scalar >::magnitudeType > &  norms) const
inline

Definition at line 94 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraVectorT< GO, NO >::normInf ( const Teuchos::ArrayView< Teuchos::ScalarTraits< Scalar >::magnitudeType > &  norms) const
inline

Compute Inf-norm of each vector in multi-vector.

Definition at line 97 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraVectorT< GO, NO >::meanValue ( const Teuchos::ArrayView< Scalar > &  means) const
inlinevirtual

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

Reimplemented from Xpetra::EpetraMultiVectorT< EpetraGlobalOrdinal, Node >.

Definition at line 100 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraVectorT< GO, NO >::replaceGlobalValue ( GlobalOrdinal  globalRow,
size_t  vectorIndex,
const Scalar value 
)
inlinevirtual

Replace value, using global (row) index.

Reimplemented from Xpetra::EpetraMultiVectorT< EpetraGlobalOrdinal, Node >.

Definition at line 103 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraVectorT< GO, NO >::sumIntoGlobalValue ( GlobalOrdinal  globalRow,
size_t  vectorIndex,
const Scalar value 
)
inlinevirtual

Add value to existing value, using global (row) index.

Reimplemented from Xpetra::EpetraMultiVectorT< EpetraGlobalOrdinal, Node >.

Definition at line 106 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraVectorT< GO, NO >::replaceLocalValue ( LocalOrdinal  myRow,
size_t  vectorIndex,
const Scalar value 
)
inlinevirtual

Replace value, using local (row) index.

Reimplemented from Xpetra::EpetraMultiVectorT< EpetraGlobalOrdinal, Node >.

Definition at line 109 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraVectorT< GO, NO >::sumIntoLocalValue ( LocalOrdinal  myRow,
size_t  vectorIndex,
const Scalar value 
)
inlinevirtual

Add value to existing value, using local (row) index.

Reimplemented from Xpetra::EpetraMultiVectorT< EpetraGlobalOrdinal, Node >.

Definition at line 112 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraVectorT< GO, NO >::dot ( const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &  A,
const Teuchos::ArrayView< Scalar > &  dots 
) const
inlinevirtual

Compute the dot product of each corresponding pair of vectors (columns) in A and B.

Reimplemented from Xpetra::EpetraMultiVectorT< EpetraGlobalOrdinal, Node >.

Definition at line 115 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraVectorT< GO, NO >::replaceGlobalValue ( GlobalOrdinal  globalRow,
const Scalar value 
)
inlinevirtual

Replace current value at the specified location with specified value.

Implements Xpetra::Vector< double, int, EpetraGlobalOrdinal, Node >.

Definition at line 137 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraVectorT< GO, NO >::sumIntoGlobalValue ( GlobalOrdinal  globalRow,
const Scalar value 
)
inlinevirtual

Adds specified value to existing value at the specified location.

Implements Xpetra::Vector< double, int, EpetraGlobalOrdinal, Node >.

Definition at line 140 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraVectorT< GO, NO >::replaceLocalValue ( LocalOrdinal  myRow,
const Scalar value 
)
inlinevirtual

Replace current value at the specified location with specified values.

Implements Xpetra::Vector< double, int, EpetraGlobalOrdinal, Node >.

Definition at line 143 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraVectorT< GO, NO >::sumIntoLocalValue ( LocalOrdinal  myRow,
const Scalar value 
)
inlinevirtual

Adds specified value to existing value at the specified location.

Implements Xpetra::Vector< double, int, EpetraGlobalOrdinal, Node >.

Definition at line 146 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
Scalar Xpetra::EpetraVectorT< GO, NO >::dot ( const Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &  a) const
inlinevirtual

Computes dot product of this Vector against input Vector x.

Implements Xpetra::Vector< double, int, EpetraGlobalOrdinal, Node >.

Definition at line 154 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
Teuchos::ScalarTraits<Scalar>::magnitudeType Xpetra::EpetraVectorT< GO, NO >::norm1 ( ) const
inlinevirtual

Return 1-norm of this Vector.

Implements Xpetra::Vector< double, int, EpetraGlobalOrdinal, Node >.

Definition at line 157 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
Teuchos::ScalarTraits<Scalar>::magnitudeType Xpetra::EpetraVectorT< GO, NO >::norm2 ( ) const
inlinevirtual

Compute 2-norm of this Vector.

Implements Xpetra::Vector< double, int, EpetraGlobalOrdinal, Node >.

Definition at line 160 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
Teuchos::ScalarTraits<Scalar>::magnitudeType Xpetra::EpetraVectorT< GO, NO >::normInf ( ) const
inlinevirtual

Compute Inf-norm of this Vector.

Implements Xpetra::Vector< double, int, EpetraGlobalOrdinal, Node >.

Definition at line 163 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
Scalar Xpetra::EpetraVectorT< GO, NO >::meanValue ( ) const
inlinevirtual

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

Compute mean (average) value of this Vector.

Implements Xpetra::Vector< double, int, EpetraGlobalOrdinal, Node >.

Definition at line 169 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
std::string Xpetra::EpetraVectorT< GO, NO >::description ( ) const
inlinevirtual

Return a simple one-line description of this object.

Reimplemented from Xpetra::EpetraMultiVectorT< EpetraGlobalOrdinal, Node >.

Definition at line 177 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraVectorT< GO, NO >::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::EpetraMultiVectorT< EpetraGlobalOrdinal, Node >.

Definition at line 180 of file Xpetra_EpetraVector.hpp.

template<class GO , class NO >
Epetra_Vector* Xpetra::EpetraVectorT< GO, NO >::getEpetra_Vector ( ) const
inline

Get the underlying Epetra vector.

Definition at line 195 of file Xpetra_EpetraVector.hpp.

Member Data Documentation

template<class GO , class NO >
const RCP<const Epetra_MultiVector> Xpetra::EpetraVectorT< GO, NO >::internalRefToBaseMV_
private

Definition at line 202 of file Xpetra_EpetraVector.hpp.


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