Xpetra Version of the Day
Loading...
Searching...
No Matches
Xpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > Class Template Referenceabstract

#include <Xpetra_RowMatrix.hpp>

Inheritance diagram for Xpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >:
Xpetra::CrsMatrix< double, int, EpetraGlobalOrdinal, Node > Xpetra::CrsMatrix< double, int, int, EpetraNode > Xpetra::CrsMatrix< double, int, long long, EpetraNode > Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, KokkosClassic::DefaultNode::DefaultNodeType > Xpetra::CrsMatrix< Scalar, int, int, EpetraNode > Xpetra::CrsMatrix< Scalar, int, long long, EpetraNode > Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > Xpetra::TpetraRowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >

Public Types

typedef Scalar scalar_type
 
typedef LocalOrdinal local_ordinal_type
 
typedef GlobalOrdinal global_ordinal_type
 
typedef Node node_type
 

Constructor/Destructor Methods

virtual ~RowMatrix ()
 Destructor.
 

Matrix Query Methods

virtual const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getRowMap () const =0
 Returns the Map that describes the row distribution in this matrix.
 
virtual const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getColMap () const =0
 Returns the Map that describes the column distribution in this matrix.
 
virtual global_size_t getGlobalNumRows () const =0
 Returns the number of global rows in this matrix.
 
virtual global_size_t getGlobalNumCols () const =0
 Returns the number of global columns in this matrix.
 
virtual size_t getLocalNumRows () const =0
 Returns the number of rows owned on the calling node.
 
virtual size_t getLocalNumCols () const =0
 Returns the number of columns needed to apply the forward operator on this node, i.e., the number of elements listed in the column map.
 
virtual global_size_t getGlobalNumEntries () const =0
 Returns the global number of entries in this matrix.
 
virtual size_t getLocalNumEntries () const =0
 Returns the local number of entries in this matrix.
 
virtual size_t getNumEntriesInLocalRow (LocalOrdinal localRow) const =0
 Returns the current number of entries on this node in the specified local row.
 
virtual size_t getGlobalMaxNumRowEntries () const =0
 Returns the maximum number of entries across all rows/columns on all nodes.
 
virtual size_t getLocalMaxNumRowEntries () const =0
 Returns the maximum number of entries across all rows/columns on this node.
 
virtual bool isLocallyIndexed () const =0
 If matrix indices are in the local range, this function returns true. Otherwise, this function returns false. *‍/.
 
virtual bool isGloballyIndexed () const =0
 If matrix indices are in the global range, this function returns true. Otherwise, this function returns false. *‍/.
 
virtual bool isFillComplete () const =0
 Returns true if fillComplete() has been called.
 
virtual bool supportsRowViews () const =0
 Returns true if getLocalRowView() and getGlobalRowView() are valid for this class.
 

Extraction Methods

virtual void getLocalRowCopy (LocalOrdinal LocalRow, const Teuchos::ArrayView< LocalOrdinal > &Indices, const Teuchos::ArrayView< Scalar > &Values, size_t &NumEntries) const =0
 Extract a list of entries in a specified local row of the graph. Put into storage allocated by calling routine.
 
virtual void getGlobalRowView (GlobalOrdinal GlobalRow, ArrayView< const GlobalOrdinal > &indices, ArrayView< const Scalar > &values) const =0
 Extract a const, non-persisting view of global indices in a specified row of the matrix.
 
virtual void getLocalRowView (LocalOrdinal LocalRow, ArrayView< const LocalOrdinal > &indices, ArrayView< const Scalar > &values) const =0
 Extract a const, non-persisting view of local indices in a specified row of the matrix.
 
virtual void getLocalDiagCopy (Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &diag) const =0
 Get a copy of the diagonal entries owned by this node, with local row indices.
 

Mathematical Methods

virtual ScalarTraits< Scalar >::magnitudeType getFrobeniusNorm () const =0
 Returns the Frobenius norm of the matrix.
 

Pure virtual functions to be overridden by subclasses.

virtual const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getDomainMap () const =0
 Returns the Map associated with the domain of this operator, which must be compatible with X.getMap().
 
virtual const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getRangeMap () const =0
 Returns the Map associated with the range of this operator, which must be compatible with Y.getMap().
 
virtual void apply (const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &X, MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &Y, Teuchos::ETransp mode=Teuchos::NO_TRANS, Scalar alpha=Teuchos::ScalarTraits< Scalar >::one(), Scalar beta=Teuchos::ScalarTraits< Scalar >::zero()) const =0
 Computes the operator-multivector application.
 

Detailed Description

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

Definition at line 65 of file Xpetra_RowMatrix.hpp.

Member Typedef Documentation

◆ scalar_type

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

Definition at line 67 of file Xpetra_RowMatrix.hpp.

◆ local_ordinal_type

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

Definition at line 68 of file Xpetra_RowMatrix.hpp.

◆ global_ordinal_type

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

Definition at line 69 of file Xpetra_RowMatrix.hpp.

◆ node_type

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

Definition at line 70 of file Xpetra_RowMatrix.hpp.

Constructor & Destructor Documentation

◆ ~RowMatrix()

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

Destructor.

Definition at line 76 of file Xpetra_RowMatrix.hpp.

Member Function Documentation

◆ getRowMap()

◆ getColMap()

◆ getGlobalNumRows()

◆ getGlobalNumCols()

◆ getLocalNumRows()

◆ getLocalNumCols()

◆ getGlobalNumEntries()

◆ getLocalNumEntries()

◆ getNumEntriesInLocalRow()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node = KokkosClassic::DefaultNode::DefaultNodeType>
virtual size_t Xpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getNumEntriesInLocalRow ( LocalOrdinal  localRow) const
pure virtual

◆ getGlobalMaxNumRowEntries()

◆ getLocalMaxNumRowEntries()

◆ isLocallyIndexed()

◆ isGloballyIndexed()

◆ isFillComplete()

◆ supportsRowViews()

◆ getLocalRowCopy()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node = KokkosClassic::DefaultNode::DefaultNodeType>
virtual void Xpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getLocalRowCopy ( LocalOrdinal  LocalRow,
const Teuchos::ArrayView< LocalOrdinal > &  Indices,
const Teuchos::ArrayView< Scalar > &  Values,
size_t &  NumEntries 
) const
pure virtual

◆ getGlobalRowView()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node = KokkosClassic::DefaultNode::DefaultNodeType>
virtual void Xpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getGlobalRowView ( GlobalOrdinal  GlobalRow,
ArrayView< const GlobalOrdinal > &  indices,
ArrayView< const Scalar > &  values 
) const
pure virtual

◆ getLocalRowView()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node = KokkosClassic::DefaultNode::DefaultNodeType>
virtual void Xpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getLocalRowView ( LocalOrdinal  LocalRow,
ArrayView< const LocalOrdinal > &  indices,
ArrayView< const Scalar > &  values 
) const
pure virtual

◆ getLocalDiagCopy()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node = KokkosClassic::DefaultNode::DefaultNodeType>
virtual void Xpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getLocalDiagCopy ( Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &  diag) const
pure virtual

◆ getFrobeniusNorm()

◆ getDomainMap()

◆ getRangeMap()

◆ apply()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node = KokkosClassic::DefaultNode::DefaultNodeType>
virtual void Xpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::apply ( const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &  X,
MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &  Y,
Teuchos::ETransp  mode = Teuchos::NO_TRANS,
Scalar  alpha = Teuchos::ScalarTraits< Scalar >::one(),
Scalar  beta = Teuchos::ScalarTraits< Scalar >::zero() 
) const
pure virtual

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