MueLu
Version of the Day
|
Pure virtual base class for all MueLu aggregation algorithms. More...
#include <MueLu_AggregationAlgorithmBase.hpp>
Public Types | |
using | LWGraphHostType = LWGraph |
using | AggStatHostType = Kokkos::View< unsigned *, typename LWGraphHostType::device_type > |
using | LWGraphType = LWGraph_kokkos |
using | AggStatType = Kokkos::View< unsigned *, typename LWGraphType::device_type > |
Constructors/Destructors | |
virtual | ~AggregationAlgorithmBase () |
Destructor. More... | |
Build routines | |
virtual void | SetupPhase (const ParameterList ¶ms, Teuchos::RCP< const Teuchos::Comm< int >> &comm, LO &numLocalNodes, LO &numNonAggregatedNodes) |
virtual void | BuildAggregatesNonKokkos (const Teuchos::ParameterList ¶ms, const LWGraphHostType &graph, Aggregates &aggregates, AggStatHostType &aggStat, LO &numNonAggregatedNodes) const =0 |
BuildAggregatesNonKokkos routine. More... | |
virtual void | BuildAggregates (const Teuchos::ParameterList ¶ms, const LWGraphType &graph, Aggregates &aggregates, AggStatType &aggStat, LO &numNonAggregatedNodes) const =0 |
BuildAggregates routine. More... | |
Additional Inherited Members | |
![]() | |
virtual | ~BaseClass () |
Destructor. More... | |
![]() | |
VerbLevel | GetVerbLevel () const |
Get the verbosity level. More... | |
void | SetVerbLevel (const VerbLevel verbLevel) |
Set the verbosity level of this object. More... | |
int | GetProcRankVerbose () const |
Get proc rank used for printing. Do not use this information for any other purpose. More... | |
int | SetProcRankVerbose (int procRank) const |
Set proc rank used for printing. More... | |
bool | IsPrint (MsgType type, int thisProcRankOnly=-1) const |
Find out whether we need to print out information for a specific message type. More... | |
Teuchos::FancyOStream & | GetOStream (MsgType type, int thisProcRankOnly=0) const |
Get an output stream for outputting the input message type. More... | |
Teuchos::FancyOStream & | GetBlackHole () const |
VerboseObject () | |
virtual | ~VerboseObject () |
Destructor. More... | |
![]() | |
VerboseObject (const EVerbosityLevel verbLevel=VERB_DEFAULT, const RCP< FancyOStream > &oStream=Teuchos::null) | |
virtual const VerboseObject & | setVerbLevel (const EVerbosityLevel verbLevel) const |
virtual const VerboseObject & | setOverridingVerbLevel (const EVerbosityLevel verbLevel) const |
virtual EVerbosityLevel | getVerbLevel () const |
TEUCHOSPARAMETERLIST_LIB_DLL_EXPORT RCP< const ParameterList > | getValidVerboseObjectSublist () |
TEUCHOSPARAMETERLIST_LIB_DLL_EXPORT void | setupVerboseObjectSublist (ParameterList *paramList) |
TEUCHOSPARAMETERLIST_LIB_DLL_EXPORT void | readVerboseObjectSublist (ParameterList *paramList, RCP< FancyOStream > *oStream, EVerbosityLevel *verbLevel) |
void | readVerboseObjectSublist (ParameterList *paramList, VerboseObject< ObjectType > *verboseObject) |
![]() | |
virtual | ~VerboseObjectBase () |
VerboseObjectBase (const RCP< FancyOStream > &oStream=Teuchos::null) | |
virtual const VerboseObjectBase & | setOStream (const RCP< FancyOStream > &oStream) const |
virtual const VerboseObjectBase & | setOverridingOStream (const RCP< FancyOStream > &oStream) const |
virtual VerboseObjectBase & | setLinePrefix (const std::string &linePrefix) |
virtual RCP< FancyOStream > | getOStream () const |
virtual RCP< FancyOStream > | getOverridingOStream () const |
virtual std::string | getLinePrefix () const |
virtual OSTab | getOSTab (const int tabs=1, const std::string &linePrefix="") const |
![]() | |
virtual | ~Describable () |
Destructor. More... | |
virtual std::string | ShortClassName () const |
Return the class name of the object, without template parameters and without namespace. More... | |
virtual void | describe (Teuchos::FancyOStream &out_arg, const VerbLevel verbLevel=Default) const |
virtual std::string | description () const |
Return a simple one-line description of this object. More... | |
void | describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default) const |
Print the object with some verbosity level to an FancyOStream object. More... | |
![]() | |
void | describe (std::ostream &out, const EVerbosityLevel verbLevel=verbLevel_default) const |
LabeledObject () | |
virtual | ~LabeledObject () |
virtual void | setObjectLabel (const std::string &objectLabel) |
virtual std::string | getObjectLabel () const |
DescribableStreamManipulatorState | describe (const Describable &describable, const EVerbosityLevel verbLevel=Describable::verbLevel_default) |
std::ostream & | operator<< (std::ostream &os, const DescribableStreamManipulatorState &d) |
![]() | |
static void | SetMueLuOStream (const Teuchos::RCP< Teuchos::FancyOStream > &mueluOStream) |
static void | SetMueLuOFileStream (const std::string &filename) |
static Teuchos::RCP < Teuchos::FancyOStream > | GetMueLuOStream () |
static void | SetDefaultVerbLevel (const VerbLevel defaultVerbLevel) |
Set the default (global) verbosity level. More... | |
static VerbLevel | GetDefaultVerbLevel () |
Get the default (global) verbosity level. More... | |
![]() | |
static void | setDefaultVerbLevel (const EVerbosityLevel defaultVerbLevel) |
static EVerbosityLevel | getDefaultVerbLevel () |
![]() | |
static void | setDefaultOStream (const RCP< FancyOStream > &defaultOStream) |
static RCP< FancyOStream > | getDefaultOStream () |
![]() | |
static const EVerbosityLevel | verbLevel_default |
![]() | |
void | initializeVerboseObject (const EVerbosityLevel verbLevel=VERB_DEFAULT, const RCP< FancyOStream > &oStream=Teuchos::null) |
![]() | |
void | initializeVerboseObjectBase (const RCP< FancyOStream > &oStream=Teuchos::null) |
virtual void | informUpdatedVerbosityState () const |
Pure virtual base class for all MueLu aggregation algorithms.
Definition at line 32 of file MueLu_AggregationAlgorithmBase.hpp.
using MueLu::AggregationAlgorithmBase< LocalOrdinal, GlobalOrdinal, Node >::LWGraphHostType = LWGraph |
Definition at line 36 of file MueLu_AggregationAlgorithmBase.hpp.
using MueLu::AggregationAlgorithmBase< LocalOrdinal, GlobalOrdinal, Node >::AggStatHostType = Kokkos::View<unsigned*, typename LWGraphHostType::device_type> |
Definition at line 37 of file MueLu_AggregationAlgorithmBase.hpp.
using MueLu::AggregationAlgorithmBase< LocalOrdinal, GlobalOrdinal, Node >::LWGraphType = LWGraph_kokkos |
Definition at line 39 of file MueLu_AggregationAlgorithmBase.hpp.
using MueLu::AggregationAlgorithmBase< LocalOrdinal, GlobalOrdinal, Node >::AggStatType = Kokkos::View<unsigned*, typename LWGraphType::device_type> |
Definition at line 40 of file MueLu_AggregationAlgorithmBase.hpp.
|
inlinevirtual |
Destructor.
Definition at line 46 of file MueLu_AggregationAlgorithmBase.hpp.
|
inlinevirtual |
Perform necessary communication among procs even if a proc might skip a phase
SetupPhase routine gets executed on all ranks, even if all nodes are already aggregated If communication is required by the phase it needs to take place here.
Reimplemented in MueLu::AggregationPhase2aAlgorithm< LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 58 of file MueLu_AggregationAlgorithmBase.hpp.
|
pure virtual |
BuildAggregatesNonKokkos routine.
|
pure virtual |
BuildAggregates routine.