Public Member Functions | Protected Member Functions | Private Types | Private Attributes | List of all members
Xpetra::EpetraIntVectorT< long long, EpetraNode > Class Template Reference

#include <Xpetra_EpetraIntVector.hpp>

Inheritance diagram for Xpetra::EpetraIntVectorT< long long, EpetraNode >:
Xpetra::Vector< int, int, long long, EpetraNode > Xpetra::MultiVector< int, int, long long, EpetraNode > Xpetra::DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > Teuchos::Describable Teuchos::LabeledObject

Public Member Functions

RCP< Epetra_IntVector > getEpetra_IntVector () const
 
const RCP< const Comm< int > > getComm () const
 
Teuchos::RCP< const Map< int, GlobalOrdinal, Node > > getMap () const
 The Map describing the parallel distribution of this object. More...
 
void doImport (const DistObject< int, int, GlobalOrdinal, Node > &source, const Import< int, GlobalOrdinal, Node > &importer, CombineMode CM)
 
void doExport (const DistObject< int, LocalOrdinal, GlobalOrdinal, Node > &dest, const Import< int, GlobalOrdinal, Node > &importer, CombineMode CM)
 
void doImport (const DistObject< int, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< int, GlobalOrdinal, Node > &exporter, CombineMode CM)
 
void doExport (const DistObject< int, LocalOrdinal, GlobalOrdinal, Node > &dest, const Export< int, GlobalOrdinal, Node > &exporter, CombineMode CM)
 
void replaceMap (const RCP< const Map< int, GlobalOrdinal, Node > > &map)
 
- Public Member Functions inherited from Xpetra::Vector< int, int, long long, EpetraNode >
virtual ~Vector ()
 Destructor. More...
 
- Public Member Functions inherited from Xpetra::MultiVector< int, int, long long, EpetraNode >
virtual ~MultiVector ()
 Destructor. More...
 
MultiVector< int, int, long long, EpetraNode > & operator= (const MultiVector< int, int, long long, EpetraNode > &rhs)
 Assignment operator: Does a deep copy. More...
 
virtual void Xpetra_randomize ()
 Set multi-vector values to random numbers. XPetra implementation. More...
 
- 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 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 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 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...
 
- Public Member Functions inherited from Teuchos::Describable
void describe (std::ostream &out, const EVerbosityLevel verbLevel=verbLevel_default) const
 
virtual ~Describable ()
 
DescribableStreamManipulatorState describe (const Describable &describable, const EVerbosityLevel verbLevel=Describable::verbLevel_default)
 
std::ostream & operator<< (std::ostream &os, const DescribableStreamManipulatorState &d)
 
void describe (std::ostream &out, const EVerbosityLevel verbLevel=verbLevel_default) const
 
virtual ~Describable ()
 
- Public Member Functions inherited from Teuchos::LabeledObject
 LabeledObject ()
 
virtual ~LabeledObject ()
 
virtual void setObjectLabel (const std::string &objectLabel)
 
virtual std::string getObjectLabel () const
 

Protected Member Functions

virtual void assign (const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &rhs)
 Implementation of the assignment operator (operator=); does a deep copy. More...
 

Private Types

typedef int Scalar
 
typedef int LocalOrdinal
 
typedef long long GlobalOrdinal
 
typedef EpetraNode Node
 

Private Attributes

RCP< Epetra_IntVector > vec_
 The Epetra_IntVector which this class wraps. More...
 

Constructor/Destructor Methods

 EpetraIntVectorT (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &map, bool zeroOut=true)
 Sets all vector entries to zero. More...
 
 ~EpetraIntVectorT ()
 Destructor. More...
 

Mathematical methods

int dot (const Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &a) const
 TODO missing comment. More...
 
Teuchos::ScalarTraits< int >::magnitudeType norm1 () const
 Return 1-norm of this Vector. More...
 
Teuchos::ScalarTraits< int >::magnitudeType norm2 () const
 Compute 2-norm of this Vector. More...
 
Teuchos::ScalarTraits< int >::magnitudeType normInf () const
 Compute Inf-norm of this Vector. More...
 
int meanValue () const
 Compute mean (average) value of this Vector. More...
 
