Xpetra  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Macros Pages
Xpetra::ReorderedBlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > Class Template Reference

#include <Xpetra_ReorderedBlockedMultiVector.hpp>

Inheritance diagram for Xpetra::ReorderedBlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >:
Xpetra::BlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > Xpetra::DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node >

Public Types

typedef Scalar scalar_type
 
typedef LocalOrdinal local_ordinal_type
 
typedef GlobalOrdinal global_ordinal_type
 
typedef Node node_type
 
- Public Types inherited from Xpetra::BlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >
typedef Scalar scalar_type
 
typedef LocalOrdinal local_ordinal_type
 
typedef GlobalOrdinal global_ordinal_type
 
typedef Node node_type
 
- Public Types inherited from Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >
typedef Scalar scalar_type
 
typedef LocalOrdinal local_ordinal_type
 
typedef GlobalOrdinal global_ordinal_type
 
typedef Node node_type
 

Private Member Functions

Teuchos::RCP< const
Xpetra::Map< LocalOrdinal,
GlobalOrdinal, Node > > 
mergeSubBlockMaps (Teuchos::RCP< const Xpetra::BlockReorderManager > brm)
 

Private Attributes

Teuchos::RCP< const
Xpetra::BlockReorderManager
brm_
 
Teuchos::RCP< const
Xpetra::BlockedMultiVector
< Scalar, LocalOrdinal,
GlobalOrdinal, Node > > 
fullVec_
 

Constructor/Destructor Methods

 ReorderedBlockedMultiVector (Teuchos::RCP< const BlockedMap > &rangeMap, Teuchos::RCP< const Xpetra::BlockReorderManager > brm, Teuchos::RCP< const Xpetra::BlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > bvec)
 Constructor. More...
 
virtual ~ReorderedBlockedMultiVector ()
 Destructor. 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 Member Functions inherited from Xpetra::BlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >
Teuchos::RCP< const MapgetMap () const
 Access function for the underlying Map this DistObject was constructed with. More...
 
Teuchos::RCP< const
Xpetra::BlockedMap
< LocalOrdinal, GlobalOrdinal,
Node > > 
getBlockedMap () const
 Access function for the underlying Map this DistObject was constructed with. More...
 
Teuchos::RCP< MultiVectorgetMultiVector (size_t r) const
 return partial multivector associated with block row r More...
 
Teuchos::RCP< MultiVectorgetMultiVector (size_t r, bool bThyraMode) const
 return partial multivector associated with block row r More...
 
void setMultiVector (size_t r, Teuchos::RCP< const MultiVector > v, bool bThyraMode)
 set partial multivector associated with block row r More...
 
Teuchos::RCP< MultiVectorMerge () const
 merge BlockedMultiVector blocks to a single MultiVector More...
 
 BlockedMultiVector (const Teuchos::RCP< const BlockedMap > &map, size_t NumVectors, bool zeroOut=true)
 Constructor. More...
 
 BlockedMultiVector (Teuchos::RCP< const Xpetra::BlockedMap< LocalOrdinal, GlobalOrdinal, Node > > bmap, Teuchos::RCP< const MultiVector > v)
 
 BlockedMultiVector (Teuchos::RCP< const Xpetra::MapExtractor< Scalar, LocalOrdinal, GlobalOrdinal, Node >> mapExtractor, Teuchos::RCP< const MultiVector > v)
 
 BlockedMultiVector (const Teuchos::RCP< const BlockedMap > &map, std::vector< Teuchos::RCP< MultiVector > > &vin)
 
virtual ~BlockedMultiVector ()
 Destructor. More...
 
BlockedMultiVector< Scalar,
LocalOrdinal, GlobalOrdinal,
Node > & 
operator= (const MultiVector &rhs)
 Assignment operator: Does a deep copy. More...
 
virtual void replaceGlobalValue (GlobalOrdinal, size_t, const Scalar &)
 Replace value, using global (row) index. More...
 
virtual void sumIntoGlobalValue (GlobalOrdinal, size_t, const Scalar &)
 Add value to existing value, using global (row) index. More...
 
virtual void replaceLocalValue (LocalOrdinal, size_t, const Scalar &)
 Replace value, using local (row) index. More...
 
virtual void sumIntoLocalValue (LocalOrdinal, size_t, const Scalar &)
 Add value to existing value, using local (row) index. More...
 
