|
MueLu Version of the Day
|
Algorithm for coarsening a graph with uncoupled aggregation. keep special marked nodes as singleton node aggregates over all multigrid levels. More...
#include <MueLu_OnePtAggregationAlgorithm_decl.hpp>
Constructors/Destructors. | |
| OnePtAggregationAlgorithm (RCP< const FactoryBase > const &graphFact=Teuchos::null) | |
| Constructor. | |
| virtual | ~OnePtAggregationAlgorithm () |
| Destructor. | |
Aggregation methods. | |
| void | BuildAggregatesNonKokkos (Teuchos::ParameterList const ¶ms, LWGraph const &graph, Aggregates &aggregates, typename AggregationAlgorithmBase< LocalOrdinal, GlobalOrdinal, Node >::AggStatHostType &aggStat, LO &numNonAggregatedNodes) const |
| Local aggregation. | |
| void | BuildAggregates (Teuchos::ParameterList const ¶ms, LWGraph_kokkos const &graph, Aggregates &aggregates, typename AggregationAlgorithmBase< LocalOrdinal, GlobalOrdinal, Node >::AggStatType &aggStat, LO &numNonAggregatedNodes) const |
Additional Inherited Members | |
Public Types inherited from MueLu::AggregationAlgorithmBase< LocalOrdinal, GlobalOrdinal, Node > | |
| 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 > |
Public Member Functions inherited from MueLu::AggregationAlgorithmBase< LocalOrdinal, GlobalOrdinal, Node > | |
| virtual | ~AggregationAlgorithmBase () |
| Destructor. | |
| 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. | |
| virtual void | BuildAggregates (const Teuchos::ParameterList ¶ms, const LWGraphType &graph, Aggregates &aggregates, AggStatType &aggStat, LO &numNonAggregatedNodes) const =0 |
| BuildAggregates routine. | |
Public Member Functions inherited from MueLu::BaseClass | |
| virtual | ~BaseClass () |
| Destructor. | |
Public Member Functions inherited from MueLu::VerboseObject | |
| VerboseObject () | |
| virtual | ~VerboseObject () |
| Destructor. | |
| VerbLevel | GetVerbLevel () const |
| Get the verbosity level. | |
| void | SetVerbLevel (const VerbLevel verbLevel) |
| Set the verbosity level of this object. | |
| int | GetProcRankVerbose () const |
| Get proc rank used for printing. Do not use this information for any other purpose. | |
| int | SetProcRankVerbose (int procRank) const |
| Set proc rank used for printing. | |
| bool | IsPrint (MsgType type, int thisProcRankOnly=-1) const |
| Find out whether we need to print out information for a specific message type. | |
| Teuchos::FancyOStream & | GetOStream (MsgType type, int thisProcRankOnly=0) const |
| Get an output stream for outputting the input message type. | |
| Teuchos::FancyOStream & | GetBlackHole () const |
Public Member Functions inherited from MueLu::Describable | |
| virtual | ~Describable () |
| Destructor. | |
| 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. | |
| 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. | |
| virtual std::string | ShortClassName () const |
| Return the class name of the object, without template parameters and without namespace. | |
Static Public Member Functions inherited from MueLu::VerboseObject | |
| static void | SetDefaultVerbLevel (const VerbLevel defaultVerbLevel) |
| Set the default (global) verbosity level. | |
| static VerbLevel | GetDefaultVerbLevel () |
| Get the default (global) verbosity level. | |
| static void | SetMueLuOStream (const Teuchos::RCP< Teuchos::FancyOStream > &mueluOStream) |
| static void | SetMueLuOFileStream (const std::string &filename) |
| static Teuchos::RCP< Teuchos::FancyOStream > | GetMueLuOStream () |
Algorithm for coarsening a graph with uncoupled aggregation. keep special marked nodes as singleton node aggregates over all multigrid levels.
The user can mark some nodes as ONEPT to build some single node aggregates. This can be very useful for certain applications. We build single node aggregates for nodes with the state ONEPT. Then, the state is changed to ignored. The OnePtAggregationAlgorithm should run before the Phase1AggregationAlgorithm.
Only nodes with state ONEPT are changed to IGNORED.
Definition at line 51 of file MueLu_OnePtAggregationAlgorithm_decl.hpp.
| MueLu::OnePtAggregationAlgorithm< LocalOrdinal, GlobalOrdinal, Node >::OnePtAggregationAlgorithm | ( | RCP< const FactoryBase > const & | graphFact = Teuchos::null | ) |
Constructor.
Definition at line 35 of file MueLu_OnePtAggregationAlgorithm_def.hpp.
|
inlinevirtual |
Destructor.
Definition at line 63 of file MueLu_OnePtAggregationAlgorithm_decl.hpp.
| void MueLu::OnePtAggregationAlgorithm< LocalOrdinal, GlobalOrdinal, Node >::BuildAggregatesNonKokkos | ( | Teuchos::ParameterList const & | params, |
| LWGraph const & | graph, | ||
| Aggregates & | aggregates, | ||
| typename AggregationAlgorithmBase< LocalOrdinal, GlobalOrdinal, Node >::AggStatHostType & | aggStat, | ||
| LO & | numNonAggregatedNodes | ||
| ) | const |
Local aggregation.
Definition at line 39 of file MueLu_OnePtAggregationAlgorithm_def.hpp.
| void MueLu::OnePtAggregationAlgorithm< LocalOrdinal, GlobalOrdinal, Node >::BuildAggregates | ( | Teuchos::ParameterList const & | params, |
| LWGraph_kokkos const & | graph, | ||
| Aggregates & | aggregates, | ||
| typename AggregationAlgorithmBase< LocalOrdinal, GlobalOrdinal, Node >::AggStatType & | aggStat, | ||
| LO & | numNonAggregatedNodes | ||
| ) | const |
Definition at line 77 of file MueLu_OnePtAggregationAlgorithm_def.hpp.