| 
 | 
| 
typedef MatrixType::scalar_type  | scalar_type | 
|   | 
typedef  
MatrixType::local_ordinal_type  | local_ordinal_type | 
|   | 
typedef  
MatrixType::global_ordinal_type  | global_ordinal_type | 
|   | 
| 
typedef MatrixType::node_type  | node_type | 
|   | 
typedef Teuchos::ScalarTraits 
< scalar_type >::magnitudeType  | magnitude_type | 
|   | 
| 
using  | row_matrix_type = Tpetra::RowMatrix< scalar_type, local_ordinal_type, global_ordinal_type, node_type > | 
|   | 
| 
typedef row_matrix_type::mag_type  | mag_type | 
|   | 
| 
using  | scalar_type = typename MatrixType::scalar_type | 
|   | 
| 
using  | local_ordinal_type = typename MatrixType::local_ordinal_type | 
|   | 
| 
using  | global_ordinal_type = typename MatrixType::global_ordinal_type | 
|   | 
| 
using  | node_type = typename MatrixType::node_type | 
|   | 
 | 
 | 
|   | OverlappingRowMatrix (const Teuchos::RCP< const row_matrix_type > &A, const int overlapLevel) | 
|   | 
|   | ~OverlappingRowMatrix ()=default | 
|   | Destructor.  More...
  | 
|   | 
 | 
virtual Teuchos::RCP< const  
Teuchos::Comm< int > >  | getComm () const  | 
|   | The communicator over which the matrix is distributed.  More...
  | 
|   | 
virtual Teuchos::RCP< const  
Tpetra::Map 
< local_ordinal_type,  
global_ordinal_type, node_type > >  | getRowMap () const  | 
|   | The Map that describes the distribution of rows over processes.  More...
  | 
|   | 
virtual Teuchos::RCP< const  
Tpetra::Map 
< local_ordinal_type,  
global_ordinal_type, node_type > >  | getColMap () const  | 
|   | The Map that describes the distribution of columns over processes.  More...
  | 
|   | 
virtual Teuchos::RCP< const  
Tpetra::Map 
< local_ordinal_type,  
global_ordinal_type, node_type > >  | getDomainMap () const  | 
|   | The Map that describes the domain of this matrix.  More...
  | 
|   | 
virtual Teuchos::RCP< const  
Tpetra::Map 
< local_ordinal_type,  
global_ordinal_type, node_type > >  | getRangeMap () const  | 
|   | The Map that describes the range of this matrix.  More...
  | 
|   | 
virtual Teuchos::RCP< const  
Tpetra::RowGraph 
< local_ordinal_type,  
global_ordinal_type, node_type > >  | getGraph () const  | 
|   | This matrix's graph.  More...
  | 
|   | 
| virtual global_size_t  | getGlobalNumRows () const  | 
|   | The global number of rows in this matrix.  More...
  | 
|   | 
| virtual global_size_t  | getGlobalNumCols () const  | 
|   | The global number of columns in this matrix.  More...
  | 
|   | 
| virtual size_t  | getNodeNumRows () const  | 
|   | The number of rows owned by the calling process.  More...
  | 
|   | 
| virtual size_t  | getNodeNumCols () const  | 
|   | The number of columns owned by the calling process.  More...
  | 
|   | 
| virtual global_ordinal_type  | getIndexBase () const  | 
|   | The index base for global indices for this matrix.  More...
  | 
|   | 
| virtual global_size_t  | getGlobalNumEntries () const  | 
|   | The global number of entries in this matrix.  More...
  | 
|   | 
| virtual size_t  | getNodeNumEntries () const  | 
|   | The number of entries in this matrix owned by the calling process.  More...
  | 
|   | 
| virtual size_t  | getNumEntriesInGlobalRow (global_ordinal_type globalRow) const  | 
|   | The number of entries in the given global row that are owned by the calling process.  More...
  | 
|   | 
| virtual size_t  | getNumEntriesInLocalRow (local_ordinal_type localRow) const  | 
|   | The number of entries in the given local row that are owned by the calling process.  More...
  | 
|   | 
| virtual size_t  | getGlobalMaxNumRowEntries () const  | 
|   | The maximum number of entries in any row on any process.  More...
  | 
