46#ifndef XPETRA_TPETRACRSMATRIX_DEF_HPP
47#define XPETRA_TPETRACRSMATRIX_DEF_HPP
49#include <Xpetra_MultiVectorFactory.hpp>
51#include "Tpetra_Details_residual.hpp"
55 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
57 : mtx_ (
Teuchos::
rcp (new Tpetra::
CrsMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node> (
toTpetra(rowMap), maxNumEntriesPerRow, params))) { }
59 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
61 : mtx_(
Teuchos::
rcp(new Tpetra::
CrsMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node> (
toTpetra(rowMap), NumEntriesPerRowToAlloc(), params))) { }
63 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
64 TpetraCrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node>::TpetraCrsMatrix(
const Teuchos::RCP<
const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap,
const Teuchos::RCP<
const Map< LocalOrdinal, GlobalOrdinal, Node > > &colMap,
size_t maxNumEntriesPerRow,
const Teuchos::RCP< Teuchos::ParameterList > ¶ms)
67 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
68 TpetraCrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node>::TpetraCrsMatrix(
const Teuchos::RCP<
const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap,
const Teuchos::RCP<
const Map< LocalOrdinal, GlobalOrdinal, Node > > &colMap,
const ArrayRCP< const size_t > &NumEntriesPerRowToAlloc,
const Teuchos::RCP< Teuchos::ParameterList > ¶ms)
71 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
77 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
84 typedef Tpetra::CrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node> MyTpetraCrsMatrix;
90 mtx_=Tpetra::importAndFillCompleteCrsMatrix<MyTpetraCrsMatrix>(tSourceMatrix.getTpetra_CrsMatrix(),
toTpetra(importer),myDomainMap,myRangeMap,params);
91 bool restrictComm=
false;
92 if(!params.
is_null()) restrictComm = params->
get(
"Restrict Communicator",restrictComm);
93 if(restrictComm && mtx_->getRowMap().is_null()) mtx_=Teuchos::null;
97 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
104 typedef Tpetra::CrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node> MyTpetraCrsMatrix;
110 mtx_=Tpetra::exportAndFillCompleteCrsMatrix<MyTpetraCrsMatrix>(tSourceMatrix.getTpetra_CrsMatrix(),
toTpetra(exporter),myDomainMap,myRangeMap,params);
114 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
122 typedef Tpetra::CrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node> MyTpetraCrsMatrix;
129 mtx_=Tpetra::importAndFillCompleteCrsMatrix<MyTpetraCrsMatrix>(tSourceMatrix.getTpetra_CrsMatrix(),
toTpetra(RowImporter),
toTpetra(*DomainImporter),myDomainMap,myRangeMap,params);
130 bool restrictComm=
false;
131 if(!params.
is_null()) restrictComm = params->
get(
"Restrict Communicator",restrictComm);
132 if(restrictComm && mtx_->getRowMap().is_null()) mtx_=Teuchos::null;
135 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
143 typedef Tpetra::CrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node> MyTpetraCrsMatrix;
150 mtx_=Tpetra::exportAndFillCompleteCrsMatrix<MyTpetraCrsMatrix>(tSourceMatrix.getTpetra_CrsMatrix(),
toTpetra(RowExporter),
toTpetra(*DomainExporter),myDomainMap,myRangeMap,params);
156#ifdef HAVE_XPETRA_TPETRA
157 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
164 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
174 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
184 : mtx_(
Teuchos::
rcp(new Tpetra::
CrsMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node>(lclMatrix,
toTpetra(rowMap),
toTpetra(colMap),
toTpetra(domainMap),
toTpetra(rangeMap),
toTpetra(importer),
toTpetra(exporter), params))) { }
187 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
190 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
193 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
196 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
199 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
207 const LocalOrdinal numValid =
208 mtx_->replaceLocalValues (localRow, cols, vals);
210 static_cast<size_type
> (numValid) != cols.
size (), std::runtime_error,
211 "replaceLocalValues returned " << numValid <<
" != cols.size() = " <<
212 cols.
size () <<
".");
215 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
218 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
221 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
225 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
227 {
XPETRA_MONITOR(
"TpetraCrsMatrix::setAllValues"); mtx_->setAllValues(rowptr,colind,values); }
229 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
235 rowptr = Kokkos::Compat::persistingView(mtx_->getLocalRowPtrsHost());
236 colind = Kokkos::Compat::persistingView(mtx_->getLocalIndicesHost());
237 values = Teuchos::arcp_reinterpret_cast<const Scalar>(
238 Kokkos::Compat::persistingView(mtx_->getLocalValuesHost(
239 Tpetra::Access::ReadOnly)));
242 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
247 values = Teuchos::arcp_reinterpret_cast<Scalar>(
248 Kokkos::Compat::persistingView(mtx_->getLocalValuesDevice(
249 Tpetra::Access::ReadWrite)));
252 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
254 {
return mtx_->haveGlobalConstants();}
256 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
259 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
260 void TpetraCrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node>::fillComplete(
const RCP<
const Map< LocalOrdinal, GlobalOrdinal, Node > > &domainMap,
const RCP<
const Map< LocalOrdinal, GlobalOrdinal, Node > > &rangeMap,
const RCP< ParameterList > ¶ms) {
XPETRA_MONITOR(
"TpetraCrsMatrix::fillComplete"); mtx_->fillComplete(
toTpetra(domainMap),
toTpetra(rangeMap), params); }
262 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
266 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
271 mtx_->replaceDomainMapAndImporter(
toTpetra(newDomainMap),myImport);
274 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
284 if(importer!=Teuchos::null) {
286 myImport = tImporter.getTpetra_Import();
288 if(exporter!=Teuchos::null) {
290 myExport = tExporter.getTpetra_Export();
293 mtx_->expertStaticFillComplete(
toTpetra(domainMap),
toTpetra(rangeMap),myImport,myExport,params);
296 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
299 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
302 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
305 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
308 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
311 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
314 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
317 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
320 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
323 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
326 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
329 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
332 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
335 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
338 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
341 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
344 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
347 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
350 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
353 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
356 typename Tpetra::CrsGraph<LocalOrdinal,GlobalOrdinal,Node>::nonconst_local_inds_host_view_type indices(
"indices",Indices.
size());
357 typename Tpetra::CrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node>::nonconst_values_host_view_type values(
"values", Values.
size());
359 mtx_->getLocalRowCopy(LocalRow, indices, values, NumEntries);
360 for (
size_t i=0;i<NumEntries; ++i) {
361 Indices[i]=indices(i);
366 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
369 typename Tpetra::CrsGraph<LocalOrdinal,GlobalOrdinal,Node>::nonconst_global_inds_host_view_type indices(
"indices",Indices.
size());
370 typename Tpetra::CrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node>::nonconst_values_host_view_type values(
"values", Values.
size());
372 mtx_->getGlobalRowCopy(GlobalRow, indices, values, NumEntries);
373 for (
size_t i=0;i<NumEntries; ++i) {
374 Indices[i]=indices(i);
380 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
383 typename Tpetra::CrsGraph<LocalOrdinal,GlobalOrdinal,Node>::global_inds_host_view_type indices;
384 typename Tpetra::CrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node>::values_host_view_type values;
386 mtx_->getGlobalRowView(GlobalRow, indices, values);
391 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
394 typename Tpetra::CrsGraph<LocalOrdinal,GlobalOrdinal,Node>::local_inds_host_view_type indices;
395 typename Tpetra::CrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node>::values_host_view_type values;
397 mtx_->getLocalRowView(LocalRow, indices, values);
402 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
403 void TpetraCrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node>::apply(
const MultiVector &X,
MultiVector &Y,
Teuchos::ETransp mode, Scalar alpha, Scalar beta)
const {
XPETRA_MONITOR(
"TpetraCrsMatrix::apply"); mtx_->apply(
toTpetra(X),
toTpetra(Y), mode, alpha, beta); }
405 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
406 void TpetraCrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node>::apply(
const MultiVector &X,
MultiVector &Y,
Teuchos::ETransp mode, Scalar alpha, Scalar beta,
bool sumInterfaceValues,
const RCP<
Import<LocalOrdinal, GlobalOrdinal, Node> >& regionInterfaceImporter,
const Teuchos::ArrayRCP<LocalOrdinal>& regionInterfaceLIDs )
const
411 if (sumInterfaceValues)
416 matvecInterfaceTmp->doImport(Y, *regionInterfaceImporter,
INSERT);
422 for(LocalOrdinal interfaceIdx = 0; interfaceIdx < static_cast<LocalOrdinal>(interfaceData.
size()); ++interfaceIdx) {
423 YData[regionInterfaceLIDs[interfaceIdx]] += interfaceData[interfaceIdx];
428 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
431 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
434 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
437 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
440 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
444 mtx_->setObjectLabel(objectLabel);
449 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
453 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
457 mtx_->getLocalDiagCopy(*tDiag.getTpetra_Vector());
460 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
463 mtx_->getLocalDiagOffsets(offsets);
466 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
469 mtx_->getLocalDiagCopy(*(
toTpetra(diag)), offsets);
472 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
475 Tpetra::replaceDiagonalCrsMatrix(*mtx_, *(
toTpetra(diag)));
478 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
484 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
490 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
493 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
505 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
516 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
527 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
538 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
541 mtx_->removeEmptyProcessesInPlace(
toTpetra(newMap));
544 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
546 return ! mtx_.is_null ();
549 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
552 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
556 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
560 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
#define XPETRA_MONITOR(funcName)
#define XPETRA_DYNAMIC_CAST(type, obj, newObj, exceptionMsg)
void resize(const size_type n, const T &val=T())
virtual void setObjectLabel(const std::string &objectLabel)
static Teuchos::RCP< MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > Build(const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &map, size_t NumVectors, bool zeroOut=true)
Constructor specifying the number of non-zeros for all rows.
virtual Teuchos::ArrayRCP< Scalar > getDataNonConst(size_t j)=0
View of the local values in a particular vector of this multivector.
void insertLocalValues(LocalOrdinal localRow, const ArrayView< const LocalOrdinal > &cols, const ArrayView< const Scalar > &vals)
Insert matrix entries, using local IDs.
bool supportsRowViews() const
Returns true if getLocalRowView() and getGlobalRowView() are valid for this class.
RCP< Tpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > getTpetra_CrsMatrixNonConst() const
Get the underlying Tpetra matrix.
void replaceLocalValues(LocalOrdinal localRow, const ArrayView< const LocalOrdinal > &cols, const ArrayView< const Scalar > &vals)
Replace matrix entries, using local IDs.
TpetraCrsMatrix(const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap, size_t maxNumEntriesPerRow, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null)
Constructor specifying fixed number of entries for each row.
ScalarTraits< Scalar >::magnitudeType getFrobeniusNorm() const
Returns the Frobenius norm of the matrix.
void getGlobalRowCopy(GlobalOrdinal GlobalRow, const ArrayView< GlobalOrdinal > &indices, const ArrayView< Scalar > &values, size_t &numEntries) const
Extract a list of entries in a specified global row of this matrix. Put into pre-allocated storage.
Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::local_matrix_type local_matrix_type
void replaceGlobalValues(GlobalOrdinal globalRow, const ArrayView< const GlobalOrdinal > &cols, const ArrayView< const Scalar > &vals)
Replace matrix entries, using global IDs.
void getLocalDiagCopy(Vector &diag) const
Get a copy of the diagonal entries owned by this node, with local row indices.
size_t getNumEntriesInGlobalRow(GlobalOrdinal globalRow) const
Returns the current number of entries in the (locally owned) global row.
void scale(const Scalar &alpha)
Scale the current values of a matrix, this = alpha*this.
void rightScale(const Vector &x)
Right scale operator with given vector values.
void getLocalRowCopy(LocalOrdinal LocalRow, const ArrayView< LocalOrdinal > &Indices, const ArrayView< Scalar > &Values, size_t &NumEntries) const
Extract a list of entries in a specified local row of the matrix. Put into storage allocated by calli...
global_size_t getGlobalNumCols() const
Number of global columns in the matrix.
void fillComplete(const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &domainMap, const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rangeMap, const RCP< ParameterList > ¶ms=null)
Signal that data entry is complete, specifying domain and range maps.
const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getColMap() const
Returns the Map that describes the column distribution in this matrix.
void allocateAllValues(size_t numNonZeros, ArrayRCP< size_t > &rowptr, ArrayRCP< LocalOrdinal > &colind, ArrayRCP< Scalar > &values)
Allocates and returns ArrayRCPs of the Crs arrays — This is an Xpetra-only routine.
void residual(const MultiVector &X, const MultiVector &B, MultiVector &R) const
Compute a residual R = B - (*this) * X.
void doExport(const DistObject< char, LocalOrdinal, GlobalOrdinal, Node > &dest, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)
Export.
bool isGloballyIndexed() const
If matrix indices are in the global range, this function returns true. Otherwise, this function retur...
void resumeFill(const RCP< ParameterList > ¶ms=null)
void getLocalDiagOffsets(Teuchos::ArrayRCP< size_t > &offsets) const
Get offsets of the diagonal entries in the matrix.
void insertGlobalValues(GlobalOrdinal globalRow, const ArrayView< const GlobalOrdinal > &cols, const ArrayView< const Scalar > &vals)
Insert matrix entries, using global IDs.
void leftScale(const Vector &x)
Left scale operator with given vector values.
void getLocalRowView(LocalOrdinal LocalRow, ArrayView< const LocalOrdinal > &indices, ArrayView< const Scalar > &values) const
Extract a const, non-persisting view of local indices in a specified row of the matrix.
bool haveGlobalConstants() const
Returns true if globalConstants have been computed; false otherwise.
bool hasMatrix() const
Does this have an underlying matrix.
size_t getLocalMaxNumRowEntries() const
Returns the maximum number of entries across all rows/columns on this node.
std::string description() const
A simple one-line description of this object.
RCP< const Tpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > getTpetra_CrsMatrix() const
Get the underlying Tpetra matrix.
size_t getLocalNumRows() const
Returns the number of matrix rows owned on the calling node.
virtual ~TpetraCrsMatrix()
Destructor.
void setAllToScalar(const Scalar &alpha)
Set all matrix entries equal to scalarThis.
bool isLocallyIndexed() const
If matrix indices are in the local range, this function returns true. Otherwise, this function return...
bool isFillActive() const
Returns true if the matrix is in edit mode.
void replaceDomainMapAndImporter(const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &newDomainMap, Teuchos::RCP< const Import< LocalOrdinal, GlobalOrdinal, Node > > &newImporter)
Replaces the current domainMap and importer with the user-specified objects.
void setAllValues(const ArrayRCP< size_t > &rowptr, const ArrayRCP< LocalOrdinal > &colind, const ArrayRCP< Scalar > &values)
Sets the 1D pointer arrays of the graph.
void removeEmptyProcessesInPlace(const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &newMap)
size_t getLocalNumCols() const
Returns the number of columns connected to the locally owned rows of this matrix.
global_size_t getGlobalNumEntries() const
Returns the global number of entries in this matrix.
void getAllValues(ArrayRCP< const size_t > &rowptr, ArrayRCP< const LocalOrdinal > &colind, ArrayRCP< const Scalar > &values) const
Gets the 1D pointer arrays of the graph.
void doImport(const DistObject< char, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)
Import.
global_size_t getGlobalNumRows() const
Number of global elements in the row map of this matrix.
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.
size_t getNumEntriesInLocalRow(LocalOrdinal localRow) const
Returns the current number of entries on this node in the specified local row.
void getGlobalRowView(GlobalOrdinal GlobalRow, ArrayView< const GlobalOrdinal > &indices, ArrayView< const Scalar > &values) const
Extract a const, non-persisting view of global indices in a specified row of the matrix.
const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getDomainMap() const
Returns the Map associated with the domain of this operator. This will be null until fillComplete() i...
void expertStaticFillComplete(const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &domainMap, const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rangeMap, const RCP< const Import< LocalOrdinal, GlobalOrdinal, Node > > &importer=Teuchos::null, const RCP< const Export< LocalOrdinal, GlobalOrdinal, Node > > &exporter=Teuchos::null, const RCP< ParameterList > ¶ms=Teuchos::null)
Expert static fill complete.
void replaceDiag(const Vector &diag)
Replace the diagonal entries of the matrix.
const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getRowMap() const
Returns the Map that describes the row distribution in this matrix.
size_t getGlobalMaxNumRowEntries() const
Returns the maximum number of entries across all rows/columns on all nodes.
void setObjectLabel(const std::string &objectLabel)
void apply(const MultiVector &X, MultiVector &Y, Teuchos::ETransp mode=Teuchos::NO_TRANS, Scalar alpha=ScalarTraits< Scalar >::one(), Scalar beta=ScalarTraits< Scalar >::zero()) const
Computes the sparse matrix-multivector multiplication.
RCP< const CrsGraph< LocalOrdinal, GlobalOrdinal, Node > > getCrsGraph() const
Returns the CrsGraph associated with this matrix.
const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getRangeMap() const
Returns the Map associated with the range of this operator, which must be compatible with Y....
bool isFillComplete() const
Returns true if the matrix is in compute mode, i.e. if fillComplete() has been called.
size_t getLocalNumEntries() const
Returns the local number of entries in this matrix.
Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getMap() const
Implements DistObject interface.
#define TEUCHOS_TEST_FOR_EXCEPTION(throw_exception_test, Exception, msg)
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)
size_t global_size_t
Global size_t object.
RCP< const CrsGraph< int, GlobalOrdinal, Node > > toXpetra(const Epetra_CrsGraph &g)
RCP< const Tpetra::CrsGraph< LocalOrdinal, GlobalOrdinal, Node > > toTpetra(const RCP< const CrsGraph< LocalOrdinal, GlobalOrdinal, Node > > &graph)
CombineMode
Xpetra::Combine Mode enumerable type.