52 #ifndef IFPACK2_ADDITIVESCHWARZ_DECL_HPP 53 #define IFPACK2_ADDITIVESCHWARZ_DECL_HPP 55 #include "Ifpack2_ConfigDefs.hpp" 59 #include "Tpetra_Map.hpp" 60 #include "Tpetra_MultiVector.hpp" 61 #include "Tpetra_RowMatrix.hpp" 62 #include <type_traits> 66 template<
class MV,
class OP,
class NormType>
275 template<
class MatrixType,
276 class LocalInverseType =
278 typename MatrixType::local_ordinal_type,
279 typename MatrixType::global_ordinal_type,
280 typename MatrixType::node_type> >
283 typename MatrixType::local_ordinal_type,
284 typename MatrixType::global_ordinal_type,
285 typename MatrixType::node_type>,
287 typename MatrixType::local_ordinal_type,
288 typename MatrixType::global_ordinal_type,
289 typename MatrixType::node_type> >,
291 typename MatrixType::local_ordinal_type,
292 typename MatrixType::global_ordinal_type,
293 typename MatrixType::node_type> >
296 static_assert(std::is_same<LocalInverseType,
298 typename MatrixType::local_ordinal_type,
299 typename MatrixType::global_ordinal_type,
300 typename MatrixType::node_type> >::value,
"Ifpack2::AdditiveSchwarz: You are not allowed to use nondefault values for the LocalInverseType template parameter. Please stop specifying this explicitly. The default template parameter is perfectly fine.");
302 static_assert(std::is_same<MatrixType,
303 Tpetra::RowMatrix<
typename MatrixType::scalar_type,
304 typename MatrixType::local_ordinal_type,
305 typename MatrixType::global_ordinal_type,
306 typename MatrixType::node_type> >::value,
"Ifpack2::AdditiveSchwarz: Please use MatrixType = Tpetra::RowMatrix instead of MatrixType = Tpetra::CrsMatrix. Don't worry, AdditiveSchwarz's constructor can take either type of matrix; it does a dynamic cast if necessary inside. Restricting the set of allowed types here will improve build times and reduce library and executable sizes.");
324 typedef typename Teuchos::ScalarTraits<scalar_type>::magnitudeType
magnitude_type;
327 typedef Tpetra::RowMatrix<scalar_type,
351 const int overlapLevel);
361 virtual Teuchos::RCP<const Tpetra::Map<local_ordinal_type,global_ordinal_type,node_type> > getDomainMap()
const;
364 virtual Teuchos::RCP<const Tpetra::Map<local_ordinal_type,global_ordinal_type,node_type> > getRangeMap()
const;
368 apply (
const Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &X,
369 Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &Y,
370 Teuchos::ETransp mode = Teuchos::NO_TRANS,
371 scalar_type alpha = Teuchos::ScalarTraits<scalar_type>::one(),
372 scalar_type beta = Teuchos::ScalarTraits<scalar_type>::zero())
const;
413 setInnerPreconditioner (
const Teuchos::RCP<
Preconditioner<scalar_type,
416 node_type> >& innerPrec);
445 setMatrix (
const Teuchos::RCP<const row_matrix_type>& A);
449 virtual Teuchos::RCP<const row_matrix_type> getMatrix()
const;
618 virtual void setParameters (
const Teuchos::ParameterList& plist);
644 setParameterList (
const Teuchos::RCP<Teuchos::ParameterList>& plist);
653 virtual void initialize();
656 virtual bool isInitialized()
const;
659 virtual void compute();
662 virtual bool isComputed()
const;
665 virtual int getNumInitialize()
const;
668 virtual int getNumCompute()
const;
671 virtual int getNumApply()
const;
674 virtual double getInitializeTime()
const;
677 virtual double getComputeTime()
const;
680 virtual double getApplyTime()
const;
686 std::string description()
const;
689 void describe(Teuchos::FancyOStream &out,
const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default)
const;
694 virtual std::ostream& print(std::ostream& os)
const;
697 virtual int getOverlapLevel()
const;
702 typedef Tpetra::Map<local_ordinal_type,
706 typedef Tpetra::Import<local_ordinal_type,
708 node_type> import_type;
710 typedef Tpetra::MultiVector<scalar_type,
715 typedef Tpetra::Operator<scalar_type,
726 typedef Trilinos::Details::LinearSolver<MV, OP, typename MV::mag_type> inner_solver_type;
735 void localApply(MV &OverlappingX, MV &OverlappingY)
const;
739 bool hasInnerPrecName ()
const;
743 std::string innerPrecName ()
const;
747 void removeInnerPrecName ();
754 std::pair<Teuchos::ParameterList, bool> innerPrecParams ()
const;
758 void removeInnerPrecParams ();
761 static std::string defaultInnerPrecName ();
766 Teuchos::RCP<const row_matrix_type> Matrix_;
771 Teuchos::RCP<row_matrix_type> OverlappingMatrix_;
774 Teuchos::RCP<row_matrix_type> ReorderedLocalizedMatrix_;
777 Teuchos::RCP<row_matrix_type> innerMatrix_;
793 Teuchos::ParameterList List_;
796 mutable Teuchos::RCP<const Teuchos::ParameterList> validParams_;
799 Tpetra::CombineMode CombineMode_;
803 std::string ReorderingAlgorithm_;
805 bool FilterSingletons_;
807 Teuchos::RCP<row_matrix_type> SingletonMatrix_;
811 bool ZeroStartingSolution_;
818 mutable int NumApply_;
820 double InitializeTime_;
824 mutable double ApplyTime_;
826 double InitializeFlops_;
828 double ComputeFlops_;
830 mutable double ApplyFlops_;
832 Teuchos::RCP<inner_solver_type> Inverse_;
834 Teuchos::RCP<const map_type> localMap_;
842 mutable Teuchos::RCP<const import_type> DistributedImporter_;
847 #endif // IFPACK2_ADDITIVESCHWARZ_DECL_HPP Mix-in interface for preconditioners that can change their matrix after construction.
Definition: Ifpack2_Details_CanChangeMatrix.hpp:93
Declaration of interface for nested preconditioners.
Mix-in interface for nested preconditioners.
Definition: Ifpack2_Details_NestedPreconditioner.hpp:97
MatrixType::node_type node_type
The Node type used by the input MatrixType.
Definition: Ifpack2_AdditiveSchwarz_decl.hpp:321
Teuchos::ScalarTraits< scalar_type >::magnitudeType magnitude_type
The type of the magnitude (absolute value) of a matrix entry.
Definition: Ifpack2_AdditiveSchwarz_decl.hpp:324
Ifpack2 implementation details.
MatrixType::global_ordinal_type global_ordinal_type
The type of global indices in the input MatrixType.
Definition: Ifpack2_AdditiveSchwarz_decl.hpp:318
MatrixType::scalar_type scalar_type
The type of the entries of the input MatrixType.
Definition: Ifpack2_AdditiveSchwarz_decl.hpp:312
Definition: Ifpack2_AdditiveSchwarz_decl.hpp:64
Interface for all Ifpack2 preconditioners.
Definition: Ifpack2_Preconditioner.hpp:107
Declaration of interface for preconditioners that can change their matrix after construction.
Tpetra::RowMatrix< scalar_type, local_ordinal_type, global_ordinal_type, node_type > row_matrix_type
The Tpetra::RowMatrix specialization matching MatrixType.
Definition: Ifpack2_AdditiveSchwarz_decl.hpp:330
Additive Schwarz domain decomposition for Tpetra sparse matrices.
Definition: Ifpack2_AdditiveSchwarz_decl.hpp:281
Preconditioners and smoothers for Tpetra sparse matrices.
Definition: Ifpack2_AdditiveSchwarz_decl.hpp:72
void getValidParameters(Teuchos::ParameterList ¶ms)
Fills a list which contains all the parameters possibly used by Ifpack2.
Definition: Ifpack2_Parameters.cpp:50
MatrixType::local_ordinal_type local_ordinal_type
The type of local indices in the input MatrixType.
Definition: Ifpack2_AdditiveSchwarz_decl.hpp:315