12#ifndef __IFPACK2_FASTILU_BASE_DEF_HPP__
13#define __IFPACK2_FASTILU_BASE_DEF_HPP__
16#include "Tpetra_BlockCrsMatrix.hpp"
17#include "Tpetra_BlockCrsMatrix_Helpers.hpp"
18#include "Ifpack2_Details_getCrsMatrix.hpp"
19#include <KokkosKernels_Utils.hpp>
20#include <Kokkos_Timer.hpp>
21#include <Teuchos_TimeMonitor.hpp>
27template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
32 , computedFlag_(
false)
40 , params_(Params::getDefaults()) {}
42template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
43Teuchos::RCP<const Tpetra::Map<LocalOrdinal, GlobalOrdinal, Node> >
46 return mat_->getDomainMap();
49template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
50Teuchos::RCP<const Tpetra::Map<LocalOrdinal, GlobalOrdinal, Node> >
53 return mat_->getRangeMap();
56template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
58 apply(
const Tpetra::MultiVector<Scalar, LocalOrdinal, GlobalOrdinal, Node>& X,
59 Tpetra::MultiVector<Scalar, LocalOrdinal, GlobalOrdinal, Node>& Y,
60 Teuchos::ETransp
mode,
63 const std::string
timerName(
"Ifpack2::FastILU::apply");
64 Teuchos::RCP<Teuchos::Time>
timer = Teuchos::TimeMonitor::lookupCounter(
timerName);
65 if (
timer.is_null()) {
70 if (!isInitialized() || !isComputed()) {
71 throw std::runtime_error(std::string(
"Called ") + getName() +
"::apply() without first calling initialize() and/or compute().");
73 if (X.getNumVectors() != Y.getNumVectors()) {
74 throw std::invalid_argument(getName() +
"::apply: X and Y have different numbers of vectors (pass X and Y with exactly matching dimensions)");
76 if (X.getLocalLength() != Y.getLocalLength()) {
77 throw std::invalid_argument(getName() +
"::apply: X and Y have different lengths (pass X and Y with exactly matching dimensions)");
81 int nvecs = X.getNumVectors();
82 auto nrowsX = X.getLocalLength();
83 auto nrowsY = Y.getLocalLength();
85 auto x2d = X.getLocalViewDevice(Tpetra::Access::ReadOnly);
86 auto y2d = Y.getLocalViewDevice(Tpetra::Access::ReadWrite);
93 auto x2d = X.getLocalViewDevice(Tpetra::Access::ReadOnly);
94 auto y2d = Y.getLocalViewDevice(Tpetra::Access::ReadWrite);
106template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
110 params_ = Params(
List, getName());
113template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
116 return params_.blockCrs && params_.blockCrsSize > 1;
119template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
122 const std::string
timerName(
"Ifpack2::FastILU::initialize");
123 Teuchos::RCP<Teuchos::Time>
timer = Teuchos::TimeMonitor::lookupCounter(
timerName);
124 if (
timer.is_null()) {
129 if (mat_.is_null()) {
130 throw std::runtime_error(std::string(
"Called ") + getName() +
"::initialize() but matrix was null (call setMatrix() with a non-null matrix first)");
134 auto crs_matrix = Ifpack2::Details::getCrsMatrix(this->mat_);
136 if (params_.fillBlocks) {
149 CrsArrayReader<Scalar, ImplScalar, LocalOrdinal, GlobalOrdinal, Node>::getStructure(mat_.get(), localRowPtrsHost_, localRowPtrs_, localColInds_);
150 CrsArrayReader<Scalar, ImplScalar, LocalOrdinal, GlobalOrdinal, Node>::getValues(mat_.get(), localValues_, localRowPtrsHost_);
153 if (params_.use_metis) {
154 assert(!params_.blockCrs);
161#ifdef HAVE_IFPACK2_METIS
181 KokkosKernels::Impl::symmetrize_graph_symbolic_hashmap<
203 for (LocalOrdinal
k = localRowPtrsHost_(
i);
k < localRowPtrsHost_(
i + 1);
k++) {
217 throw std::runtime_error(std::string(
"METIS_NodeND returned info = " +
info));
221 throw std::runtime_error(std::string(
"TPL METIS is not enabled"));
230template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
236template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
240 throw std::runtime_error(getName() +
": initialize() must be called before compute()");
243 const std::string
timerName(
"Ifpack2::FastILU::compute");
244 Teuchos::RCP<Teuchos::Time>
timer = Teuchos::TimeMonitor::lookupCounter(
timerName);
245 if (
timer.is_null()) {
252 CrsArrayReader<Scalar, ImplScalar, LocalOrdinal, GlobalOrdinal, Node>::getValues(mat_.get(), localValues_, localRowPtrsHost_);
255 computedFlag_ =
true;
259template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
262 return computedFlag_;
265template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
266Teuchos::RCP<const Tpetra::RowMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node> >
272template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
278template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
284template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
290template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
296template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
302template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
308template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
314template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
318 throw std::runtime_error(std::string(
"Preconditioner type Ifpack2::Details::") + getName() +
" doesn't support checkLocalILU().");
321template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
325 throw std::runtime_error(std::string(
"Preconditioner type Ifpack2::Details::") + getName() +
" doesn't support checkLocalIC().");
328template <
typename Scalar,
typename LocalOrdinal,
typename GlobalOrdinal,
typename Node>
330 std::ostringstream
os;
332 os <<
"\"Ifpack2::Details::" << getName() <<
"\": {";
333 os <<
"Initialized: " << (isInitialized() ?
"true" :
"false") <<
", ";
334 os <<
"Computed: " << (isComputed() ?
"true" :
"false") <<
", ";
335 os <<
"Sweeps: " << getSweeps() <<
", ";
336 os <<
"Triangular solve type: " << getSpTrsvType() <<
", ";
337 if (getSpTrsvType() ==
"Fast") {
338 os <<
"# of triangular solve iterations: " << getNTrisol() <<
", ";
340 if (mat_.is_null()) {
341 os <<
"Matrix: null";
343 os <<
"Global matrix dimensions: [" << mat_->getGlobalNumRows() <<
", " << mat_->getGlobalNumCols() <<
"]";
344 os <<
", Global nnz: " << mat_->getGlobalNumEntries();
349template <
typename Scalar,
typename LocalOrdinal,
typename GlobalOrdinal,
typename Node>
351 setMatrix(
const Teuchos::RCP<const TRowMatrix>& A) {
353 throw std::invalid_argument(std::string(
"Ifpack2::Details::") + getName() +
"::setMatrix() called with a null matrix. Pass a non-null matrix.");
356 if (mat_.get() != A.get()) {
359 computedFlag_ =
false;
363template <
typename Scalar,
typename LocalOrdinal,
typename GlobalOrdinal,
typename Node>
369 p.sptrsv_algo = FastILU::SpTRSV::Fast;
380 p.fillBlocks =
false;
384template <
typename Scalar,
typename LocalOrdinal,
typename GlobalOrdinal,
typename Node>
385FastILU_Base<Scalar, LocalOrdinal, GlobalOrdinal, Node>::
386 Params::Params(
const Teuchos::ParameterList& pL, std::string precType) {
387 *
this = getDefaults();
392#define TYPE_ERROR(name, correctTypeName) \
393 { throw std::invalid_argument(precType + "::setParameters(): parameter \"" + name + "\" has the wrong type (must be " + correctTypeName + ")"); }
394#define CHECK_VALUE(param, member, cond, msg) \
397 throw std::invalid_argument(precType + "::setParameters(): parameter \"" + param + "\" has value " + std::to_string(member) + " but " + msg); \
402 if (pL.isParameter(
"metis")) {
403 if (pL.isType<
bool>(
"metis"))
404 use_metis = pL.get<
bool>(
"metis");
406 TYPE_ERROR(
"metis",
"bool");
409 if (pL.isParameter(
"sweeps")) {
410 if (pL.isType<
int>(
"sweeps")) {
411 nFact = pL.get<
int>(
"sweeps");
412 CHECK_VALUE(
"sweeps", nFact, nFact < 1,
"must have a value of at least 1");
414 TYPE_ERROR(
"sweeps",
"int");
416 std::string sptrsv_type =
"Fast";
417 if (pL.isParameter(
"triangular solve type")) {
418 sptrsv_type = pL.get<std::string>(
"triangular solve type");
420 if (sptrsv_type ==
"Standard Host") {
421 sptrsv_algo = FastILU::SpTRSV::StandardHost;
422 }
else if (sptrsv_type ==
"Standard") {
423 sptrsv_algo = FastILU::SpTRSV::Standard;
427 if (pL.isParameter(
"triangular solve iterations")) {
428 if (pL.isType<
int>(
"triangular solve iterations")) {
429 nTrisol = pL.get<
int>(
"triangular solve iterations");
430 CHECK_VALUE(
"triangular solve iterations", nTrisol, nTrisol < 1,
"must have a value of at least 1");
432 TYPE_ERROR(
"triangular solve iterations",
"int");
435 if (pL.isParameter(
"level")) {
436 if (pL.isType<
int>(
"level")) {
437 level = pL.get<
int>(
"level");
438 }
else if (pL.isType<
double>(
"level")) {
441 double dval = pL.get<
double>(
"level");
443 double fpart = modf(dval, &ipart);
445 CHECK_VALUE(
"level", level, fpart != 0,
"must be an integral value");
447 TYPE_ERROR(
"level",
"int");
449 CHECK_VALUE(
"level", level, level < 0,
"must be nonnegative");
451 if (pL.isParameter(
"damping factor")) {
452 if (pL.isType<
double>(
"damping factor"))
453 omega = pL.get<
double>(
"damping factor");
455 TYPE_ERROR(
"damping factor",
"double");
457 if (pL.isParameter(
"shift")) {
458 if (pL.isType<
double>(
"shift"))
459 shift = pL.get<
double>(
"shift");
461 TYPE_ERROR(
"shift",
"double");
464 if (pL.isParameter(
"guess")) {
465 if (pL.isType<
bool>(
"guess"))
466 guessFlag = pL.get<
bool>(
"guess");
468 TYPE_ERROR(
"guess",
"bool");
471 if (pL.isParameter(
"block size for ILU")) {
472 if (pL.isType<
int>(
"block size for ILU")) {
473 blockSizeILU = pL.get<
int>(
"block size for ILU");
474 CHECK_VALUE(
"block size for ILU", blockSizeILU, blockSizeILU < 1,
"must have a value of at least 1");
476 TYPE_ERROR(
"block size for ILU",
"int");
479 if (pL.isParameter(
"block size for SpTRSV")) {
480 if (pL.isType<
int>(
"block size for SpTRSV"))
481 blockSize = pL.get<
int>(
"block size for SpTRSV");
483 TYPE_ERROR(
"block size for SpTRSV",
"int");
486 if (pL.isParameter(
"block crs")) {
487 if (pL.isType<
bool>(
"block crs"))
488 blockCrs = pL.get<
bool>(
"block crs");
490 TYPE_ERROR(
"block crs",
"bool");
493 if (pL.isParameter(
"block crs block size")) {
494 if (pL.isType<
int>(
"block crs block size"))
495 blockCrsSize = pL.get<
int>(
"block crs block size");
497 TYPE_ERROR(
"block crs block size",
"int");
500 if (pL.isParameter(
"fill blocks for input")) {
501 if (pL.isType<
bool>(
"fill blocks for input"))
502 blockCrsSize = pL.get<
bool>(
"fill blocks for input");
504 TYPE_ERROR(
"fill blocks for input",
"bool");
511#define IFPACK2_DETAILS_FASTILU_BASE_INSTANT(S, L, G, N) \
512 template class Ifpack2::Details::FastILU_Base<S, L, G, N>;
Provides functions for retrieving local CRS arrays (row pointers, column indices, and values) from Tp...
The base class of the Ifpack2 FastILU wrappers (Filu, Fildl and Fic)
Definition Ifpack2_Details_FastILU_Base_decl.hpp:38
Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node >::impl_scalar_type ImplScalar
Kokkos scalar type.
Definition Ifpack2_Details_FastILU_Base_decl.hpp:45
double getInitializeTime() const
Get the time spent in the last initialize() call.
Definition Ifpack2_Details_FastILU_Base_def.hpp:292
virtual void checkLocalILU() const
Verify and print debug information about the underlying ILU preconditioner (only supported if this is...
Definition Ifpack2_Details_FastILU_Base_def.hpp:316
void setMatrix(const Teuchos::RCP< const TRowMatrix > &A)
Definition Ifpack2_Details_FastILU_Base_def.hpp:351
void compute()
Compute the preconditioner.
Definition Ifpack2_Details_FastILU_Base_def.hpp:238
double getComputeTime() const
Get the time spent in the last compute() call.
Definition Ifpack2_Details_FastILU_Base_def.hpp:298
double getCopyTime() const
Get the time spent deep copying local 3-array CRS out of the matrix.
Definition Ifpack2_Details_FastILU_Base_def.hpp:310
int getNumApply() const
Get the number of times apply() was called.
Definition Ifpack2_Details_FastILU_Base_def.hpp:286
void initialize()
Initialize the preconditioner.
Definition Ifpack2_Details_FastILU_Base_def.hpp:121
bool isInitialized() const
Whether initialize() has been called since the last time the matrix's structure was changed.
Definition Ifpack2_Details_FastILU_Base_def.hpp:232
Kokkos::View< LocalOrdinal *, execution_space >::host_mirror_type OrdinalArrayHost
Array of LocalOrdinal on host.
Definition Ifpack2_Details_FastILU_Base_decl.hpp:57
FastILU_Base(Teuchos::RCP< const TRowMatrix > mat_)
Constructor.
Definition Ifpack2_Details_FastILU_Base_def.hpp:29
void setParameters(const Teuchos::ParameterList &List)
Validate parameters, and set defaults when parameters are not provided.
Definition Ifpack2_Details_FastILU_Base_def.hpp:108
void apply(const TMultiVec &X, TMultiVec &Y, Teuchos::ETransp mode=Teuchos::NO_TRANS, Scalar alpha=Teuchos::ScalarTraits< Scalar >::one(), Scalar beta=Teuchos::ScalarTraits< Scalar >::zero()) const
Apply the preconditioner.
Definition Ifpack2_Details_FastILU_Base_def.hpp:58
double getApplyTime() const
Get the time spent in the last apply() call.
Definition Ifpack2_Details_FastILU_Base_def.hpp:304
Teuchos::RCP< const Tpetra::Map< LocalOrdinal, GlobalOrdinal, Node > > getDomainMap() const
Get the domain map of the matrix.
Definition Ifpack2_Details_FastILU_Base_def.hpp:45
virtual void checkLocalIC() const
Verify and print debug information about the underlying IC preconditioner.
Definition Ifpack2_Details_FastILU_Base_def.hpp:323
int getNumInitialize() const
Get the number of times initialize() was called.
Definition Ifpack2_Details_FastILU_Base_def.hpp:274
Teuchos::RCP< const Tpetra::Map< LocalOrdinal, GlobalOrdinal, Node > > getRangeMap() const
Get the range map of the matrix.
Definition Ifpack2_Details_FastILU_Base_def.hpp:52
Teuchos::RCP< const TRowMatrix > getMatrix() const
Get the current matrix.
Definition Ifpack2_Details_FastILU_Base_def.hpp:268
std::string description() const
Return a brief description of the preconditioner, in YAML format.
Definition Ifpack2_Details_FastILU_Base_def.hpp:329
Kokkos::View< ImplScalar *, execution_space > ImplScalarArray
Array of Scalar on device.
Definition Ifpack2_Details_FastILU_Base_decl.hpp:59
int getNumCompute() const
Get the number of times compute() was called.
Definition Ifpack2_Details_FastILU_Base_def.hpp:280
bool isComputed() const
Whether compute() has been called since the last time the matrix's values or structure were changed.
Definition Ifpack2_Details_FastILU_Base_def.hpp:261
Ifpack2's implementation of Trilinos::Details::LinearSolver interface.
Definition Ifpack2_Details_LinearSolver_decl.hpp:75
Ifpack2 implementation details.
Preconditioners and smoothers for Tpetra sparse matrices.
Definition Ifpack2_AdditiveSchwarz_decl.hpp:40