int maxValue () const
 Compute max value of this Vector. More...
 
void dot (const MultiVector< int, int, GlobalOrdinal, Node > &A, const Teuchos::ArrayView< int > &dots) const
 Computes dot product of each corresponding pair of vectors, dots[i] = this[i].dot(A[i]) More...
 
void abs (const MultiVector< int, int, GlobalOrdinal, Node > &A)
 Puts element-wise absolute values of input Multi-vector in target: A = abs(this) More...
 
void reciprocal (const MultiVector< int, int, GlobalOrdinal, Node > &A)
 Puts element-wise reciprocal values of input Multi-vector in target, this(i,j) = 1/A(i,j). More...
 
void scale (const int &alpha)
 Scale the current values of a multi-vector, this = alpha*this. More...
 
void scale (Teuchos::ArrayView< const int > alpha)
 Scale the current values of a multi-vector, this[j] = alpha[j]*this[j]. More...
 
void update (const int &alpha, const MultiVector< int, int, GlobalOrdinal, Node > &A, const int &beta)
 Update multi-vector values with scaled values of A, this = beta*this + alpha*A. More...
 
void update (const int &alpha, const MultiVector< int, int, GlobalOrdinal, Node > &A, const int &beta, const MultiVector< int, int, GlobalOrdinal, Node > &B, const int &gamma)
 Update multi-vector with scaled values of A and B, this = gamma*this + alpha*A + beta*B. More...
 
void norm1 (const Teuchos::ArrayView< Teuchos::ScalarTraits< int >::magnitudeType > &norms) const
 Compute 1-norm of each vector in multi-vector. More...
 
void norm2 (const Teuchos::ArrayView< Teuchos::ScalarTraits< int >::magnitudeType > &norms) const
 Compute 2-norm of each vector in multi-vector. More...
 
void normInf (const Teuchos::ArrayView< Teuchos::ScalarTraits< int >::magnitudeType > &norms) const
 Compute Inf-norm of each vector in multi-vector. More...
 
void meanValue (const Teuchos::ArrayView< int > &means) const
 Compute mean (average) value of each vector in multi-vector. More...
 
void maxValue (const Teuchos::ArrayView< int > &maxs) const
 Compute max value of each vector in multi-vector. More...
 
void multiply (Teuchos::ETransp transA, Teuchos::ETransp transB, const int &alpha, const MultiVector< int, int, GlobalOrdinal, Node > &A, const MultiVector< int, int, GlobalOrdinal, Node > &B, const int &beta)
 Matrix-Matrix multiplication, this = beta*this + alpha*op(A)*op(B). More...
 
void elementWiseMultiply (int scalarAB, const Vector< int, int, GlobalOrdinal, Node > &A, const MultiVector< int, int, GlobalOrdinal, Node > &B, int scalarThis)
 Element-wise multiply of a Vector A with a EpetraMultiVector B. 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...
 
void putScalar (const int &value)
 Initialize all values in a multi-vector with specified value. More...
 
void randomize (bool bUseXpetraImplementation=true)
 Set multi-vector values to random numbers. More...
 
void setSeed (unsigned int seed)
 Set seed for Random function. 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...
 

Data Copy and View get methods

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 int > getData (size_t j) const
 
Teuchos::ArrayRCP< int > getDataNonConst (size_t j)
 

Attribute access functions

size_t getNumVectors () const
 Returns the number of vectors in the multi-vector. More...
 
size_t getLocalLength () const
 Returns the local vector length on the calling processor of vectors in the multi-vector. More...
 
global_size_t getGlobalLength () const
 Returns the global vector length of vectors in the multi-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...
 

Additional Inherited Members

- Public Types inherited from Xpetra::Vector< int, int, long long, EpetraNode >
typedef int scalar_type
 
typedef int local_ordinal_type
 
typedef long long global_ordinal_type
 
typedef EpetraNode node_type
 
- Public Types inherited from Xpetra::MultiVector< int, int, long long, EpetraNode >
typedef int scalar_type
 
typedef int local_ordinal_type
 
typedef long long global_ordinal_type
 
typedef EpetraNode node_type
 
- Static Public Attributes inherited from Teuchos::Describable
static const EVerbosityLevel verbLevel_default
 