virtual void putScalar (const Scalar &value)
 Set all values in the multivector with the given value. More...
 
virtual Teuchos::RCP< const
Xpetra::Vector< Scalar,
LocalOrdinal, GlobalOrdinal,
Node > > 
getVector (size_t j) const
 Return a Vector which is a const view of column j. More...
 
virtual Teuchos::RCP
< Xpetra::Vector< Scalar,
LocalOrdinal, GlobalOrdinal,
Node > > 
getVectorNonConst (size_t j)
 Return a Vector which is a nonconst view of column j. More...
 
virtual Teuchos::ArrayRCP
< const Scalar > 
getData (size_t j) const
 Const view of the local values in a particular vector of this multivector. More...
 
virtual Teuchos::ArrayRCP< Scalar > getDataNonConst (size_t j)
 View of the local values in a particular vector of this multivector. More...
 
virtual void dot (const MultiVector &, const Teuchos::ArrayView< Scalar > &) const
 Compute dot product of each corresponding pair of vectors, dots[i] = this[i].dot(A[i]). More...
 
virtual void abs (const MultiVector &)
 Put element-wise absolute values of input Multi-vector in target: A = abs(this). More...
 
virtual void reciprocal (const MultiVector &)
 Put element-wise reciprocal values of input Multi-vector in target, this(i,j) = 1/A(i,j). More...
 
virtual void scale (const Scalar &alpha)
 Scale the current values of a multi-vector, this = alpha*this. More...
 
virtual void scale (Teuchos::ArrayView< const Scalar > alpha)
 Scale the current values of a multi-vector, this[j] = alpha[j]*this[j]. More...
 
virtual void update (const Scalar &alpha, const MultiVector &A, const Scalar &beta)
 Update multi-vector values with scaled values of A, this = beta*this + alpha*A. More...
 
virtual void update (const Scalar &alpha, const MultiVector &A, const Scalar &beta, const MultiVector &B, const Scalar &gamma)
 Update multi-vector with scaled values of A and B, this = gamma*this + alpha*A + beta*B. More...
 
virtual void norm1 (const Teuchos::ArrayView< typename Teuchos::ScalarTraits< Scalar >::magnitudeType > &norms) const
 Compute 1-norm of each vector in multi-vector. More...
 
virtual void norm2 (const Teuchos::ArrayView< typename Teuchos::ScalarTraits< Scalar >::magnitudeType > &norms) const
 
virtual void normInf (const Teuchos::ArrayView< typename Teuchos::ScalarTraits< Scalar >::magnitudeType > &norms) const
 Compute Inf-norm of each vector in multi-vector. More...
 
virtual void meanValue (const Teuchos::ArrayView< Scalar > &) 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...
 
virtual void multiply (Teuchos::ETransp, Teuchos::ETransp, const Scalar &, const MultiVector &, const MultiVector &, const Scalar &)
 Matrix-matrix multiplication: this = beta*this + alpha*op(A)*op(B). More...
 
virtual void elementWiseMultiply (Scalar scalarAB, const Xpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const MultiVector &B, Scalar scalarThis)
 Element-wise multiply of a Vector A with a MultiVector B. More...
 
virtual size_t getNumVectors () const
 Number of columns in the multivector. More...
 
virtual size_t getLocalLength () const
 Local number of rows on the calling process. More...
 
virtual global_size_t getGlobalLength () const
 Global number of rows in the multivector. More...
 
virtual bool isSameSize (const Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &vec) const
 Local number of rows on the calling process. More...
 
virtual void replaceMap (const RCP< const Map > &map)
 
virtual void doImport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &, const Import &, CombineMode)
 Import. More...
 
virtual void doExport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &, const Import &, CombineMode)
 Export. More...
 
virtual void doImport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &, const Export &, CombineMode)
 Import (using an Exporter). More...
 
virtual void doExport (const DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > &, const Export &, CombineMode)
 Export (using an Importer). More...
 
virtual void setSeed (unsigned int seed)
 Set seed for Random function. More...
 
virtual void randomize (bool bUseXpetraImplementation=false)
 Set multi-vector values to random numbers. More...
 
virtual void Xpetra_randomize ()
 Set multi-vector values to random numbers. XPetra implementation. More...
 
- Public Member Functions inherited from Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >
virtual ~MultiVector ()
 Destructor. More...
 