|   | 
| virtual size_t  | getNodeMaxNumRowEntries () const  | 
|   | The maximum number of entries in any row on the calling process.  More...
  | 
|   | 
| virtual bool  | hasColMap () const  | 
|   | Whether this matrix has a column Map.  More...
  | 
|   | 
| virtual bool  | isLocallyIndexed () const  | 
|   | Whether this matrix is locally indexed.  More...
  | 
|   | 
| virtual bool  | isGloballyIndexed () const  | 
|   | Whether this matrix is globally indexed.  More...
  | 
|   | 
| virtual bool  | isFillComplete () const  | 
|   | true if fillComplete() has been called, else false.  More...
  | 
|   | 
| virtual bool  | supportsRowViews () const  | 
|   | true if row views are supported, else false.  More...
  | 
|   | 
 | 
| virtual void  | getGlobalRowCopy (global_ordinal_type GlobalRow, const Teuchos::ArrayView< global_ordinal_type > &Indices, const Teuchos::ArrayView< scalar_type > &Values, size_t &NumEntries) const  | 
|   | Extract a list of entries in a specified global row of this matrix. Put into pre-allocated storage.  More...
  | 
|   | 
| virtual void  | getLocalRowCopy (local_ordinal_type LocalRow, const Teuchos::ArrayView< local_ordinal_type > &Indices, const Teuchos::ArrayView< scalar_type > &Values, size_t &NumEntries) const  | 
|   | Extract a list of entries in a specified local row of the graph. Put into storage allocated by calling routine.  More...
  | 
|   | 
| virtual void  | getGlobalRowView (global_ordinal_type GlobalRow, Teuchos::ArrayView< const global_ordinal_type > &indices, Teuchos::ArrayView< const scalar_type > &values) const  | 
|   | Extract a const, non-persisting view of global indices in a specified row of the matrix.  More...
  | 
|   | 
| virtual void  | getLocalRowView (local_ordinal_type LocalRow, Teuchos::ArrayView< const local_ordinal_type > &indices, Teuchos::ArrayView< const scalar_type > &values) const  | 
|   | Extract a const, non-persisting view of local indices in a specified row of the matrix.  More...
  | 
|   | 
| virtual void  | getLocalDiagCopy (Tpetra::Vector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &diag) const  | 
|   | Get a copy of the diagonal entries owned by this node, with local row indices.  More...
  | 
|   | 
| virtual  | ~RowMatrix ()=default | 
|   | Destructor (virtual for memory safety of derived classes)  More...
  | 
|   | 
 | 
| virtual void  | leftScale (const Tpetra::Vector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &x) | 
|   | Scales the RowMatrix on the left with the Vector x.  More...
  | 
|   | 
| virtual void  | rightScale (const Tpetra::Vector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &x) | 
|   | Scales the RowMatrix on the right with the Vector x.  More...
  | 
|   | 
| virtual mag_type  | getFrobeniusNorm () const  | 
|   | Returns the Frobenius norm of the matrix.  More...
  | 
|   | 
| virtual void  | apply (const Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &X, Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &Y, Teuchos::ETransp mode=Teuchos::NO_TRANS, scalar_type alpha=Teuchos::ScalarTraits< scalar_type >::one(), scalar_type beta=Teuchos::ScalarTraits< scalar_type >::zero()) const  | 
|   | Computes the operator-multivector application.  More...
  | 
|   | 
| virtual bool  | hasTransposeApply () const  | 
|   | Whether this operator's apply() method can apply the adjoint (transpose).  More...
  | 
|   | 
| 
virtual void  | importMultiVector (const Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &X, Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &OvX, Tpetra::CombineMode CM=Tpetra::INSERT) | 
|   | 
| 
virtual void  | exportMultiVector (const Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &OvX, Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &X, Tpetra::CombineMode CM=Tpetra::ADD) | 
|   | 
| 
std::string  | description () const  | 
|   | 
| 
void  | describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const  | 
|   | 
virtual Teuchos::RCP< const  
row_matrix_type >  | getUnderlyingMatrix () const  | 
|   | 
template<class MatrixType>
class Ifpack2::OverlappingRowMatrix< MatrixType >
Sparse matrix (Tpetra::RowMatrix subclass) with ghost rows. 
- Template Parameters
 - 
  
    | MatrixType | Tpetra::RowMatrix specialization.  |