43 #ifndef IFPACK2_LOCALFILTER_DEF_HPP 44 #define IFPACK2_LOCALFILTER_DEF_HPP 46 #include <Ifpack2_LocalFilter_decl.hpp> 47 #include <Tpetra_Map.hpp> 48 #include <Tpetra_MultiVector.hpp> 49 #include <Tpetra_Vector.hpp> 54 # include "Teuchos_DefaultSerialComm.hpp" 60 template<
class MatrixType>
62 LocalFilter<MatrixType>::
63 mapPairsAreFitted (
const row_matrix_type& A)
65 const map_type& rangeMap = * (A.getRangeMap ());
66 const map_type& rowMap = * (A.getRowMap ());
67 const bool rangeAndRowFitted = mapPairIsFitted (rangeMap, rowMap);
69 const map_type& domainMap = * (A.getDomainMap ());
70 const map_type& columnMap = * (A.getColMap ());
71 const bool domainAndColumnFitted = mapPairIsFitted (domainMap, columnMap);
73 return rangeAndRowFitted && domainAndColumnFitted;
77 template<
class MatrixType>
79 LocalFilter<MatrixType>::
80 mapPairIsFitted (
const map_type& map1,
const map_type& map2)
82 return map1.isLocallyFitted (map2);
86 template<
class MatrixType>
97 #ifdef HAVE_IFPACK2_DEBUG 99 ! mapPairsAreFitted (*A), std::invalid_argument,
"Ifpack2::LocalFilter: " 100 "A's Map pairs are not fitted to each other on Process " 101 << A_->getRowMap ()->getComm ()->getRank () <<
" of the input matrix's " 103 "This means that LocalFilter does not currently know how to work with A. " 104 "This will change soon. Please see discussion of Bug 5992.");
105 #endif // HAVE_IFPACK2_DEBUG 108 RCP<const Teuchos::Comm<int> > localComm;
110 localComm =
rcp (
new Teuchos::MpiComm<int> (MPI_COMM_SELF));
138 const size_t numRows = A_->getRangeMap()->getNodeNumElements ();
146 const global_ordinal_type indexBase =
static_cast<global_ordinal_type
> (0);
150 Tpetra::GloballyDistributed, A_->getNode ()));
153 localRangeMap_ = localRowMap_;
160 localDomainMap_ = localRangeMap_;
163 const size_t numCols = A_->getDomainMap()->getNodeNumElements ();
166 Tpetra::GloballyDistributed, A_->getNode ()));
172 NumEntries_.resize (numRows);
176 MaxNumEntries_ = A_->getNodeMaxNumRowEntries ();
177 MaxNumEntriesA_ = A_->getNodeMaxNumRowEntries ();
180 localIndices_.
resize (MaxNumEntries_);
181 Values_.
resize (MaxNumEntries_);
190 size_t ActualMaxNumEntries = 0;
192 for (
size_t i = 0; i < numRows; ++i) {
194 size_t Nnz, NewNnz = 0;
195 A_->getLocalRowCopy (i, localIndices_, Values_, Nnz);
196 for (
size_t j = 0; j < Nnz; ++j) {
208 if (static_cast<size_t> (localIndices_[j]) < numRows) {
213 if (NewNnz > ActualMaxNumEntries) {
214 ActualMaxNumEntries = NewNnz;
217 NumNonzeros_ += NewNnz;
218 NumEntries_[i] = NewNnz;
221 MaxNumEntries_ = ActualMaxNumEntries;
225 template<
class MatrixType>
230 template<
class MatrixType>
234 return localRowMap_->getComm ();
238 template<
class MatrixType>
242 return A_->getNode ();
246 template<
class MatrixType>
247 Teuchos::RCP<
const Tpetra::Map<
typename MatrixType::local_ordinal_type,
248 typename MatrixType::global_ordinal_type,
249 typename MatrixType::node_type> >
256 template<
class MatrixType>
257 Teuchos::RCP<
const Tpetra::Map<
typename MatrixType::local_ordinal_type,
258 typename MatrixType::global_ordinal_type,
259 typename MatrixType::node_type> >
266 template<
class MatrixType>
267 Teuchos::RCP<
const Tpetra::Map<
typename MatrixType::local_ordinal_type,
268 typename MatrixType::global_ordinal_type,
269 typename MatrixType::node_type> >
272 return localDomainMap_;
276 template<
class MatrixType>
277 Teuchos::RCP<
const Tpetra::Map<
typename MatrixType::local_ordinal_type,
278 typename MatrixType::global_ordinal_type,
279 typename MatrixType::node_type> >
282 return localRangeMap_;
286 template<
class MatrixType>
287 Teuchos::RCP<
const Tpetra::RowGraph<
typename MatrixType::local_ordinal_type,
288 typename MatrixType::global_ordinal_type,
289 typename MatrixType::node_type> >
295 return A_->getGraph ();
299 template<
class MatrixType>
302 return static_cast<global_size_t
> (localRangeMap_->getNodeNumElements ());
306 template<
class MatrixType>
309 return static_cast<global_size_t
> (localDomainMap_->getNodeNumElements ());
313 template<
class MatrixType>
316 return static_cast<size_t> (localRangeMap_->getNodeNumElements ());
320 template<
class MatrixType>
323 return static_cast<size_t> (localDomainMap_->getNodeNumElements ());
327 template<
class MatrixType>
328 typename MatrixType::global_ordinal_type
331 return A_->getIndexBase ();
335 template<
class MatrixType>
342 template<
class MatrixType>
349 template<
class MatrixType>
363 return NumEntries_[localRow];
368 template<
class MatrixType>
378 if (getRowMap ()->isNodeLocalElement (localRow)) {
379 return NumEntries_[localRow];
391 template<
class MatrixType>
394 return MaxNumEntries_;
398 template<
class MatrixType>
401 return MaxNumEntries_;
405 template<
class MatrixType>
412 template<
class MatrixType>
415 return A_->isLocallyIndexed ();
419 template<
class MatrixType>
422 return A_->isGloballyIndexed();
426 template<
class MatrixType>
429 return A_->isFillComplete ();
433 template<
class MatrixType>
439 size_t& numEntries)
const 444 const LO localRow = this->getRowMap ()->getLocalElement (globalRow);
457 numEntries = this->getNumEntriesInLocalRow (localRow);
462 this->getLocalRowCopy (localRow, localIndices (), values, numEntries);
464 const map_type& colMap = * (this->getColMap ());
467 const size_type numEnt =
468 std::min (static_cast<size_type> (numEntries),
469 std::min (globalIndices.
size (), values.
size ()));
470 for (size_type k = 0; k < numEnt; ++k) {
471 globalIndices[k] = colMap.getGlobalElement (localIndices[k]);
477 template<
class MatrixType>
483 size_t &NumEntries)
const 486 typedef global_ordinal_type GO;
488 if (! A_->getRowMap ()->isNodeLocalElement (LocalRow)) {
494 if (A_->getRowMap()->getComm()->getSize() == 1) {
495 A_->getLocalRowCopy (LocalRow, Indices (), Values (), NumEntries);
500 const size_t numEntInLclRow = NumEntries_[LocalRow];
501 if (static_cast<size_t> (Indices.
size ()) < numEntInLclRow ||
502 static_cast<size_t> (Values.
size ()) < numEntInLclRow) {
507 true, std::runtime_error,
508 "Ifpack2::LocalFilter::getLocalRowCopy: Invalid output array length. " 509 "The output arrays must each have length at least " << numEntInLclRow
510 <<
" for local row " << LocalRow <<
" on Process " 511 << localRowMap_->getComm ()->getRank () <<
".");
513 else if (numEntInLclRow == static_cast<size_t> (0)) {
532 size_t numEntInMat = 0;
533 A_->getLocalRowCopy (LocalRow, localIndices_ (), Values_ (), numEntInMat);
538 const map_type& matrixDomMap = * (A_->getDomainMap ());
539 const map_type& matrixColMap = * (A_->getColMap ());
541 const size_t capacity =
static_cast<size_t> (std::min (Indices.
size (),
544 const size_t numRows = localRowMap_->getNodeNumElements ();
545 const bool buggy =
true;
546 for (
size_t j = 0; j < numEntInMat; ++j) {
552 const LO matrixLclCol = localIndices_[j];
553 const GO gblCol = matrixColMap.getGlobalElement (matrixLclCol);
562 if ((
size_t) localIndices_[j] < numRows) {
563 Indices[NumEntries] = localIndices_[j];
564 Values[NumEntries] = Values_[j];
568 if (matrixDomMap.isNodeGlobalElement (gblCol)) {
572 if (NumEntries < capacity) {
573 Indices[NumEntries] = matrixLclCol;
574 Values[NumEntries] = Values_[j];
583 template<
class MatrixType>
591 "Ifpack2::LocalFilter does not implement getGlobalRowView.");
595 template<
class MatrixType>
603 "Ifpack2::LocalFilter does not implement getLocalRowView.");
607 template<
class MatrixType>
610 getLocalDiagCopy (Tpetra::Vector<scalar_type,local_ordinal_type,global_ordinal_type,node_type>& diag)
const 614 global_ordinal_type, node_type> vector_type;
617 RCP<vector_type> diagView = diag.offsetViewNonConst (A_->getRowMap (), 0);
618 A_->getLocalDiagCopy (*diagView);
622 template<
class MatrixType>
625 leftScale (
const Tpetra::Vector<scalar_type, local_ordinal_type, global_ordinal_type, node_type>& )
628 "Ifpack2::LocalFilter does not implement leftScale.");
632 template<
class MatrixType>
635 rightScale (
const Tpetra::Vector<scalar_type, local_ordinal_type, global_ordinal_type, node_type>& )
638 "Ifpack2::LocalFilter does not implement rightScale.");
642 template<
class MatrixType>
645 apply (
const Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &X,
646 Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &Y,
651 typedef Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> MV;
653 X.getNumVectors() != Y.getNumVectors(), std::runtime_error,
654 "Ifpack2::LocalFilter::apply: X and Y must have the same number of columns. " 655 "X has " << X.getNumVectors () <<
" columns, but Y has " 656 << Y.getNumVectors () <<
" columns.");
658 #ifdef HAVE_IFPACK2_DEBUG 664 for (
size_t j = 0; j < X.getNumVectors (); ++j) {
665 if (STM::isnaninf (norms[j])) {
670 TEUCHOS_TEST_FOR_EXCEPTION( ! good, std::runtime_error,
"Ifpack2::LocalFilter::apply: The 1-norm of the input X is NaN or Inf.");
672 #endif // HAVE_IFPACK2_DEBUG 680 MV X_copy (X, Teuchos::Copy);
681 applyNonAliased (X_copy, Y, mode, alpha, beta);
683 applyNonAliased (X, Y, mode, alpha, beta);
686 #ifdef HAVE_IFPACK2_DEBUG 692 for (
size_t j = 0; j < Y.getNumVectors (); ++j) {
693 if (STM::isnaninf (norms[j])) {
698 TEUCHOS_TEST_FOR_EXCEPTION( ! good, std::runtime_error,
"Ifpack2::LocalFilter::apply: The 1-norm of the output Y is NaN or Inf.");
700 #endif // HAVE_IFPACK2_DEBUG 703 template<
class MatrixType>
706 applyNonAliased (
const Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &X,
707 Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &Y,
710 scalar_type beta)
const 716 const scalar_type
zero = STS::zero ();
717 const scalar_type one = STS::one ();
722 else if (beta != one) {
726 const size_t NumVectors = Y.getNumVectors ();
727 const size_t numRows = localRowMap_->getNodeNumElements ();
734 const bool constantStride = X.isConstantStride () && Y.isConstantStride ();
735 if (constantStride) {
738 const size_t x_stride = X.getStride();
739 const size_t y_stride = Y.getStride();
740 ArrayRCP<scalar_type> y_rcp = Y.get1dViewNonConst();
741 ArrayRCP<const scalar_type> x_rcp = X.get1dView();
742 ArrayView<scalar_type> y_ptr = y_rcp();
743 ArrayView<const scalar_type> x_ptr = x_rcp();
744 for (
size_t i = 0; i < numRows; ++i) {
747 getLocalRowCopy (i, localIndices_ (), Values_ (), Nnz);
748 if (mode == Teuchos::NO_TRANS) {
749 for (
size_t j = 0; j < Nnz; ++j) {
750 const local_ordinal_type col = localIndices_[j];
751 for (
size_t k = 0; k < NumVectors; ++k) {
752 y_ptr[i + y_stride*k] +=
753 alpha * Values_[j] * x_ptr[col + x_stride*k];
757 else if (mode == Teuchos::TRANS) {
758 for (
size_t j = 0; j < Nnz; ++j) {
759 const local_ordinal_type col = localIndices_[j];
760 for (
size_t k = 0; k < NumVectors; ++k) {
761 y_ptr[col + y_stride*k] +=
762 alpha * Values_[j] * x_ptr[i + x_stride*k];
767 for (
size_t j = 0; j < Nnz; ++j) {
768 const local_ordinal_type col = localIndices_[j];
769 for (
size_t k = 0; k < NumVectors; ++k) {
770 y_ptr[col + y_stride*k] +=
771 alpha * STS::conjugate (Values_[j]) * x_ptr[i + x_stride*k];
780 ArrayRCP<ArrayRCP<const scalar_type> > x_ptr = X.get2dView();
781 ArrayRCP<ArrayRCP<scalar_type> > y_ptr = Y.get2dViewNonConst();
783 for (
size_t i = 0; i < numRows; ++i) {
786 getLocalRowCopy (i, localIndices_ (), Values_ (), Nnz);
787 if (mode == Teuchos::NO_TRANS) {
788 for (
size_t k = 0; k < NumVectors; ++k) {
789 ArrayView<const scalar_type> x_local = (x_ptr())[k]();
790 ArrayView<scalar_type> y_local = (y_ptr())[k]();
791 for (
size_t j = 0; j < Nnz; ++j) {
792 y_local[i] += alpha * Values_[j] * x_local[localIndices_[j]];
796 else if (mode == Teuchos::TRANS) {
797 for (
size_t k = 0; k < NumVectors; ++k) {
798 ArrayView<const scalar_type> x_local = (x_ptr())[k]();
799 ArrayView<scalar_type> y_local = (y_ptr())[k]();
800 for (
size_t j = 0; j < Nnz; ++j) {
801 y_local[localIndices_[j]] += alpha * Values_[j] * x_local[i];
806 for (
size_t k = 0; k < NumVectors; ++k) {
807 ArrayView<const scalar_type> x_local = (x_ptr())[k]();
808 ArrayView<scalar_type> y_local = (y_ptr())[k]();
809 for (
size_t j = 0; j < Nnz; ++j) {
810 y_local[localIndices_[j]] +=
811 alpha * STS::conjugate (Values_[j]) * x_local[i];
819 template<
class MatrixType>
826 template<
class MatrixType>
833 template<
class MatrixType>
835 LocalFilter<MatrixType>::mag_type
838 #ifdef TPETRA_HAVE_KOKKOS_REFACTOR 839 typedef Kokkos::Details::ArithTraits<scalar_type> STS;
840 typedef Kokkos::Details::ArithTraits<mag_type> STM;
847 const size_type maxNumRowEnt = getNodeMaxNumRowEntries ();
850 const size_t numRows =
static_cast<size_t> (localRowMap_->getNodeNumElements ());
853 mag_type sumSquared = STM::zero ();
854 for (
size_t i = 0; i < numRows; ++i) {
855 size_t numEntries = 0;
856 this->getLocalRowCopy (i, ind (), val (), numEntries);
857 for (size_type k = 0; k < static_cast<size_type> (numEntries); ++k) {
858 const mag_type v_k_abs = STS::magnitude (val[k]);
859 sumSquared += v_k_abs * v_k_abs;
862 return STM::squareroot (sumSquared);
865 template<
class MatrixType>
870 std::ostringstream os;
872 os <<
"Ifpack2::LocalFilter: {";
873 os <<
"MatrixType: " << TypeNameTraits<MatrixType>::name ();
874 if (this->getObjectLabel () !=
"") {
875 os <<
", Label: \"" << this->getObjectLabel () <<
"\"";
877 os <<
", Number of rows: " << getGlobalNumRows ()
878 <<
", Number of columns: " << getGlobalNumCols ()
884 template<
class MatrixType>
901 out <<
"Ifpack2::LocalFilter:" << endl;
903 out <<
"MatrixType: " << TypeNameTraits<MatrixType>::name () << endl;
904 if (this->getObjectLabel () !=
"") {
905 out <<
"Label: \"" << this->getObjectLabel () <<
"\"" << endl;
907 out <<
"Number of rows: " << getGlobalNumRows () << endl
908 <<
"Number of columns: " << getGlobalNumCols () << endl
909 <<
"Number of nonzeros: " << NumNonzeros_ << endl;
912 out <<
"Row Map:" << endl;
913 localRowMap_->describe (out, vl);
914 out <<
"Domain Map:" << endl;
915 localDomainMap_->describe (out, vl);
916 out <<
"Range Map:" << endl;
917 localRangeMap_->describe (out, vl);
922 template<
class MatrixType>
923 Teuchos::RCP<
const Tpetra::RowMatrix<
typename MatrixType::scalar_type,
924 typename MatrixType::local_ordinal_type,
925 typename MatrixType::global_ordinal_type,
926 typename MatrixType::node_type> >
935 #define IFPACK2_LOCALFILTER_INSTANT(S,LO,GO,N) \ 936 template class Ifpack2::LocalFilter< Tpetra::RowMatrix<S, LO, GO, N> >; 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.
Definition: Ifpack2_LocalFilter_def.hpp:598
virtual bool isFillComplete() const
Returns true if fillComplete() has been called.
Definition: Ifpack2_LocalFilter_def.hpp:427
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.
Definition: Ifpack2_LocalFilter_def.hpp:635
virtual mag_type getFrobeniusNorm() const
The Frobenius norm of the (locally filtered) matrix.
Definition: Ifpack2_LocalFilter_def.hpp:836
basic_OSTab< char > OSTab
virtual Teuchos::RCP< const row_matrix_type > getUnderlyingMatrix() const
Return matrix that LocalFilter was built on.
Definition: Ifpack2_LocalFilter_def.hpp:927
virtual global_size_t getGlobalNumCols() const
The number of global columns in this matrix.
Definition: Ifpack2_LocalFilter_def.hpp:307
virtual bool isLocallyIndexed() const
Whether the underlying sparse matrix is locally (opposite of globally) indexed.
Definition: Ifpack2_LocalFilter_def.hpp:413
virtual void describe(Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default) const
Print the object to the given output stream.
Definition: Ifpack2_LocalFilter_def.hpp:887
#define TEUCHOS_TEST_FOR_EXCEPTION(throw_exception_test, Exception, msg)
virtual size_t getNodeNumCols() const
The number of columns in the (locally filtered) matrix.
Definition: Ifpack2_LocalFilter_def.hpp:321
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.
Definition: Ifpack2_LocalFilter_def.hpp:586
virtual global_size_t getGlobalNumRows() const
The number of global rows in this matrix.
Definition: Ifpack2_LocalFilter_def.hpp:300
virtual Teuchos::RCP< const map_type > getRangeMap() const
Returns the Map that describes the range distribution in this matrix.
Definition: Ifpack2_LocalFilter_def.hpp:280
Tpetra::Map< local_ordinal_type, global_ordinal_type, node_type > map_type
Type of the Tpetra::Map specialization that this class uses.
Definition: Ifpack2_LocalFilter_decl.hpp:204
virtual bool supportsRowViews() const
Returns true if RowViews are supported.
Definition: Ifpack2_LocalFilter_def.hpp:827
MatrixType::local_ordinal_type local_ordinal_type
The type of local indices in the input MatrixType.
Definition: Ifpack2_LocalFilter_decl.hpp:184
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)
virtual Teuchos::RCP< const map_type > getColMap() const
Returns the Map that describes the column distribution in this matrix.
Definition: Ifpack2_LocalFilter_def.hpp:260
virtual void getGlobalRowCopy(global_ordinal_type GlobalRow, const Teuchos::ArrayView< global_ordinal_type > &Indices, const Teuchos::ArrayView< scalar_type > &Values, size_t &NumEntries) const
Get the entries in the given row, using global indices.
Definition: Ifpack2_LocalFilter_def.hpp:436
virtual void getLocalRowCopy(local_ordinal_type LocalRow, const Teuchos::ArrayView< local_ordinal_type > &Indices, const Teuchos::ArrayView< scalar_type > &Values, size_t &NumEntries) const
Get the entries in the given row, using local indices.
Definition: Ifpack2_LocalFilter_def.hpp:480
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.
Definition: Ifpack2_LocalFilter_def.hpp:625
virtual Teuchos::RCP< const Tpetra::RowGraph< local_ordinal_type, global_ordinal_type, node_type > > getGraph() const
The (locally filtered) matrix's graph.
Definition: Ifpack2_LocalFilter_def.hpp:290
virtual size_t getNodeNumRows() const
The number of rows owned on the calling process.
Definition: Ifpack2_LocalFilter_def.hpp:314
LinearOp zero(const VectorSpace &vs)
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
Compute Y = beta*Y + alpha*A_local*X.
Definition: Ifpack2_LocalFilter_def.hpp:645
virtual global_ordinal_type getIndexBase() const
Returns the index base for global indices for this matrix.
Definition: Ifpack2_LocalFilter_def.hpp:329
virtual bool hasColMap() const
Whether this matrix has a well-defined column Map.
Definition: Ifpack2_LocalFilter_def.hpp:406
void resize(size_type new_size, const value_type &x=value_type())
virtual size_t getGlobalMaxNumRowEntries() const
The maximum number of entries across all rows/columns on all processes.
Definition: Ifpack2_LocalFilter_def.hpp:392
virtual Teuchos::RCP< const Teuchos::Comm< int > > getComm() const
Returns the communicator.
Definition: Ifpack2_LocalFilter_def.hpp:232
virtual std::string description() const
A one-line description of this object.
Definition: Ifpack2_LocalFilter_def.hpp:867
virtual size_t getNodeMaxNumRowEntries() const
The maximum number of entries across all rows/columns on this process.
Definition: Ifpack2_LocalFilter_def.hpp:399
LocalFilter(const Teuchos::RCP< const row_matrix_type > &A)
Constructor.
Definition: Ifpack2_LocalFilter_def.hpp:88
virtual ~LocalFilter()
Destructor.
Definition: Ifpack2_LocalFilter_def.hpp:226
virtual global_size_t getGlobalNumEntries() const
Returns the global number of entries in this matrix.
Definition: Ifpack2_LocalFilter_def.hpp:336
virtual Teuchos::RCP< const map_type > getRowMap() const
Returns the Map that describes the row distribution in this matrix.
Definition: Ifpack2_LocalFilter_def.hpp:250
MatrixType::scalar_type scalar_type
The type of the entries of the input MatrixType.
Definition: Ifpack2_LocalFilter_decl.hpp:181
virtual size_t getNodeNumEntries() const
Returns the local number of entries in this matrix.
Definition: Ifpack2_LocalFilter_def.hpp:343
virtual bool isGloballyIndexed() const
Whether the underlying sparse matrix is globally (opposite of locally) indexed.
Definition: Ifpack2_LocalFilter_def.hpp:420
virtual void getLocalDiagCopy(Tpetra::Vector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &diag) const
Get the diagonal entries of the (locally filtered) matrix.
Definition: Ifpack2_LocalFilter_def.hpp:610
virtual Teuchos::RCP< node_type > getNode() const
Returns the underlying Node object.
Definition: Ifpack2_LocalFilter_def.hpp:240
Access only local rows and columns of a sparse matrix.
Definition: Ifpack2_LocalFilter_decl.hpp:160
virtual Teuchos::RCP< const map_type > getDomainMap() const
Returns the Map that describes the domain distribution in this matrix.
Definition: Ifpack2_LocalFilter_def.hpp:270
virtual size_t getNumEntriesInGlobalRow(global_ordinal_type globalRow) const
The current number of entries on this node in the specified global row.
Definition: Ifpack2_LocalFilter_def.hpp:352
Preconditioners and smoothers for Tpetra sparse matrices.
Definition: Ifpack2_AdditiveSchwarz_decl.hpp:72
virtual bool hasTransposeApply() const
Whether this operator supports applying the transpose or conjugate transpose.
Definition: Ifpack2_LocalFilter_def.hpp:820
virtual size_t getNumEntriesInLocalRow(local_ordinal_type localRow) const
The current number of entries on this node in the specified local row.
Definition: Ifpack2_LocalFilter_def.hpp:371