43 #ifndef IFPACK2_REORDERFILTER_DEF_HPP 44 #define IFPACK2_REORDERFILTER_DEF_HPP 45 #include "Ifpack2_ReorderFilter_decl.hpp" 48 #include "Tpetra_ConfigDefs.hpp" 49 #include "Tpetra_RowMatrix.hpp" 50 #include "Tpetra_Map.hpp" 51 #include "Tpetra_MultiVector.hpp" 52 #include "Tpetra_Vector.hpp" 56 template<
class MatrixType>
59 const Teuchos::ArrayRCP<local_ordinal_type>& perm,
60 const Teuchos::ArrayRCP<local_ordinal_type>& reverseperm)
63 reverseperm_ (reverseperm)
65 TEUCHOS_TEST_FOR_EXCEPTION(
66 A_.is_null (), std::invalid_argument,
67 "Ifpack2::ReorderFilter: The input matrix is null.");
70 TEUCHOS_TEST_FOR_EXCEPTION(
71 A_->getComm()->getSize() != 1, std::invalid_argument,
72 "Ifpack2::ReorderFilter: This class may only be used if the input matrix's " 73 "communicator has one process. This class is an implementation detail of " 74 "Ifpack2::AdditiveSchwarz, and it is not meant to be used otherwise.");
76 TEUCHOS_TEST_FOR_EXCEPTION(
77 A_->getNodeNumRows () != A_->getGlobalNumRows (),
78 std::invalid_argument,
79 "Ifpack2::ReorderFilter: The input matrix is not square.");
82 Kokkos::resize(Indices_,A_->getNodeMaxNumRowEntries ());
83 Kokkos::resize(Values_,A_->getNodeMaxNumRowEntries ());
87 template<
class MatrixType>
91 template<
class MatrixType>
100 template<
class MatrixType>
101 Teuchos::RCP<const typename ReorderFilter<MatrixType>::map_type>
104 TEUCHOS_TEST_FOR_EXCEPTION(
105 A_.is_null (), std::runtime_error,
"Ifpack2::ReorderFilter::" 106 "getRowMap: The matrix A is null, so there is no row Map.");
108 return A_->getRowMap ();
112 template<
class MatrixType>
113 Teuchos::RCP<const typename ReorderFilter<MatrixType>::map_type>
116 TEUCHOS_TEST_FOR_EXCEPTION(
117 A_.is_null (), std::runtime_error,
"Ifpack2::ReorderFilter::" 118 "getColMap: The matrix A is null, so there is no column Map.");
120 return A_->getColMap();
124 template<
class MatrixType>
125 Teuchos::RCP<const typename ReorderFilter<MatrixType>::map_type>
128 TEUCHOS_TEST_FOR_EXCEPTION(
129 A_.is_null (), std::runtime_error,
"Ifpack2::ReorderFilter::" 130 "getDomainMap: The matrix A is null, so there is no domain Map.");
132 return A_->getDomainMap();
136 template<
class MatrixType>
137 Teuchos::RCP<const typename ReorderFilter<MatrixType>::map_type>
140 TEUCHOS_TEST_FOR_EXCEPTION(
141 A_.is_null (), std::runtime_error,
"Ifpack2::ReorderFilter::" 142 "getRangeMap: The matrix A is null, so there is no range Map.");
144 return A_->getRangeMap();
148 template<
class MatrixType>
149 Teuchos::RCP<
const Tpetra::RowGraph<
typename MatrixType::local_ordinal_type,
150 typename MatrixType::global_ordinal_type,
151 typename MatrixType::node_type> >
154 throw std::runtime_error(
"Ifpack2::ReorderFilter: does not support getGraph.");
158 template<
class MatrixType>
161 return A_->getGlobalNumRows();
165 template<
class MatrixType>
168 return A_->getGlobalNumCols();
172 template<
class MatrixType>
175 return A_->getNodeNumRows();
179 template<
class MatrixType>
182 return A_->getNodeNumCols();
186 template<
class MatrixType>
189 return A_->getIndexBase();
193 template<
class MatrixType>
196 return A_->getGlobalNumEntries();
200 template<
class MatrixType>
203 return A_->getNodeNumEntries();
207 template<
class MatrixType>
211 if (A_.is_null () || A_->getRowMap ().is_null ()) {
212 return Teuchos::OrdinalTraits<size_t>::invalid ();
215 const local_ordinal_type lclRow =
216 A_->getRowMap ()->getLocalElement (globalRow);
217 if (lclRow == Teuchos::OrdinalTraits<local_ordinal_type>::invalid ()) {
219 return static_cast<size_t> (0);
221 const local_ordinal_type origLclRow = reverseperm_[lclRow];
222 return A_->getNumEntriesInLocalRow (origLclRow);
228 template<
class MatrixType>
234 if (A_->getRowMap ()->isNodeLocalElement (localRow)) {
236 const local_ordinal_type localReorderedRow = reverseperm_[localRow];
237 return A_->getNumEntriesInLocalRow (localReorderedRow);
240 return static_cast<size_t> (0);
245 template<
class MatrixType>
248 return A_->getGlobalMaxNumRowEntries();
252 template<
class MatrixType>
255 return A_->getNodeMaxNumRowEntries();
259 template<
class MatrixType>
266 template<
class MatrixType>
269 return A_->isLocallyIndexed();
273 template<
class MatrixType>
276 return A_->isGloballyIndexed();
280 template<
class MatrixType>
283 return A_->isFillComplete();
287 template<
class MatrixType>
290 nonconst_global_inds_host_view_type &globalInd,
291 nonconst_values_host_view_type &val,
292 size_t& numEntries)
const 294 using Teuchos::Array;
295 using Teuchos::ArrayView;
296 using Teuchos::av_reinterpret_cast;
297 typedef local_ordinal_type LO;
298 typedef global_ordinal_type GO;
299 typedef Teuchos::OrdinalTraits<LO> OTLO;
301 const map_type& rowMap = * (A_->getRowMap ());
302 const local_ordinal_type localRow = rowMap.getLocalElement (globalRow);
303 TEUCHOS_TEST_FOR_EXCEPTION(
304 localRow == OTLO::invalid (), std::invalid_argument,
"Ifpack2::Reorder" 305 "Filter::getGlobalRowCopy: The given global row index " << globalRow
306 <<
" is not owned by the calling process with rank " 307 << rowMap.getComm ()->getRank () <<
".");
310 numEntries = this->getNumEntriesInLocalRow (localRow);
311 this->getLocalRowCopy (localRow, Indices_, val, numEntries);
314 for (
size_t k = 0; k < numEntries; ++k) {
315 globalInd[k] = rowMap.getGlobalElement (Indices_[k]);
319 #ifdef TPETRA_ENABLE_DEPRECATED_CODE 320 template<
class MatrixType>
323 const Teuchos::ArrayView<global_ordinal_type>& Indices,
324 const Teuchos::ArrayView<scalar_type>& Values,
325 size_t& numEntries)
const 327 using IST =
typename row_matrix_type::impl_scalar_type;
328 nonconst_global_inds_host_view_type ind_in(Indices.data(),Indices.size());
329 nonconst_values_host_view_type val_in(reinterpret_cast<IST*>(Values.data()),Values.size());
330 getGlobalRowCopy(globalRow,ind_in,val_in,numEntries);
334 template<
class MatrixType>
337 nonconst_local_inds_host_view_type &Indices,
338 nonconst_values_host_view_type &Values,
339 size_t& NumEntries)
const 342 TEUCHOS_TEST_FOR_EXCEPTION(
343 ! A_->getRowMap ()->isNodeLocalElement (LocalRow),
344 std::invalid_argument,
345 "Ifpack2::ReorderFilter::getLocalRowCopy: The given local row index " 346 << LocalRow <<
" is not a valid local row index on the calling process " 347 "with rank " << A_->getRowMap ()->getComm ()->getRank () <<
".");
351 const local_ordinal_type origLclRow = reverseperm_[LocalRow];
352 const size_t numEntries = A_->getNumEntriesInLocalRow (origLclRow);
354 TEUCHOS_TEST_FOR_EXCEPTION(
355 static_cast<size_t> (Indices.size ()) < numEntries ||
356 static_cast<size_t> (Values.size ()) < numEntries,
357 std::invalid_argument,
358 "Ifpack2::ReorderFilter::getLocalRowCopy: The given array views are not " 359 "long enough to store all the data in the given row " << LocalRow
360 <<
". Indices.size() = " << Indices.size () <<
", Values.size() = " 361 << Values.size () <<
", but the (original) row has " << numEntries
364 A_->getLocalRowCopy (origLclRow, Indices, Values, NumEntries);
369 for (
size_t i = 0; i < NumEntries; ++i) {
370 Indices[i] = perm_[Indices[i]];
374 #ifdef TPETRA_ENABLE_DEPRECATED_CODE 375 template<
class MatrixType>
377 const Teuchos::ArrayView<local_ordinal_type> &Indices,
378 const Teuchos::ArrayView<scalar_type> &Values,
379 size_t &NumEntries)
const 381 using IST =
typename row_matrix_type::impl_scalar_type;
382 nonconst_local_inds_host_view_type ind_in(Indices.data(),Indices.size());
383 nonconst_values_host_view_type val_in(reinterpret_cast<IST*>(Values.data()),Values.size());
384 getLocalRowCopy(LocalRow,ind_in,val_in,NumEntries);
388 template<
class MatrixType>
390 global_inds_host_view_type &,
391 values_host_view_type &)
const 393 throw std::runtime_error(
"Ifpack2::ReorderFilter: does not support getGlobalRowView.");
396 #ifdef TPETRA_ENABLE_DEPRECATED_CODE 397 template<
class MatrixType>
400 Teuchos::ArrayView<const global_ordinal_type> &,
401 Teuchos::ArrayView<const scalar_type> &)
const 403 throw std::runtime_error(
"Ifpack2::ReorderFilter: does not support getGlobalRowView.");
408 template<
class MatrixType>
410 local_inds_host_view_type & ,
411 values_host_view_type & )
const 413 throw std::runtime_error(
"Ifpack2::ReorderFilter: does not support getLocalRowView.");
416 #ifdef TPETRA_ENABLE_DEPRECATED_CODE 417 template<
class MatrixType>
420 Teuchos::ArrayView<const local_ordinal_type> &,
421 Teuchos::ArrayView<const scalar_type> &)
const 423 throw std::runtime_error(
"Ifpack2::ReorderFilter: does not support getLocalRowView.");
428 template<
class MatrixType>
430 getLocalDiagCopy (Tpetra::Vector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &diag)
const 433 return A_->getLocalDiagCopy(diag);
437 template<
class MatrixType>
440 throw std::runtime_error(
"Ifpack2::ReorderFilter does not support leftScale.");
444 template<
class MatrixType>
447 throw std::runtime_error(
"Ifpack2::ReorderFilter does not support rightScale.");
451 template<
class MatrixType>
453 apply (
const Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &X,
454 Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &Y,
455 Teuchos::ETransp mode,
457 scalar_type beta)
const 459 typedef Teuchos::ScalarTraits<scalar_type> STS;
461 TEUCHOS_TEST_FOR_EXCEPTION(
462 alpha != STS::one () || beta != STS::zero (), std::logic_error,
463 "Ifpack2::ReorderFilter::apply is only implemented for alpha = 1 and " 464 "beta = 0. You set alpha = " << alpha <<
" and beta = " << beta <<
".");
468 TEUCHOS_TEST_FOR_EXCEPTION(
469 X.getNumVectors() != Y.getNumVectors(), std::runtime_error,
470 "Ifpack2::ReorderFilter::apply: X.getNumVectors() != Y.getNumVectors().");
472 const scalar_type zero = STS::zero ();
473 Teuchos::ArrayRCP<Teuchos::ArrayRCP<const scalar_type> > x_ptr = X.get2dView();
474 Teuchos::ArrayRCP<Teuchos::ArrayRCP<scalar_type> > y_ptr = Y.get2dViewNonConst();
477 const size_t NumVectors = Y.getNumVectors ();
479 for (
size_t i = 0; i < A_->getNodeNumRows (); ++i) {
482 getLocalRowCopy (i, Indices_ , Values_ , Nnz);
483 scalar_type* Values =
reinterpret_cast<scalar_type*
>(Values_.data());
484 if (mode == Teuchos::NO_TRANS) {
485 for (
size_t j = 0; j < Nnz; ++j) {
486 for (
size_t k = 0; k < NumVectors; ++k) {
487 y_ptr[k][i] += Values[j] * x_ptr[k][Indices_[j]];
491 else if (mode == Teuchos::TRANS) {
492 for (
size_t j = 0; j < Nnz; ++j) {
493 for (
size_t k = 0; k < NumVectors; ++k) {
494 y_ptr[k][Indices_[j]] += Values[j] * x_ptr[k][i];
499 for (
size_t j = 0; j < Nnz; ++j) {
500 for (
size_t k = 0; k < NumVectors; ++k) {
501 y_ptr[k][Indices_[j]] += STS::conjugate(Values[j]) * x_ptr[k][i];
509 template<
class MatrixType>
516 template<
class MatrixType>
523 template<
class MatrixType>
527 return A_->getFrobeniusNorm ();
531 template<
class MatrixType>
534 Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &reorderedY)
const 536 this->
template permuteOriginalToReorderedTempl<scalar_type,scalar_type>(originalX, reorderedY);
540 template<
class MatrixType>
541 template<
class DomainScalar,
class RangeScalar>
543 Tpetra::MultiVector<RangeScalar,local_ordinal_type,global_ordinal_type,node_type> &reorderedY)
const 545 TEUCHOS_TEST_FOR_EXCEPTION(originalX.getNumVectors() != reorderedY.getNumVectors(), std::runtime_error,
546 "Ifpack2::ReorderFilter::permuteOriginalToReordered ERROR: X.getNumVectors() != Y.getNumVectors().");
548 Teuchos::ArrayRCP<Teuchos::ArrayRCP<const DomainScalar> > x_ptr = originalX.get2dView();
549 Teuchos::ArrayRCP<Teuchos::ArrayRCP<RangeScalar> > y_ptr = reorderedY.get2dViewNonConst();
551 for(
size_t k=0; k < originalX.getNumVectors(); k++)
552 for(local_ordinal_type i=0; (size_t)i< originalX.getLocalLength(); i++)
553 y_ptr[k][perm_[i]] = (RangeScalar)x_ptr[k][i];
557 template<
class MatrixType>
559 Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &originalY)
const 561 this->
template permuteReorderedToOriginalTempl<scalar_type,scalar_type>(reorderedX, originalY);
565 template<
class MatrixType>
566 template<
class DomainScalar,
class RangeScalar>
569 Tpetra::MultiVector<RangeScalar,local_ordinal_type,global_ordinal_type,node_type> &originalY)
const 571 TEUCHOS_TEST_FOR_EXCEPTION(
572 reorderedX.getNumVectors() != originalY.getNumVectors(),
574 "Ifpack2::ReorderFilter::permuteReorderedToOriginal: " 575 "X.getNumVectors() != Y.getNumVectors().");
577 #ifdef HAVE_IFPACK2_DEBUG 579 typedef Teuchos::ScalarTraits<DomainScalar> STS;
580 typedef typename STS::magnitudeType magnitude_type;
581 typedef Teuchos::ScalarTraits<magnitude_type> STM;
582 Teuchos::Array<magnitude_type> norms (reorderedX.getNumVectors ());
583 reorderedX.norm2 (norms ());
586 j < reorderedX.getNumVectors (); ++j) {
587 if (STM::isnaninf (norms[j])) {
592 TEUCHOS_TEST_FOR_EXCEPTION(
593 ! good, std::runtime_error,
"Ifpack2::ReorderFilter::" 594 "permuteReorderedToOriginalTempl: The 2-norm of the input reorderedX is " 597 #endif // HAVE_IFPACK2_DEBUG 599 Teuchos::ArrayRCP<Teuchos::ArrayRCP<const DomainScalar> > x_ptr = reorderedX.get2dView();
600 Teuchos::ArrayRCP<Teuchos::ArrayRCP<RangeScalar> > y_ptr = originalY.get2dViewNonConst();
602 for (
size_t k = 0; k < reorderedX.getNumVectors (); ++k) {
603 for (local_ordinal_type i = 0; (size_t)i < reorderedX.getLocalLength (); ++i) {
604 y_ptr[k][reverseperm_[i]] = (RangeScalar) x_ptr[k][i];
608 #ifdef HAVE_IFPACK2_DEBUG 610 typedef Teuchos::ScalarTraits<RangeScalar> STS;
611 typedef typename STS::magnitudeType magnitude_type;
612 typedef Teuchos::ScalarTraits<magnitude_type> STM;
613 Teuchos::Array<magnitude_type> norms (originalY.getNumVectors ());
614 originalY.norm2 (norms ());
617 j < originalY.getNumVectors (); ++j) {
618 if (STM::isnaninf (norms[j])) {
623 TEUCHOS_TEST_FOR_EXCEPTION(
624 ! good, std::runtime_error,
"Ifpack2::ReorderFilter::" 625 "permuteReorderedToOriginalTempl: The 2-norm of the output originalY is " 628 #endif // HAVE_IFPACK2_DEBUG 633 #define IFPACK2_REORDERFILTER_INSTANT(S,LO,GO,N) \ 634 template class Ifpack2::ReorderFilter< Tpetra::RowMatrix<S, LO, GO, N> >; virtual size_t getNumEntriesInLocalRow(local_ordinal_type localRow) const
The current number of entries in this matrix, stored on the calling process, in the row whose local i...
Definition: Ifpack2_ReorderFilter_def.hpp:230
Wraps a Tpetra::RowMatrix in a filter that reorders local rows and columns.
Definition: Ifpack2_ReorderFilter_decl.hpp:69
virtual bool isLocallyIndexed() const
If matrix indices are in the local range, this function returns true. Otherwise, this function return...
Definition: Ifpack2_ReorderFilter_def.hpp:267
virtual void permuteOriginalToReordered(const Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &originalX, Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &reorderedY) const
Permute multivector: original-to-reordered.
Definition: Ifpack2_ReorderFilter_def.hpp:533
virtual bool supportsRowViews() const
Returns true if RowViews are supported.
Definition: Ifpack2_ReorderFilter_def.hpp:517
virtual global_size_t getGlobalNumEntries() const
Returns the global number of entries in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:194
virtual Teuchos::RCP< const map_type > getRangeMap() const
Returns the Map that describes the range distribution in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:138
virtual void permuteReorderedToOriginal(const Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &reorderedX, Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &originalY) const
Permute multivector: reordered-to-original.
Definition: Ifpack2_ReorderFilter_def.hpp:558
virtual Teuchos::RCP< const map_type > getRowMap() const
Returns the Map that describes the row distribution in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:102
virtual size_t getGlobalMaxNumRowEntries() const
Returns the maximum number of entries across all rows/columns on all nodes.
Definition: Ifpack2_ReorderFilter_def.hpp:246
ReorderFilter(const Teuchos::RCP< const row_matrix_type > &A, const Teuchos::ArrayRCP< local_ordinal_type > &perm, const Teuchos::ArrayRCP< local_ordinal_type > &reverseperm)
Constructor.
Definition: Ifpack2_ReorderFilter_def.hpp:58
virtual global_size_t getGlobalNumCols() const
Returns the number of global columns in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:166
virtual size_t getNodeNumEntries() const
Returns the local number of entries in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:201
virtual size_t getNodeNumCols() const
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.
Definition: Ifpack2_ReorderFilter_def.hpp:180
virtual void getLocalRowView(local_ordinal_type LocalRow, local_inds_host_view_type &indices, values_host_view_type &values) const
Extract a const, non-persisting view of local indices in a specified row of the matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:409
virtual void getGlobalRowView(global_ordinal_type GlobalRow, global_inds_host_view_type &indices, values_host_view_type &values) const
Extract a const, non-persisting view of global indices in a specified row of the matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:389
virtual bool isGloballyIndexed() const
If matrix indices are in the global range, this function returns true. Otherwise, this function retur...
Definition: Ifpack2_ReorderFilter_def.hpp:274
virtual global_size_t getGlobalNumRows() const
Returns the number of global rows in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:159
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.
Definition: Ifpack2_ReorderFilter_def.hpp:430
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
, where Op(A) is either A, , or .
Definition: Ifpack2_ReorderFilter_def.hpp:453
virtual Teuchos::RCP< const map_type > getDomainMap() const
Returns the Map that describes the domain distribution in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:126
virtual Teuchos::RCP< const map_type > getColMap() const
Returns the Map that describes the column distribution in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:114
virtual mag_type getFrobeniusNorm() const
Returns the Frobenius norm of the matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:524
virtual size_t getNodeMaxNumRowEntries() const
Returns the maximum number of entries across all rows/columns on this node.
Definition: Ifpack2_ReorderFilter_def.hpp:253
virtual void getLocalRowCopy(local_ordinal_type LocalRow, nonconst_local_inds_host_view_type &Indices, nonconst_values_host_view_type &Values, size_t &NumEntries) const
Extract a list of entries in a specified local row of the graph. Put into storage allocated by callin...
Definition: Ifpack2_ReorderFilter_def.hpp:336
virtual size_t getNumEntriesInGlobalRow(global_ordinal_type globalRow) const
The current number of entries in this matrix, stored on the calling process, in the row whose global ...
Definition: Ifpack2_ReorderFilter_def.hpp:209
virtual Teuchos::RCP< const Teuchos::Comm< int > > getComm() const
The matrix's communicator.
Definition: Ifpack2_ReorderFilter_def.hpp:92
virtual bool hasTransposeApply() const
Whether apply() can apply the transpose or conjugate transpose.
Definition: Ifpack2_ReorderFilter_def.hpp:510
virtual size_t getNodeNumRows() const
Returns the number of rows owned on the calling node.
Definition: Ifpack2_ReorderFilter_def.hpp:173
virtual bool isFillComplete() const
Returns true if fillComplete() has been called.
Definition: Ifpack2_ReorderFilter_def.hpp:281
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_ReorderFilter_def.hpp:438
Preconditioners and smoothers for Tpetra sparse matrices.
Definition: Ifpack2_AdditiveSchwarz_decl.hpp:73
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_ReorderFilter_def.hpp:445
virtual Teuchos::RCP< const Tpetra::RowGraph< local_ordinal_type, global_ordinal_type, node_type > > getGraph() const
Returns the RowGraph associated with this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:152
virtual bool hasColMap() const
Indicates whether this matrix has a well-defined column map.
Definition: Ifpack2_ReorderFilter_def.hpp:260
virtual ~ReorderFilter()
Destructor.
Definition: Ifpack2_ReorderFilter_def.hpp:88
virtual void getGlobalRowCopy(global_ordinal_type GlobalRow, nonconst_global_inds_host_view_type &Indices, nonconst_values_host_view_type &Values, size_t &NumEntries) const
Extract a list of entries in a specified global row of this matrix. Put into pre-allocated storage...
Definition: Ifpack2_ReorderFilter_def.hpp:289
virtual global_ordinal_type getIndexBase() const
Returns the index base for global indices for this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:187