46 #ifndef XPETRA_BLOCKEDCRSMATRIX_HPP
47 #define XPETRA_BLOCKEDCRSMATRIX_HPP
72 #ifdef HAVE_XPETRA_THYRA
73 #include <Thyra_ProductVectorSpaceBase.hpp>
74 #include <Thyra_VectorSpaceBase.hpp>
75 #include <Thyra_LinearOpBase.hpp>
76 #include <Thyra_BlockedLinearOpBase.hpp>
77 #include <Thyra_PhysicallyBlockedLinearOpBase.hpp>
90 template <
class Scalar,
95 public Matrix<Scalar, LocalOrdinal, GlobalOrdinal, Node> {
103 #undef XPETRA_BLOCKEDCRSMATRIX_SHORT
130 for (
size_t r = 0; r <
Rows(); ++r)
131 for (
size_t c = 0; c <
Cols(); ++c)
158 for (
size_t r = 0; r <
Rows(); ++r)
159 for (
size_t c = 0; c <
Cols(); ++c)
166 #ifdef HAVE_XPETRA_THYRA
181 int numRangeBlocks = productRangeSpace->numBlocks();
182 int numDomainBlocks = productDomainSpace->numBlocks();
185 std::vector<Teuchos::RCP<const Map> > subRangeMaps(numRangeBlocks);
186 for (
size_t r=0; r<Teuchos::as<size_t>(numRangeBlocks); ++r) {
187 for (
size_t c=0; c<Teuchos::as<size_t>(numDomainBlocks); ++c) {
188 if (thyraOp->blockExists(r,c)) {
193 subRangeMaps[r] = xop->getRangeMap();
203 bool bRangeUseThyraStyleNumbering =
false;
204 size_t numAllElements = 0;
205 for(
size_t v = 0; v < subRangeMaps.size(); ++v) {
206 numAllElements += subRangeMaps[v]->getGlobalNumElements();
208 if ( fullRangeMap->getGlobalNumElements() != numAllElements) bRangeUseThyraStyleNumbering =
true;
212 std::vector<Teuchos::RCP<const Xpetra::Map<LocalOrdinal,GlobalOrdinal,Node> > > subDomainMaps(numDomainBlocks);
213 for (
size_t c=0; c<Teuchos::as<size_t>(numDomainBlocks); ++c) {
214 for (
size_t r=0; r<Teuchos::as<size_t>(numRangeBlocks); ++r) {
215 if (thyraOp->blockExists(r,c)) {
220 subDomainMaps[c] = xop->getDomainMap();
227 bool bDomainUseThyraStyleNumbering =
false;
229 for(
size_t v = 0; v < subDomainMaps.size(); ++v) {
230 numAllElements += subDomainMaps[v]->getGlobalNumElements();
232 if (fullDomainMap->getGlobalNumElements() != numAllElements) bDomainUseThyraStyleNumbering =
true;
241 for (
size_t r = 0; r <
Rows(); ++r) {
242 for (
size_t c = 0; c <
Cols(); ++c) {
243 if(thyraOp->blockExists(r,c)) {
275 std::vector<GlobalOrdinal> gids;
276 for(
size_t tt = 0; tt<subMaps.size(); ++tt) {
280 gids.insert(gids.end(), subMapGids.
begin(), subMapGids.
end());
282 size_t myNumElements = subMap->getNodeNumElements();
283 for(LocalOrdinal l = 0; l < Teuchos::as<LocalOrdinal>(myNumElements); ++l) {
284 GlobalOrdinal gid = subMap->getGlobalElement(l);
295 std::sort(gids.begin(), gids.end());
296 gids.erase(std::unique(gids.begin(), gids.end()), gids.end());
343 getMatrix(0,0)->insertGlobalValues(globalRow, cols, vals);
363 getMatrix(0,0)->insertLocalValues(localRow, cols, vals);
370 XPETRA_MONITOR(
"XpetraBlockedCrsMatrix::removeEmptyProcessesInPlace");
372 getMatrix(0,0)->removeEmptyProcessesInPlace(newMap);
392 getMatrix(0,0)->replaceGlobalValues(globalRow,cols,vals);
408 getMatrix(0,0)->replaceLocalValues(localRow,cols,vals);
417 for (
size_t row = 0; row <
Rows(); row++) {
418 for (
size_t col = 0; col <
Cols(); col++) {
420 getMatrix(row,col)->setAllToScalar(alpha);
429 for (
size_t row = 0; row <
Rows(); row++) {
430 for (
size_t col = 0; col <
Cols(); col++) {
452 for (
size_t row = 0; row <
Rows(); row++) {
453 for (
size_t col = 0; col <
Cols(); col++) {
469 getMatrix(0,0)->fillComplete(domainMap, rangeMap, params);
493 for (
size_t r = 0; r <
Rows(); ++r)
494 for (
size_t c = 0; c <
Cols(); ++c) {
498 if (Ablock != Teuchos::null && !Ablock->isFillComplete())
506 fullrowmap_ =
MapFactory::Build(rangeMap()->lib(), rangeMap()->getGlobalNumElements(), rangeMap()->getNodeElementList(), rangeMap()->getIndexBase(), rangeMap()->getComm());
509 fullcolmap_ = Teuchos::null;
511 std::vector<GO> colmapentries;
512 for (
size_t c = 0; c <
Cols(); ++c) {
515 for (
size_t r = 0; r <
Rows(); ++r) {
518 if (Ablock != Teuchos::null) {
521 copy(colElements.
getRawPtr(), colElements.
getRawPtr() + colElements.
size(), inserter(colset, colset.begin()));
526 colmapentries.reserve(colmapentries.size() + colset.size());
527 copy(colset.begin(), colset.end(), back_inserter(colmapentries));
528 sort(colmapentries.begin(), colmapentries.end());
529 typename std::vector<GO>::iterator gendLocation;
530 gendLocation = std::unique(colmapentries.begin(), colmapentries.end());
531 colmapentries.erase(gendLocation,colmapentries.end());
535 size_t numGlobalElements = 0;
553 for (
size_t row = 0; row <
Rows(); row++)
554 for (
size_t col = 0; col <
Cols(); col++)
556 globalNumRows +=
getMatrix(row,col)->getGlobalNumRows();
560 return globalNumRows;
570 for (
size_t col = 0; col <
Cols(); col++)
571 for (
size_t row = 0; row <
Rows(); row++)
573 globalNumCols +=
getMatrix(row,col)->getGlobalNumCols();
577 return globalNumCols;
585 for (
size_t row = 0; row <
Rows(); ++row)
586 for (
size_t col = 0; col <
Cols(); col++)
588 nodeNumRows +=
getMatrix(row,col)->getNodeNumRows();
600 for (
size_t row = 0; row <
Rows(); ++row)
601 for (
size_t col = 0; col <
Cols(); ++col)
603 globalNumEntries +=
getMatrix(row,col)->getGlobalNumEntries();
605 return globalNumEntries;
613 for (
size_t row = 0; row <
Rows(); ++row)
614 for (
size_t col = 0; col <
Cols(); ++col)
616 nodeNumEntries +=
getMatrix(row,col)->getNodeNumEntries();
618 return nodeNumEntries;
624 XPETRA_MONITOR(
"XpetraBlockedCrsMatrix::getNumEntriesInLocalRow");
626 return getMatrix(0,0)->getNumEntriesInLocalRow(localRow);
629 GlobalOrdinal gid = this->
getRowMap()->getGlobalElement(localRow);
640 XPETRA_MONITOR(
"XpetraBlockedCrsMatrix::getGlobalMaxNumRowEntries");
643 for (
size_t row = 0; row <
Rows(); row++) {
645 for (
size_t col = 0; col <
Cols(); col++) {
647 globalMaxEntriesBlockRows +=
getMatrix(row,col)->getGlobalMaxNumRowEntries();
650 if(globalMaxEntriesBlockRows > globalMaxEntries)
651 globalMaxEntries = globalMaxEntriesBlockRows;
653 return globalMaxEntries;
660 XPETRA_MONITOR(
"XpetraBlockedCrsMatrix::getNodeMaxNumRowEntries");
661 size_t localMaxEntries = 0;
663 for (
size_t row = 0; row <
Rows(); row++) {
664 size_t localMaxEntriesBlockRows = 0;
665 for (
size_t col = 0; col <
Cols(); col++) {
667 localMaxEntriesBlockRows +=
getMatrix(row,col)->getNodeMaxNumRowEntries();
670 if(localMaxEntriesBlockRows > localMaxEntries)
671 localMaxEntries = localMaxEntriesBlockRows;
673 return localMaxEntries;
682 for (
size_t i = 0; i <
blocks_.size(); ++i)
694 for (
size_t i = 0; i <
blocks_.size(); i++)
703 for (
size_t i = 0; i <
blocks_.size(); i++)
727 size_t &NumEntries)
const {
730 getMatrix(0,0)->getLocalRowCopy(LocalRow, Indices, Values, NumEntries);
749 getMatrix(0,0)->getGlobalRowView(GlobalRow, indices, values);
768 getMatrix(0,0)->getLocalRowView(LocalRow, indices, values);
773 GlobalOrdinal gid = this->
getRowMap()->getGlobalElement(LocalRow);
798 rm->getLocalDiagCopy(diag);
805 "BlockedCrsMatrix::getLocalDiagCopy(): the number of blocks in diag differ from the number of blocks in this operator." );
809 for (
size_t row = 0; row <
Rows(); row++) {
813 rm->getLocalDiagCopy(*rv);
814 bdiag->setMultiVector(row,rv,bdiag->getBlockedMap()->getThyraMode());
832 for (
size_t col = 0; col <
Cols(); ++col) {
842 "BlockedCrsMatrix::leftScale(): the number of blocks in diag differ from the number of blocks in this operator." );
844 for (
size_t row = 0; row <
Rows(); row++) {
848 for (
size_t col = 0; col <
Cols(); ++col) {
851 rm->leftScale(*rscale);
870 for (
size_t row = 0; row <
Rows(); ++row) {
880 "BlockedCrsMatrix::rightScale(): the number of blocks in diag differ from the number of blocks in this operator." );
882 for (
size_t col = 0; col <
Cols(); ++col) {
886 for (
size_t row = 0; row <
Rows(); row++) {
889 rm->rightScale(*rscale);
900 for (
size_t col = 0; col <
Cols(); ++col) {
901 for (
size_t row = 0; row <
Rows(); ++row) {
959 "apply() only supports the following modes: NO_TRANS and TRANS." );
968 bool bBlockedX = (refbX != Teuchos::null) ?
true :
false;
980 for (
size_t row = 0; row <
Rows(); row++) {
982 for (
size_t col = 0; col <
Cols(); col++) {
992 bool bBlockedSubMatrix = Teuchos::rcp_dynamic_cast<
BlockedCrsMatrix>(Ablock) == Teuchos::null ?
false :
true;
1004 Ablock->apply(*Xblock, *tmpYblock);
1006 Yblock->
update(one, *tmpYblock, one);
1013 for (
size_t col = 0; col <
Cols(); col++) {
1016 for (
size_t row = 0; row<
Rows(); row++) {
1024 bool bBlockedSubMatrix = Teuchos::rcp_dynamic_cast<
BlockedCrsMatrix>(Ablock) == Teuchos::null ?
false :
true;
1034 Yblock->
update(one, *tmpYblock, one);
1039 Y.
update(alpha, *tmpY, beta);
1104 "apply() only supports the following modes: NO_TRANS and TRANS." );
1112 bool bBlockedX = (refbX != Teuchos::null) ?
true :
false;
1122 for (
size_t col = 0; col <
Cols(); col++) {
1132 bool bBlockedSubMatrix = Teuchos::rcp_dynamic_cast<
BlockedCrsMatrix>(Ablock) == Teuchos::null ?
false :
true;
1144 Ablock->apply(*Xblock, *tmpYblock);
1146 Yblock->
update(one, *tmpYblock, one);
1152 Y.
update(alpha, *tmpY, beta);
1175 getMatrix(0,0)->doImport(source, importer, CM);
1185 getMatrix(0,0)->doExport(dest, importer, CM);
1195 getMatrix(0,0)->doImport(source, exporter, CM);
1205 getMatrix(0,0)->doExport(dest, exporter, CM);
1217 std::string
description()
const {
return "Xpetra_BlockedCrsMatrix.description()"; }
1221 out <<
"Xpetra::BlockedCrsMatrix: " <<
Rows() <<
" x " <<
Cols() << std::endl;
1224 out <<
"BlockMatrix is fillComplete" << std::endl;
1237 out <<
"BlockMatrix is NOT fillComplete" << std::endl;
1240 for (
size_t r = 0; r <
Rows(); ++r)
1241 for (
size_t c = 0; c <
Cols(); ++c) {
1243 out <<
"Block(" << r <<
"," << c <<
")" << std::endl;
1244 getMatrix(r,c)->describe(out,verbLevel);
1245 }
else out <<
"Block(" << r <<
"," << c <<
") = null" << std::endl;
1253 for (
size_t r = 0; r <
Rows(); ++r)
1254 for (
size_t c = 0; c <
Cols(); ++c) {
1256 std::ostringstream oss; oss<< objectLabel <<
"(" << r <<
"," << c <<
")";
1257 getMatrix(r,c)->setObjectLabel(oss.str());
1266 if (
Rows() == 1 &&
Cols () == 1)
return true;
1300 if (bmat == Teuchos::null)
return mat;
1301 return bmat->getCrsMatrix();
1307 size_t row =
Rows()+1, col =
Cols()+1;
1308 for (
size_t r = 0; r <
Rows(); ++r)
1309 for(
size_t c = 0; c <
Cols(); ++c)
1318 if (bmat == Teuchos::null)
return mm;
1319 return bmat->getInnermostCrsMatrix();
1354 using Teuchos::rcp_dynamic_cast;
1358 "BlockedCrsMatrix::Merge: only implemented for Xpetra-style or Thyra-style numbering. No mixup allowed!" );
1361 "BlockedCrsMatrix::Merge: BlockMatrix must be fill-completed." );
1367 for (
size_t i = 0; i <
Rows(); i++) {
1368 for (
size_t j = 0; j <
Cols(); j++) {
1374 if (bMat != Teuchos::null) mat = bMat->Merge();
1378 "BlockedCrsMatrix::Merge: Merging of blocked sub-operators failed?!" );
1381 if(mat->getNodeNumEntries() == 0)
continue;
1383 this->
Add(*mat, one, *sparse, one);
1389 for (
size_t i = 0; i <
Rows(); i++) {
1390 for (
size_t j = 0; j <
Cols(); j++) {
1395 if (bMat != Teuchos::null) mat = bMat->Merge();
1399 "BlockedCrsMatrix::Merge: Merging of blocked sub-operators failed?!" );
1423 if(mat->getNodeNumEntries() == 0)
continue;
1425 size_t maxNumEntries = mat->getNodeMaxNumRowEntries();
1433 for (
size_t k = 0; k < mat->getNodeNumRows(); k++) {
1435 crsMat->getCrsMatrix()->getGlobalRowCopy(rowTGID, inds(), vals(), numEntries);
1438 for (
size_t l = 0; l < numEntries; ++l) {
1444 sparse->insertGlobalValues(
1445 rowXGID, inds2(0, numEntries),
1446 vals(0, numEntries));
1456 "BlockedCrsMatrix::Merge: Local number of entries of merged matrix does not coincide with local number of entries of blocked operator." );
1459 "BlockedCrsMatrix::Merge: Global number of entries of merged matrix does not coincide with global number of entries of blocked operator." );
1465 #ifdef HAVE_XPETRA_KOKKOS_REFACTOR
1466 typedef typename CrsMatrix::local_matrix_type local_matrix_type;
1469 local_matrix_type getLocalMatrix ()
const {
1471 return getMatrix(0,0)->getLocalMatrix();
1477 #ifdef HAVE_XPETRA_THYRA
1480 Xpetra::ThyraUtils<Scalar,LO,GO,Node>::toThyra(Teuchos::rcpFromRef(*
this));
1484 Teuchos::rcp_dynamic_cast<Thyra::BlockedLinearOpBase<Scalar> >(thOp);
1509 "Matrix A is not completed");
1518 if (scalarA == zero)
1524 "BlockedCrsMatrix::Add: matrix A must be of type CrsMatrixWrap.");
1538 GO row = rowGIDs[i];
1542 for (
size_t j = 0; j < numEntries; ++j)
1571 #ifdef HAVE_XPETRA_THYRA
1581 #define XPETRA_BLOCKEDCRSMATRIX_SHORT
virtual 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...
RCP< const Map > getDomainMap(size_t i, bool bThyraMode) const
Returns the Map associated with the i'th block domain of this operator.
virtual size_t getNodeMaxNumRowEntries() const =0
Returns the maximum number of entries across all rows/columns on this node.
virtual Teuchos::RCP< const Teuchos::Comm< int > > getComm() const =0
Get this Map's Comm object.
RCP< const Map > getFullDomainMap() const
Returns the Map associated with the full domain of this operator.
virtual const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getColMap() const =0
Returns the Map that describes the column distribution in this matrix.
bool isFillComplete() const
Returns true if fillComplete() has been called and the matrix is in compute mode. ...
void replaceGlobalValues(GlobalOrdinal globalRow, const ArrayView< const GlobalOrdinal > &cols, const ArrayView< const Scalar > &vals)
Replace matrix entries, using global IDs.
void fillComplete(const RCP< const Map > &domainMap, const RCP< const Map > &rangeMap, const RCP< ParameterList > ¶ms=null)
Signal that data entry is complete.
virtual void setAllToScalar(const Scalar &alpha)
Set all matrix entries equal to scalar.
bool is_null(const std::shared_ptr< T > &p)
RCP< const Map > getRangeMap() const
Returns the Map associated with the range of this operator.
RCP< const Map > getRangeMap(size_t i, bool bThyraMode) const
Returns the Map associated with the i'th block range of this operator.
#define TEUCHOS_TEST_FOR_EXCEPTION(throw_exception_test, Exception, msg)
Teuchos::RCP< const MapExtractor > rangemaps_
virtual const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getRowMap() const =0
Returns the Map that describes the row distribution in this matrix.
void doImport(const Matrix &source, const Import &importer, CombineMode CM)
Import.
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.
virtual void bgs_apply(const MultiVector &X, MultiVector &Y, size_t row, Teuchos::ETransp mode=Teuchos::NO_TRANS, Scalar alpha=ScalarTraits< Scalar >::one(), Scalar beta=ScalarTraits< Scalar >::zero()) const
Special multiplication routine (for BGS/Jacobi smoother)
Exception throws to report errors in the internal logical of the program.
size_t getNodeNumEntries() const
Returns the local number of entries in this matrix.
virtual LocalOrdinal getLocalElement(GlobalOrdinal globalIndex) const =0
The local index corresponding to the given global index.
virtual ~BlockedCrsMatrix()
Destructor.
RCP< const Map > getRangeMap(size_t i) const
Returns the Map associated with the i'th block range of this operator.
Teuchos::RCP< Matrix > getCrsMatrix() const
return unwrap 1x1 blocked operators
void doExport(const Matrix &dest, const Import &importer, CombineMode CM)
Export.
LocalOrdinal local_ordinal_type
size_t getGlobalMaxNumRowEntries() const
Returns the maximum number of entries across all rows/columns on all nodes.
void Add(const Matrix &A, const Scalar scalarA, Matrix &B, const Scalar scalarB) const
Add a Xpetra::CrsMatrix to another: B = B*scalarB + A*scalarA.
void resumeFill(const RCP< ParameterList > ¶ms=null)
BlockedCrsMatrix(const Teuchos::RCP< const BlockedMap > &rangeMaps, const Teuchos::RCP< const BlockedMap > &domainMaps, size_t npr, Xpetra::ProfileType pftype=Xpetra::DynamicProfile)
Constructor.
global_size_t getGlobalNumCols() const
Returns the number of global columns in the matrix.
virtual void update(const Scalar &alpha, const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Scalar &beta)=0
Update multi-vector values with scaled values of A, this = beta*this + alpha*A.
void rightScale(const Vector &x)
Right scale matrix using the given vector entries.
virtual void getGlobalRowCopy(GlobalOrdinal GlobalRow, const ArrayView< GlobalOrdinal > &indices, const ArrayView< Scalar > &values, size_t &numEntries) const =0
Extract a list of entries in a specified global row of this matrix. Put into pre-allocated storage...
global_size_t getGlobalNumEntries() const
Returns the global number of entries in this matrix.
size_t getNumEntriesInLocalRow(LocalOrdinal localRow) const
Returns the current number of entries on this node in the specified local row.
RCP< const CrsGraph > getCrsGraph() const
Returns the CrsGraph associated with this matrix.
Exception indicating invalid cast attempted.
virtual bool haveGlobalConstants() const
Returns true if globalConstants have been computed; false otherwise.
void insertGlobalValues(GlobalOrdinal globalRow, const ArrayView< const GlobalOrdinal > &cols, const ArrayView< const Scalar > &vals)
Insert 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.
viewLabel_t defaultViewLabel_
virtual void insertGlobalValues(GlobalOrdinal globalRow, const ArrayView< const GlobalOrdinal > &cols, const ArrayView< const Scalar > &vals)=0
Insert matrix entries, using global IDs.
GlobalOrdinal global_ordinal_type
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)
void doExport(const Matrix &dest, const Export &exporter, CombineMode CM)
Export (using an Importer).
void leftScale(const Vector &x)
Left scale matrix using the given vector entries.
void setObjectLabel(const std::string &objectLabel)
RCP< const BlockedMap > getBlockedDomainMap() const
Returns the BlockedMap associated with the domain of this operator.
Teuchos::RCP< Matrix > getInnermostCrsMatrix()
helper routine recursively returns the first inner-most non-null matrix block from a (nested) blocked...
void insertLocalValues(LocalOrdinal localRow, const ArrayView< const LocalOrdinal > &cols, const ArrayView< const Scalar > &vals)
Insert matrix entries, using local IDs.
Teuchos::RCP< Matrix > getMatrix(size_t r, size_t c) const
return block (r,c)
virtual bool isFillComplete() const =0
Returns true if fillComplete() has been called and the matrix is in compute mode. ...
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.
virtual size_t Cols() const
number of column blocks
static Teuchos::RCP< Xpetra::Map< LocalOrdinal, GlobalOrdinal, Node > > transformThyra2XpetraGIDs(const Xpetra::Map< LocalOrdinal, GlobalOrdinal, Node > &input, const Xpetra::Map< LocalOrdinal, GlobalOrdinal, Node > &nonOvlInput, const Xpetra::Map< LocalOrdinal, GlobalOrdinal, Node > &nonOvlReferenceInput)
replace set of global ids by new global ids
RCP< const Map > getFullRangeMap() const
Returns the Map associated with the full range of this operator.
const Teuchos::RCP< const Map > getMap() const
Implements DistObject interface.
void scale(const Scalar &alpha)
Scale the current values of a matrix, this = alpha*this.
void CreateView(viewLabel_t viewLabel, const RCP< const Map > &rowMap, const RCP< const Map > &colMap)
virtual Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getMap() const =0
The Map describing the parallel distribution of this object.
viewLabel_t currentViewLabel_
TEUCHOS_DEPRECATED void reduceAll(const Comm< Ordinal > &comm, const EReductionType reductType, const Packet &send, Packet *globalReduct)
void doImport(const Matrix &source, const Export &exporter, CombineMode CM)
Import (using an Exporter).
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.
virtual GlobalOrdinal getGlobalElement(LocalOrdinal localIndex) const =0
The global index corresponding to the given local index.
Exception throws when you call an unimplemented method of Xpetra.
bool hasCrsGraph() const
Supports the getCrsGraph() call.
size_t global_size_t
Global size_t object.
static RCP< Vector > Build(const Teuchos::RCP< const Map > &map, bool zeroOut=true)
Constructor specifying the number of non-zeros for all rows.
size_t getNodeMaxNumRowEntries() const
Returns the maximum number of entries across all rows/columns on this node.
static const EVerbosityLevel verbLevel_default
std::vector< Teuchos::RCP< Matrix > > blocks_
Teuchos::RCP< Matrix > Merge() const
merge BlockedCrsMatrix blocks in a CrsMatrix
static magnitudeType magnitude(T a)
RCP< const MapExtractor > getDomainMapExtractor() const
Returns map extractor for domain map.
global_size_t getGlobalNumRows() const
Returns the number of global rows.
RCP< const CrsGraph< int, GlobalOrdinal, Node > > toXpetra(const Epetra_CrsGraph &g)
#define XPETRA_TEST_FOR_EXCEPTION(throw_exception_test, Exception, msg)
virtual bool isDiagonal() const
void setMatrix(size_t r, size_t c, Teuchos::RCP< Matrix > mat)
set matrix block
std::string description() const
Return a simple one-line description of this object.
bool bDomainThyraMode_
boolean flag, which is true, if BlockedCrsMatrix has been created using Thyra-style numbering for sub...
BlockedCrsMatrix(Teuchos::RCP< const MapExtractor > &rangeMaps, Teuchos::RCP< const MapExtractor > &domainMaps, size_t npr, Xpetra::ProfileType pftype=Xpetra::DynamicProfile)
Constructor.
bool isGloballyIndexed() const
If matrix indices are in the global range, this function returns true. Otherwise, this function retur...
Exception throws to report incompatible objects (like maps).
RCP< const Map > getDomainMap() const
Returns the Map associated with the domain of this operator.
Concrete implementation of Xpetra::Matrix.
virtual size_t Rows() const
number of row blocks
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.
CombineMode
Xpetra::Combine Mode enumerable type.
#define XPETRA_MONITOR(funcName)
static RCP< Matrix > Build(const RCP< const Map > &rowMap, size_t maxNumEntriesPerRow, Xpetra::ProfileType pftype=Xpetra::DynamicProfile)
Constructor specifying the number of non-zeros for all rows.
virtual const RCP< const Map > & getRowMap() const
Returns the Map that describes the row distribution in this matrix.
static Teuchos::RCP< Map< LocalOrdinal, GlobalOrdinal, Node > > Build(UnderlyingLib lib, global_size_t numGlobalElements, GlobalOrdinal indexBase, const Teuchos::RCP< const Teuchos::Comm< int > > &comm, LocalGlobal lg=Xpetra::GloballyDistributed)
Map constructor with Xpetra-defined contiguous uniform distribution.
virtual void scale(const Scalar &alpha)=0
Scale the current values of a matrix, this = alpha*this.
void fillComplete(const RCP< ParameterList > ¶ms=null)
Signal that data entry is complete.
#define TEUCHOS_ASSERT(assertion_test)
const viewLabel_t & GetDefaultViewLabel() const
RCP< const BlockedMap > getBlockedRangeMap() const
Returns the BlockedMap associated with the range of this operator.
RCP< const Map > getDomainMap(size_t i) const
Returns the Map associated with the i'th block domain of this operator.
virtual size_t getNumVectors() const =0
Number of columns in the multivector.
virtual size_t getNodeNumRows() const =0
Returns the number of matrix rows owned on the calling node.
size_t getNodeNumRows() const
Returns the number of matrix rows owned on the calling node.
virtual UnderlyingLib lib() const =0
Get the library used by this object (Tpetra or Epetra?)
virtual ScalarTraits< Scalar >::magnitudeType getFrobeniusNorm() const
Get Frobenius norm of the matrix.
void removeEmptyProcessesInPlace(const Teuchos::RCP< const Map > &newMap)
virtual Teuchos::RCP< const Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > getVector(size_t j) const =0
Return a Vector which is a const view of column j.
#define TEUCHOS_TEST_FOR_EXCEPT(throw_exception_test)
bool isLocallyIndexed() const
If matrix indices of all matrix blocks are in the local range, this function returns true...
void replaceLocalValues(LocalOrdinal localRow, const ArrayView< const LocalOrdinal > &cols, const ArrayView< const Scalar > &vals)
Replace matrix entries, using local IDs.
Xpetra-specific matrix class.
Teuchos::RCP< const MapExtractor > domainmaps_
virtual 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.
bool bRangeThyraMode_
boolean flag, which is true, if BlockedCrsMatrix has been created using Thyra-style numbering for sub...
RCP< const MapExtractor > getRangeMapExtractor() const
Returns map extractor class for range map.