46 #ifndef MUELU_HIERARCHY_DECL_HPP 47 #define MUELU_HIERARCHY_DECL_HPP 49 #include <Teuchos_ParameterList.hpp> 50 #include <Teuchos_Ptr.hpp> 52 #include <Xpetra_ConfigDefs.hpp> 53 #include <Xpetra_Matrix_fwd.hpp> 54 #include <Xpetra_MultiVector_fwd.hpp> 55 #include <Xpetra_MultiVectorFactory_fwd.hpp> 56 #include <Xpetra_Operator_fwd.hpp> 58 #include <Xpetra_Cloner.hpp> 67 #include "MueLu_FactoryManager.hpp" 100 template <class Scalar = Xpetra::Operator<>::scalar_type,
101 class LocalOrdinal =
typename Xpetra::Operator<Scalar>::local_ordinal_type,
102 class GlobalOrdinal =
typename Xpetra::Operator<Scalar, LocalOrdinal>::global_ordinal_type,
103 class Node =
typename Xpetra::Operator<Scalar, LocalOrdinal, GlobalOrdinal>::node_type>
105 #undef MUELU_HIERARCHY_SHORT 108 typedef Teuchos::ScalarTraits<SC>
STS;
136 Hierarchy(
const RCP<Matrix> & A,
const std::string& label);
164 template<
class S2,
class LO2,
class GO2,
class N2>
174 void AddLevel(
const RCP<Level> & level);
180 RCP<Level> &
GetLevel(
const int levelID = 0);
234 bool Setup(
int coarseLevelID,
const RCP<const FactoryManagerBase> fineLevelManager ,
const RCP<const FactoryManagerBase> coarseLevelManager,
235 const RCP<const FactoryManagerBase> nextLevelManager = Teuchos::null);
243 void Clear(
int startLevel = 0);
267 ReturnType Iterate(
const MultiVector& B, MultiVector& X, ConvData conv = ConvData(),
268 bool InitialGuessIsZero =
false, LO startLevel = 0);
279 void Write(
const LO &start=-1,
const LO &end=-1,
const std::string &suffix=
"");
312 void describe(Teuchos::FancyOStream& out,
const Teuchos::EVerbosityLevel verbLevel = Teuchos::VERB_HIGH)
const;
331 template<
class Node2>
332 Teuchos::RCP< Hierarchy<Scalar, LocalOrdinal, GlobalOrdinal, Node2> >
333 clone (
const RCP<Node2> &node2)
const;
410 template<
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
411 template<
typename Node2>
412 Teuchos::RCP<Hierarchy<Scalar, LocalOrdinal, GlobalOrdinal, Node2> >
414 clone (
const Teuchos::RCP<Node2> &node2)
const {
416 typedef Xpetra::Matrix<Scalar, LocalOrdinal, GlobalOrdinal, Node2> CloneOperator;
419 Teuchos::RCP<New_H_Type> new_h = Teuchos::rcp(
new New_H_Type());
420 new_h->Levels_.resize(this->GetNumLevels());
421 new_h->maxCoarseSize_ = maxCoarseSize_;
422 new_h->implicitTranspose_ = implicitTranspose_;
423 new_h->isPreconditioner_ = isPreconditioner_;
424 new_h->isDumpingEnabled_ = isDumpingEnabled_;
425 new_h->dumpLevel_ = dumpLevel_;
426 new_h->dumpFile_ = dumpFile_;
428 RCP<SmootherBase> Pre, Post;
429 RCP<CloneSmoother> clonePre, clonePost;
430 RCP<CloneOperator> cloneA, cloneR, cloneP;
431 RCP<Operator> A, R, P;
432 for (
int i = 0; i < GetNumLevels(); i++) {
433 RCP<Level> level = this->Levels_[i];
434 RCP<Level> clonelevel = rcp(
new Level());
436 if (level->IsAvailable(
"A")) {
437 A = level->template Get<RCP<Operator> >(
"A");
438 cloneA = Xpetra::clone<Scalar, LocalOrdinal, GlobalOrdinal, Node, Node2>(*A, node2);
439 clonelevel->template Set<RCP<CloneOperator> >(
"A", cloneA);
441 if (level->IsAvailable(
"R")){
442 R = level->template Get<RCP<Operator> >(
"R");
443 cloneR = Xpetra::clone<Scalar, LocalOrdinal, GlobalOrdinal, Node, Node2>(*R, node2);
444 clonelevel->template Set<RCP<CloneOperator> >(
"R", cloneR);
446 if (level->IsAvailable(
"P")){
447 P = level->template Get<RCP<Operator> >(
"P");
448 cloneP = Xpetra::clone<Scalar, LocalOrdinal, GlobalOrdinal, Node, Node2>(*P, node2);
449 clonelevel->template Set<RCP<CloneOperator> >(
"P", cloneP);
451 if (level->IsAvailable(
"PreSmoother")){
452 Pre = level->template Get<RCP<SmootherBase> >(
"PreSmoother");
453 clonePre = MueLu::clone<Scalar, LocalOrdinal, GlobalOrdinal, Node, Node2> (Pre, cloneA, node2);
454 clonelevel->template Set<RCP<CloneSmoother> >(
"PreSmoother", clonePre);
456 if (level->IsAvailable(
"PostSmoother")){
457 Post = level->template Get<RCP<SmootherBase> >(
"PostSmoother");
458 clonePost = MueLu::clone<Scalar, LocalOrdinal, GlobalOrdinal, Node, Node2> (Post, cloneA, node2);
459 clonelevel->
template Set<RCP<CloneSmoother> >(
"PostSmoother", clonePost);
461 new_h->Levels_[i] = clonelevel;
469 #define MUELU_HIERARCHY_SHORT 470 #endif // MUELU_HIERARCHY_DECL_HPP
void IsPreconditioner(const bool flag)
Array< RCP< MultiVector > > coarseExport_
This class specifies the default factory that should generate some data on a Level if the data does n...
double GetSmootherComplexity() const
RCP< Level > & GetLevel(const int levelID=0)
Retrieve a certain level from hierarchy.
Teuchos::RCP< Hierarchy< Scalar, LocalOrdinal, GlobalOrdinal, Node2 > > clone(const RCP< Node2 > &node2) const
Hierarchy()
Default constructor.
void DeleteLevelMultiVectors()
Array< RCP< MultiVector > > coarseImport_
void AddLevel(const RCP< Level > &level)
Add a level at the end of the hierarchy.
int sizeOfAllocatedLevelMultiVectors_
void SetMaxCoarseSize(Xpetra::global_size_t maxCoarseSize)
void AddNewLevel()
Add a new level at the end of the hierarchy.
static Xpetra::global_size_t GetDefaultMaxCoarseSize()
void SetCycle(CycleType Cycle)
Supports VCYCLE and WCYCLE types.
void Clear(int startLevel=0)
Clear impermanent data from previous setup.
Namespace for MueLu classes and methods.
Teuchos::ScalarTraits< SC > STS
MagnitudeType rate_
Convergece rate.
static const NoFactory * get()
void ReplaceCoordinateMap(Level &level)
void AllocateLevelMultiVectors(int numvecs)
void AddKeepFlag(const std::string &ename, const FactoryBase *factory=NoFactory::get(), KeepType keep=MueLu::Keep)
Call Level::AddKeepFlag for each level of the Hierarchy.
void print(std::ostream &out=std::cout, const VerbLevel verbLevel=(MueLu::Parameters|MueLu::Statistics0)) const
Xpetra::UnderlyingLib lib()
Base class for factories (e.g., R, P, and A_coarse).
Print statistics that do not involve significant additional computation.
ConvData(std::pair< LO, MagnitudeType > p)
Xpetra::UnderlyingLib lib_
CycleType GetCycle() const
Returns multigrid cycle type (supports VCYCLE and WCYCLE)
static CycleType GetDefaultCycle()
void Write(const LO &start=-1, const LO &end=-1, const std::string &suffix="")
Print matrices in the multigrid hierarchy to file.
Class that holds all level-specific information.
Class that provides default factories within Needs class.
void RemoveKeepFlag(const std::string &ename, const FactoryBase *factory, KeepType keep=MueLu::All)
Call Level::RemoveKeepFlag for each level of the Hierarchy.
int GetGlobalNumLevels() const
void CheckLevel(Level &level, int levelID)
Helper function.
const RCP< const FactoryManagerBase > & GetLevelManager(const int levelID) const
Always keep data, even accross run. This flag is set by Level::Keep(). This flag is propagated to coa...
ConvData(MagnitudeType tol)
static bool GetDefaultImplicitTranspose()
void describe(Teuchos::FancyOStream &out, const VerbLevel verbLevel=Default) const
Print the Hierarchy with some verbosity level to a FancyOStream object.
bool GetImplicitTranspose() const
void SetPRrebalance(bool doPRrebalance)
Base class for smoothers.
double GetOperatorComplexity() const
static int GetDefaultMaxLevels()
Base class for MueLu classes.
void SetImplicitTranspose(const bool &implicit)
virtual ~Hierarchy()
Destructor.
Data struct for defining stopping criteria of multigrid iteration.
Array< RCP< MultiVector > > coarseRhs_
STS::magnitudeType MagnitudeType
void Delete(const std::string &ename, const FactoryBase *factory=NoFactory::get())
Call Level::Delete(ename, factory) for each level of the Hierarchy.
MagnitudeType GetRate() const
Array< RCP< Level > > Levels_
Container for Level objects.
void DumpCurrentGraph() const
static bool GetDefaultPRrebalance()
Xpetra::global_size_t GetMaxCoarseSize() const
void SetProlongatorScalingFactor(double scalingFactor)
Specify damping factor alpha such that x = x + alpha*P*c, where c is the coarse grid correction...
ReturnType Iterate(const MultiVector &B, MultiVector &X, ConvData conv=ConvData(), bool InitialGuessIsZero=false, LO startLevel=0)
Apply the multigrid preconditioner.
Array< RCP< MultiVector > > residual_
void Keep(const std::string &ename, const FactoryBase *factory=NoFactory::get())
Call Level::Keep(ename, factory) for each level of the Hierarchy.
bool isDumpingEnabled_
Graph dumping.
void setlib(Xpetra::UnderlyingLib inlib)
std::string description() const
Return a simple one-line description of this object.
bool Setup(int coarseLevelID, const RCP< const FactoryManagerBase > fineLevelManager, const RCP< const FactoryManagerBase > coarseLevelManager, const RCP< const FactoryManagerBase > nextLevelManager=Teuchos::null)
Multi-level setup phase: build a new level of the hierarchy.
Array< RCP< MultiVector > > coarseX_
Array< RCP< MultiVector > > correction_
void EnableGraphDumping(const std::string &filename, int levelID=1)
Provides methods to build a multigrid hierarchy and apply multigrid cycles.
Array< RCP< const FactoryManagerBase > > levelManagers_
Xpetra::global_size_t maxCoarseSize_