Detailed Description

template<>
class Xpetra::EpetraIntVectorT< long long, EpetraNode >

Definition at line 773 of file Xpetra_EpetraIntVector.hpp.

Member Typedef Documentation

typedef int Xpetra::EpetraIntVectorT< long long, EpetraNode >::Scalar
private

Definition at line 776 of file Xpetra_EpetraIntVector.hpp.

typedef int Xpetra::EpetraIntVectorT< long long, EpetraNode >::LocalOrdinal
private

Definition at line 777 of file Xpetra_EpetraIntVector.hpp.

typedef long long Xpetra::EpetraIntVectorT< long long, EpetraNode >::GlobalOrdinal
private

Definition at line 778 of file Xpetra_EpetraIntVector.hpp.

typedef EpetraNode Xpetra::EpetraIntVectorT< long long, EpetraNode >::Node
private

Definition at line 779 of file Xpetra_EpetraIntVector.hpp.

Constructor & Destructor Documentation

Xpetra::EpetraIntVectorT< long long, EpetraNode >::EpetraIntVectorT ( const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &  map,
bool  zeroOut = true 
)
inlineexplicit

Sets all vector entries to zero.

Definition at line 787 of file Xpetra_EpetraIntVector.hpp.

Destructor.

Definition at line 794 of file Xpetra_EpetraIntVector.hpp.

Member Function Documentation

int Xpetra::EpetraIntVectorT< long long, EpetraNode >::dot ( const Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &  a) const
inlinevirtual

TODO missing comment.

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

Definition at line 802 of file Xpetra_EpetraIntVector.hpp.

Teuchos::ScalarTraits<int>::magnitudeType Xpetra::EpetraIntVectorT< long long, EpetraNode >::norm1 ( ) const
inlinevirtual

Return 1-norm of this Vector.

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

Definition at line 806 of file Xpetra_EpetraIntVector.hpp.

Teuchos::ScalarTraits<int>::magnitudeType Xpetra::EpetraIntVectorT< long long, EpetraNode >::norm2 ( ) const
inlinevirtual

Compute 2-norm of this Vector.

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

Definition at line 810 of file Xpetra_EpetraIntVector.hpp.

Teuchos::ScalarTraits<int>::magnitudeType Xpetra::EpetraIntVectorT< long long, EpetraNode >::normInf ( ) const
inlinevirtual

Compute Inf-norm of this Vector.

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

Definition at line 813 of file Xpetra_EpetraIntVector.hpp.

int Xpetra::EpetraIntVectorT< long long, EpetraNode >::meanValue ( ) const
inlinevirtual

Compute mean (average) value of this Vector.

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

Definition at line 816 of file Xpetra_EpetraIntVector.hpp.

int Xpetra::EpetraIntVectorT< long long, EpetraNode >::maxValue ( ) const
inline

Compute max value of this Vector.

Definition at line 819 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::replaceGlobalValue ( GlobalOrdinal  globalRow,
const Scalar value 
)
inlinevirtual

Replace current value at the specified location with specified value.

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

Definition at line 828 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::sumIntoGlobalValue ( GlobalOrdinal  globalRow,
const Scalar value 
)
inlinevirtual

Adds specified value to existing value at the specified location.

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

Definition at line 831 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::replaceLocalValue ( LocalOrdinal  myRow,
const Scalar value 
)
inlinevirtual

Replace current value at the specified location with specified values.

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

Definition at line 834 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::sumIntoLocalValue ( LocalOrdinal  myRow,
const Scalar value 
)
inlinevirtual

Adds specified value to existing value at the specified location.

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

Definition at line 837 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::putScalar ( const int &  value)
inlinevirtual

Initialize all values in a multi-vector with specified value.

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 840 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::randomize ( bool  bUseXpetraImplementation = true)
inlinevirtual

Set multi-vector values to random numbers.

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 843 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::setSeed ( unsigned int  seed)
inlinevirtual

Set seed for Random function.

Note: this method does not exist in Tpetra interface. Added for MueLu.

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 848 of file Xpetra_EpetraIntVector.hpp.

Teuchos::RCP< const Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > Xpetra::EpetraIntVectorT< long long, EpetraNode >::getVector ( size_t  j) const
inlinevirtual

