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

#include <Xpetra_EpetraIntVector_fwd.hpp>

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

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, 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< int, int, EpetraGlobalOrdinal, Node >
virtual void Xpetra_randomize ()
 Set multi-vector values to random numbers. XPetra implementation. More...
 
virtual void Xpetra_randomize (const int &minVal, const int &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< int, int,
EpetraGlobalOrdinal, Node > & 
operator= (const MultiVector< int, int, EpetraGlobalOrdinal, Node > &rhs)
 Assignment operator: Does a deep copy. More...
 
virtual void norm1 (const Teuchos::ArrayView< typename Teuchos::ScalarTraits< int >::magnitudeType > &norms) const =0
 Compute 1-norm of each vector in multi-vector. More...
 
virtual void norm2 (const Teuchos::ArrayView< typename Teuchos::ScalarTraits< int >::magnitudeType > &norms) const =0
 
virtual void normInf (const Teuchos::ArrayView< typename Teuchos::ScalarTraits< int >::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...
 

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 EpetraGlobalOrdinal GlobalOrdinal
 

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 randomize (const Scalar &, const Scalar &, 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...
 
bool isSameSize (const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &vec) const
 Checks to see if the local length, number of vectors and size of Scalar type match. 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, EpetraGlobalOrdinal, Node >
using scalar_type = int
 
using local_ordinal_type = int
 
using global_ordinal_type = EpetraGlobalOrdinal
 
using node_type = Node
 
typedef Xpetra::MultiVector
< int, int,
EpetraGlobalOrdinal, Node >
::dual_view_type 
dual_view_type
 
- Public Types inherited from Xpetra::MultiVector< int, int, EpetraGlobalOrdinal, Node >
typedef int scalar_type
 
typedef int local_ordinal_type
 
typedef EpetraGlobalOrdinal global_ordinal_type
 
typedef Node node_type
 
using impl_scalar_type = typename Kokkos::ArithTraits< int >::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
 

Detailed Description

template<class GO, class NO>
class Xpetra::EpetraIntVectorT< GO, NO >

Definition at line 51 of file Xpetra_EpetraIntVector_fwd.hpp.

Member Typedef Documentation

template<class GO , class NO >
typedef int Xpetra::EpetraIntVectorT< GO, NO >::Scalar
private

Definition at line 82 of file Xpetra_EpetraIntVector.hpp.

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

Definition at line 83 of file Xpetra_EpetraIntVector.hpp.

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

Definition at line 84 of file Xpetra_EpetraIntVector.hpp.

Constructor & Destructor Documentation

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

Sets all vector entries to zero.

Definition at line 91 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
Xpetra::EpetraIntVectorT< GO, NO >::~EpetraIntVectorT ( )
inline

Destructor.

Definition at line 94 of file Xpetra_EpetraIntVector.hpp.

Member Function Documentation

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

TODO missing comment.

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

Definition at line 102 of file Xpetra_EpetraIntVector.hpp.

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

Return 1-norm of this Vector.

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

Definition at line 109 of file Xpetra_EpetraIntVector.hpp.

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

Compute 2-norm of this Vector.

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

Definition at line 116 of file Xpetra_EpetraIntVector.hpp.

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

Compute Inf-norm of this Vector.

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

Definition at line 123 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
int Xpetra::EpetraIntVectorT< GO, NO >::meanValue ( ) const
inlinevirtual

Compute mean (average) value of this Vector.

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

Definition at line 130 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
int Xpetra::EpetraIntVectorT< GO, NO >::maxValue ( ) const
inline

Compute max value of this Vector.

Definition at line 137 of file Xpetra_EpetraIntVector.hpp.

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

Replace current value at the specified location with specified value.

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

Definition at line 149 of file Xpetra_EpetraIntVector.hpp.

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

Adds specified value to existing value at the specified location.

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

Definition at line 155 of file Xpetra_EpetraIntVector.hpp.

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

Replace current value at the specified location with specified values.

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

Definition at line 161 of file Xpetra_EpetraIntVector.hpp.

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

Adds specified value to existing value at the specified location.

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

Definition at line 167 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraIntVectorT< GO, NO >::putScalar ( const int &  value)
inlinevirtual

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

Implements Xpetra::MultiVector< int, int, EpetraGlobalOrdinal, Node >.

Definition at line 173 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraIntVectorT< GO, NO >::randomize ( bool  bUseXpetraImplementation = true)
inlinevirtual

Set multi-vector values to random numbers.

Implements Xpetra::MultiVector< int, int, EpetraGlobalOrdinal, Node >.

Definition at line 176 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraIntVectorT< GO, NO >::randomize ( const Scalar ,
const Scalar ,
bool  bUseXpetraImplementation = true 
)
inlinevirtual

Set multi-vector values to random numbers.

Implements Xpetra::MultiVector< int, int, EpetraGlobalOrdinal, Node >.

Definition at line 182 of file Xpetra_EpetraIntVector.hpp.

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

Definition at line 189 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
Teuchos::RCP<const Vector<Scalar, LocalOrdinal, GlobalOrdinal, Node> > Xpetra::EpetraIntVectorT< GO, NO >::getVector ( size_t  j) const
inlinevirtual

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

Implements Xpetra::MultiVector< int, int, EpetraGlobalOrdinal, Node >.

Definition at line 200 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
Teuchos::RCP<Vector<Scalar, LocalOrdinal, GlobalOrdinal, Node> > Xpetra::EpetraIntVectorT< GO, NO >::getVectorNonConst ( size_t  j)
inlinevirtual

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

Implements Xpetra::MultiVector< int, int, EpetraGlobalOrdinal, Node >.

Definition at line 205 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
Teuchos::ArrayRCP<const int> Xpetra::EpetraIntVectorT< GO, NO >::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, EpetraGlobalOrdinal, Node >.

Definition at line 211 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
Teuchos::ArrayRCP<int> Xpetra::EpetraIntVectorT< GO, NO >::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, EpetraGlobalOrdinal, Node >.

Definition at line 215 of file Xpetra_EpetraIntVector.hpp.

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

Definition at line 222 of file Xpetra_EpetraIntVector.hpp.

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

Definition at line 225 of file Xpetra_EpetraIntVector.hpp.

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

Definition at line 228 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraIntVectorT< GO, NO >::scale ( const int &  alpha)
inlinevirtual

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

Implements Xpetra::MultiVector< int, int, EpetraGlobalOrdinal, Node >.

Definition at line 231 of file Xpetra_EpetraIntVector.hpp.

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

Definition at line 234 of file Xpetra_EpetraIntVector.hpp.

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

Definition at line 240 of file Xpetra_EpetraIntVector.hpp.

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

Definition at line 248 of file Xpetra_EpetraIntVector.hpp.

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

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

Definition at line 257 of file Xpetra_EpetraIntVector.hpp.

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

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

Definition at line 263 of file Xpetra_EpetraIntVector.hpp.

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

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

Definition at line 269 of file Xpetra_EpetraIntVector.hpp.

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

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

Implements Xpetra::MultiVector< int, int, EpetraGlobalOrdinal, Node >.

Definition at line 275 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraIntVectorT< GO, NO >::maxValue ( const Teuchos::ArrayView< int > &  maxs) const
inline

Compute max value of each vector in multi-vector.

Definition at line 281 of file Xpetra_EpetraIntVector.hpp.

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

Definition at line 287 of file Xpetra_EpetraIntVector.hpp.

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

Definition at line 293 of file Xpetra_EpetraIntVector.hpp.

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

Replace value, using global (row) index.

Implements Xpetra::MultiVector< int, int, EpetraGlobalOrdinal, Node >.

Definition at line 304 of file Xpetra_EpetraIntVector.hpp.

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

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

Implements Xpetra::MultiVector< int, int, EpetraGlobalOrdinal, Node >.

Definition at line 310 of file Xpetra_EpetraIntVector.hpp.

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

Replace value, using local (row) index.

Implements Xpetra::MultiVector< int, int, EpetraGlobalOrdinal, Node >.

Definition at line 316 of file Xpetra_EpetraIntVector.hpp.

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

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

Implements Xpetra::MultiVector< int, int, EpetraGlobalOrdinal, Node >.

Definition at line 322 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
size_t Xpetra::EpetraIntVectorT< GO, NO >::getNumVectors ( ) const
inlinevirtual

Returns the number of vectors in the multi-vector.

Implements Xpetra::MultiVector< int, int, EpetraGlobalOrdinal, Node >.

Definition at line 333 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
size_t Xpetra::EpetraIntVectorT< GO, NO >::getLocalLength ( ) const
inlinevirtual

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

Implements Xpetra::MultiVector< int, int, EpetraGlobalOrdinal, Node >.

Definition at line 339 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
global_size_t Xpetra::EpetraIntVectorT< GO, NO >::getGlobalLength ( ) const
inlinevirtual

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

Implements Xpetra::MultiVector< int, int, EpetraGlobalOrdinal, Node >.

Definition at line 342 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
bool Xpetra::EpetraIntVectorT< GO, NO >::isSameSize ( const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &  vec) const
inlinevirtual

Checks to see if the local length, number of vectors and size of Scalar type match.

Implements Xpetra::MultiVector< int, int, EpetraGlobalOrdinal, Node >.

Definition at line 345 of file Xpetra_EpetraIntVector.hpp.

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

Return a simple one-line description of this object.

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

Definition at line 353 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraIntVectorT< 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.

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

Definition at line 358 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
RCP<Epetra_IntVector> Xpetra::EpetraIntVectorT< GO, NO >::getEpetra_IntVector ( ) const
inline

Definition at line 362 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
const RCP<const Comm<int> > Xpetra::EpetraIntVectorT< GO, NO >::getComm ( ) const
inline

Definition at line 364 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
Teuchos::RCP<const Map<int, GlobalOrdinal, Node> > Xpetra::EpetraIntVectorT< GO, NO >::getMap ( ) const
inlinevirtual

The Map describing the parallel distribution of this object.

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

Definition at line 369 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraIntVectorT< GO, NO >::doImport ( const DistObject< int, int, GlobalOrdinal, Node > &  source,
const Import< int, GlobalOrdinal, Node > &  importer,
CombineMode  CM 
)
inline

Definition at line 373 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraIntVectorT< GO, NO >::doExport ( const DistObject< int, LocalOrdinal, GlobalOrdinal, Node > &  dest,
const Import< int, GlobalOrdinal, Node > &  importer,
CombineMode  CM 
)
inline

Definition at line 376 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraIntVectorT< GO, NO >::doImport ( const DistObject< int, LocalOrdinal, GlobalOrdinal, Node > &  source,
const Export< int, GlobalOrdinal, Node > &  exporter,
CombineMode  CM 
)
inline

Definition at line 379 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraIntVectorT< GO, NO >::doExport ( const DistObject< int, LocalOrdinal, GlobalOrdinal, Node > &  dest,
const Export< int, GlobalOrdinal, Node > &  exporter,
CombineMode  CM 
)
inline

Definition at line 382 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
void Xpetra::EpetraIntVectorT< GO, NO >::replaceMap ( const RCP< const Map< int, GlobalOrdinal, Node > > &  map)
inline

Definition at line 385 of file Xpetra_EpetraIntVector.hpp.

template<class GO , class NO >
virtual void Xpetra::EpetraIntVectorT< GO, NO >::assign ( const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &  rhs)
inlineprotectedvirtual

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

Implements Xpetra::MultiVector< int, int, EpetraGlobalOrdinal, Node >.

Definition at line 393 of file Xpetra_EpetraIntVector.hpp.


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