MultiVector< Scalar,
LocalOrdinal, GlobalOrdinal,
Node > & 
operator= (const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &rhs)
 Assignment operator: Does a deep copy. More...
 
virtual void replaceMap (const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node >> &map)=0
 
- Public Member Functions inherited from Xpetra::DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node >
virtual ~DistObject ()
 Destructor. More...
 
- Protected Member Functions inherited from Xpetra::BlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >
virtual void assign (const MultiVector &rhs)
 Implementation of the assignment operator (operator=); does a deep copy. More...
 

Detailed Description

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node = KokkosClassic::DefaultNode::DefaultNodeType>
class Xpetra::ReorderedBlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >

Definition at line 73 of file Xpetra_ReorderedBlockedMultiVector.hpp.

Member Typedef Documentation

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node = KokkosClassic::DefaultNode::DefaultNodeType>
typedef Scalar Xpetra::ReorderedBlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::scalar_type

Definition at line 76 of file Xpetra_ReorderedBlockedMultiVector.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node = KokkosClassic::DefaultNode::DefaultNodeType>
typedef LocalOrdinal Xpetra::ReorderedBlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::local_ordinal_type

Definition at line 77 of file Xpetra_ReorderedBlockedMultiVector.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node = KokkosClassic::DefaultNode::DefaultNodeType>
typedef GlobalOrdinal Xpetra::ReorderedBlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::global_ordinal_type

Definition at line 78 of file Xpetra_ReorderedBlockedMultiVector.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node = KokkosClassic::DefaultNode::DefaultNodeType>
typedef Node Xpetra::ReorderedBlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::node_type

Definition at line 79 of file Xpetra_ReorderedBlockedMultiVector.hpp.

Constructor & Destructor Documentation

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node = KokkosClassic::DefaultNode::DefaultNodeType>
Xpetra::ReorderedBlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::ReorderedBlockedMultiVector ( Teuchos::RCP< const BlockedMap > &  rangeMap,
Teuchos::RCP< const Xpetra::BlockReorderManager brm,
Teuchos::RCP< const Xpetra::BlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > >  bvec 
)
inline

Constructor.

Parameters
rangeMapsrange maps for all blocks
domainMapsdomain maps for all blocks
nprextimated number of entries per row in each block(!)
brmof type BlockReorderManager
bmatoriginal full blocked operator (we keep the RCP to make sure all subblocks are available)

Definition at line 99 of file Xpetra_ReorderedBlockedMultiVector.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node = KokkosClassic::DefaultNode::DefaultNodeType>
virtual Xpetra::ReorderedBlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::~ReorderedBlockedMultiVector ( )
inlinevirtual

Destructor.

Definition at line 110 of file Xpetra_ReorderedBlockedMultiVector.hpp.

Member Function Documentation

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node = KokkosClassic::DefaultNode::DefaultNodeType>
Teuchos::RCP<const Xpetra::Map<LocalOrdinal,GlobalOrdinal,Node> > Xpetra::ReorderedBlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::mergeSubBlockMaps ( Teuchos::RCP< const Xpetra::BlockReorderManager brm)
inlineprivate

Definition at line 118 of file Xpetra_ReorderedBlockedMultiVector.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node = KokkosClassic::DefaultNode::DefaultNodeType>
std::string Xpetra::ReorderedBlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::description ( ) const
inlinevirtual

Return a simple one-line description of this object.

Reimplemented from Xpetra::BlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >.

Definition at line 153 of file Xpetra_ReorderedBlockedMultiVector.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node = KokkosClassic::DefaultNode::DefaultNodeType>
void Xpetra::ReorderedBlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::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::BlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >.

Definition at line 156 of file Xpetra_ReorderedBlockedMultiVector.hpp.

Member Data Documentation

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node = KokkosClassic::DefaultNode::DefaultNodeType>
Teuchos::RCP<const Xpetra::BlockReorderManager > Xpetra::ReorderedBlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::brm_
private

Definition at line 165 of file Xpetra_ReorderedBlockedMultiVector.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node = KokkosClassic::DefaultNode::DefaultNodeType>
Teuchos::RCP<const Xpetra::BlockedMultiVector<Scalar,LocalOrdinal,GlobalOrdinal,Node> > Xpetra::ReorderedBlockedMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::fullVec_
private

Definition at line 166 of file Xpetra_ReorderedBlockedMultiVector.hpp.


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