Return a Vector which is a const view of column j.

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 857 of file Xpetra_EpetraIntVector.hpp.

Teuchos::RCP< Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > Xpetra::EpetraIntVectorT< long long, EpetraNode >::getVectorNonConst ( size_t  j)
inlinevirtual

Return a Vector which is a nonconst view of column j.

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 862 of file Xpetra_EpetraIntVector.hpp.

Teuchos::ArrayRCP<const int> Xpetra::EpetraIntVectorT< long long, EpetraNode >::getData ( size_t  j) const
inlinevirtual

Const Local vector access function. View of the local values in a particular vector of this multi-vector.

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 868 of file Xpetra_EpetraIntVector.hpp.

Teuchos::ArrayRCP<int> Xpetra::EpetraIntVectorT< long long, EpetraNode >::getDataNonConst ( size_t  j)
inlinevirtual

Local vector access function. View of the local values in a particular vector of this multi-vector.

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 879 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::dot ( const MultiVector< int, int, GlobalOrdinal, Node > &  A,
const Teuchos::ArrayView< int > &  dots 
) const
inlinevirtual

Computes dot product of each corresponding pair of vectors, dots[i] = this[i].dot(A[i])

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 893 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::abs ( const MultiVector< int, int, GlobalOrdinal, Node > &  A)
inlinevirtual

Puts element-wise absolute values of input Multi-vector in target: A = abs(this)

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 901 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::reciprocal ( const MultiVector< int, int, GlobalOrdinal, Node > &  A)
inlinevirtual

Puts element-wise reciprocal values of input Multi-vector in target, this(i,j) = 1/A(i,j).

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 909 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::scale ( const int &  alpha)
inlinevirtual

Scale the current values of a multi-vector, this = alpha*this.

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 917 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::scale ( Teuchos::ArrayView< const int >  alpha)
inlinevirtual

Scale the current values of a multi-vector, this[j] = alpha[j]*this[j].

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 923 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::update ( const int &  alpha,
const MultiVector< int, int, GlobalOrdinal, Node > &  A,
const int &  beta 
)
inlinevirtual

Update multi-vector values with scaled values of A, this = beta*this + alpha*A.

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 929 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::update ( const int &  alpha,
const MultiVector< int, int, GlobalOrdinal, Node > &  A,
const int &  beta,
const MultiVector< int, int, GlobalOrdinal, Node > &  B,
const int &  gamma 
)
inlinevirtual

Update multi-vector with scaled values of A and B, this = gamma*this + alpha*A + beta*B.

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 937 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::norm1 ( const Teuchos::ArrayView< Teuchos::ScalarTraits< int >::magnitudeType > &  norms) const
inlinevirtual

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

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 946 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::norm2 ( const Teuchos::ArrayView< Teuchos::ScalarTraits< int >::magnitudeType > &  norms) const
inlinevirtual

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

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 949 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::normInf ( const Teuchos::ArrayView< Teuchos::ScalarTraits< int >::magnitudeType > &  norms) const
inlinevirtual

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

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 952 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::meanValue ( const Teuchos::ArrayView< int > &  means) const
inlinevirtual

Compute mean (average) value of each vector in multi-vector.

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 955 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::maxValue ( const Teuchos::ArrayView< int > &  maxs) const
inline

Compute max value of each vector in multi-vector.

Definition at line 958 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::multiply ( Teuchos::ETransp  transA,
Teuchos::ETransp  transB,
const int &  alpha,
const MultiVector< int, int, GlobalOrdinal, Node > &  A,
const MultiVector< int, int, GlobalOrdinal, Node > &  B,
const int &  beta 
)
inlinevirtual

Matrix-Matrix multiplication, this = beta*this + alpha*op(A)*op(B).

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 961 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::elementWiseMultiply ( int  scalarAB,
const Vector< int, int, GlobalOrdinal, Node > &  A,
const MultiVector< int, int, GlobalOrdinal, Node > &  B,
int  scalarThis 
)
inlinevirtual

Element-wise multiply of a Vector A with a EpetraMultiVector B.

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 964 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::replaceGlobalValue ( GlobalOrdinal  globalRow,
size_t  vectorIndex,
const Scalar value 
)
inlinevirtual

Replace value, using global (row) index.

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 975 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::sumIntoGlobalValue ( GlobalOrdinal  globalRow,
size_t  vectorIndex,
const Scalar value 
)
inlinevirtual

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

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 978 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::replaceLocalValue ( LocalOrdinal  myRow,
size_t  vectorIndex,
const Scalar value 
)
inlinevirtual

Replace value, using local (row) index.

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 981 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::sumIntoLocalValue ( LocalOrdinal  myRow,
size_t  vectorIndex,
const Scalar value 
)
inlinevirtual

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

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 984 of file Xpetra_EpetraIntVector.hpp.

size_t Xpetra::EpetraIntVectorT< long long, EpetraNode >::getNumVectors ( ) const
inlinevirtual

Returns the number of vectors in the multi-vector.

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 992 of file Xpetra_EpetraIntVector.hpp.

size_t Xpetra::EpetraIntVectorT< long long, EpetraNode >::getLocalLength ( ) const
inlinevirtual

Returns the local vector length on the calling processor of vectors in the multi-vector.

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 996 of file Xpetra_EpetraIntVector.hpp.

global_size_t Xpetra::EpetraIntVectorT< long long, EpetraNode >::getGlobalLength ( ) const
inlinevirtual

Returns the global vector length of vectors in the multi-vector.

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 999 of file Xpetra_EpetraIntVector.hpp.

std::string Xpetra::EpetraIntVectorT< long long, EpetraNode >::description ( ) const
inlinevirtual

Return a simple one-line description of this object.

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

Definition at line 1007 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< 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.

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

Definition at line 1019 of file Xpetra_EpetraIntVector.hpp.

RCP< Epetra_IntVector > Xpetra::EpetraIntVectorT< long long, EpetraNode >::getEpetra_IntVector ( ) const
inline

Definition at line 1038 of file Xpetra_EpetraIntVector.hpp.

const RCP<const Comm<int> > Xpetra::EpetraIntVectorT< long long, EpetraNode >::getComm ( ) const
inline

Definition at line 1040 of file Xpetra_EpetraIntVector.hpp.

Teuchos::RCP<const Map<int, GlobalOrdinal, Node> > Xpetra::EpetraIntVectorT< long long, EpetraNode >::getMap ( ) const
inlinevirtual

The Map describing the parallel distribution of this object.

Implements Xpetra::DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node >.

Definition at line 1045 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::doImport ( const DistObject< int, int, GlobalOrdinal, Node > &  source,
const Import< int, GlobalOrdinal, Node > &  importer,
CombineMode  CM 
)
inline

Definition at line 1050 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::doExport ( const DistObject< int, LocalOrdinal, GlobalOrdinal, Node > &  dest,
const Import< int, GlobalOrdinal, Node > &  importer,
CombineMode  CM 
)
inline

Definition at line 1062 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::doImport ( const DistObject< int, LocalOrdinal, GlobalOrdinal, Node > &  source,
const Export< int, GlobalOrdinal, Node > &  exporter,
CombineMode  CM 
)
inline

Definition at line 1074 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::doExport ( const DistObject< int, LocalOrdinal, GlobalOrdinal, Node > &  dest,
const Export< int, GlobalOrdinal, Node > &  exporter,
CombineMode  CM 
)
inline

Definition at line 1086 of file Xpetra_EpetraIntVector.hpp.

void Xpetra::EpetraIntVectorT< long long, EpetraNode >::replaceMap ( const RCP< const Map< int, GlobalOrdinal, Node > > &  map)
inlinevirtual
virtual void Xpetra::EpetraIntVectorT< long long, EpetraNode >::assign ( const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &  rhs)
inlineprotectedvirtual

Implementation of the assignment operator (operator=); does a deep copy.

Implements Xpetra::MultiVector< int, int, long long, EpetraNode >.

Definition at line 1148 of file Xpetra_EpetraIntVector.hpp.

Member Data Documentation

RCP< Epetra_IntVector > Xpetra::EpetraIntVectorT< long long, EpetraNode >::vec_
private

The Epetra_IntVector which this class wraps.

Definition at line 1183 of file Xpetra_EpetraIntVector.hpp.


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