|
MueLu Version of the Day
|
Algorithm for coarsening a graph with structured aggregation. More...
#include <MueLu_AggregationStructuredAlgorithm_decl.hpp>
Classes | |
| struct | computeGraphDataConstantFunctor |
| struct | computeGraphDataLinearFunctor |
| struct | computeGraphRowPtrFunctor |
| struct | fillAggregatesFunctor |
Public Types | |
| using | local_graph_type = typename LWGraph_kokkos::local_graph_type |
| using | non_const_row_map_type = typename local_graph_type::row_map_type::non_const_type |
| using | size_type = typename local_graph_type::size_type |
| using | entries_type = typename local_graph_type::entries_type |
| using | device_type = typename local_graph_type::device_type |
| using | execution_space = typename local_graph_type::device_type::execution_space |
| using | memory_space = typename local_graph_type::device_type::memory_space |
| using | LOVectorView = decltype(std::declval< LOVector >().getLocalViewDevice(Tpetra::Access::ReadWrite)) |
| using | constIntTupleView = typename Kokkos::View< const int[3], device_type > |
| using | constLOTupleView = typename Kokkos::View< const LO[3], device_type > |
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 > |
Constructors/Destructors. | |
| AggregationStructuredAlgorithm (const RCP< const FactoryBase > &=Teuchos::null) | |
| Constructor. | |
| virtual | ~AggregationStructuredAlgorithm () |
| Destructor. | |
Aggregation methods. | |
| void | BuildAggregatesNonKokkos (const Teuchos::ParameterList ¶ms, const LWGraph &graph, Aggregates &aggregates, typename AggregationAlgorithmBase< LocalOrdinal, GlobalOrdinal, Node >::AggStatHostType &aggStat, LO &numNonAggregatedNodes) const |
| Local aggregation. | |
| void | BuildGraphOnHost (const LWGraph &graph, RCP< IndexManager > &geoData, const LO dofsPerNode, RCP< CrsGraph > &myGraph, RCP< const Map > &coarseCoordinatesFineMap, RCP< const Map > &coarseCoordinatesMap) const |
| Local aggregation. | |
| void | BuildAggregates (const Teuchos::ParameterList ¶ms, const LWGraph_kokkos &graph, Aggregates &aggregates, typename AggregationAlgorithmBase< LocalOrdinal, GlobalOrdinal, Node >::AggStatType &aggStat, LO &numNonAggregatedNodes) const |
| Build aggregates object. | |
| void | BuildGraph (const LWGraph_kokkos &graph, RCP< IndexManager_kokkos > &geoData, const LO dofsPerNode, RCP< CrsGraph > &myGraph) const |
| Build a CrsGraph instead of aggregates. | |
| std::string | description () const |
| Return a simple one-line description of this object. | |
| void | ComputeGraphDataConstant (const LWGraph &graph, RCP< IndexManager > &geoData, const LO dofsPerNode, const int numInterpolationPoints, ArrayRCP< size_t > &nnzOnRow, Array< size_t > &rowPtr, Array< LO > &colIndex) const |
| void | ComputeGraphDataLinear (const LWGraph &graph, RCP< IndexManager > &geoData, const LO dofsPerNode, const int numInterpolationPoints, ArrayRCP< size_t > &nnzOnRow, Array< size_t > &rowPtr, Array< LO > &colIndex) const |
Additional Inherited Members | |
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 |
| 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 structured aggregation.
Use the logical indexing of the mesh to obtain a very regular aggregation pattern and maintain lines and planes of the problem as they might be useful to the smoother. This algorithms is also very easy to parallelize on node due to its very regular and predictible memory access patern.
| Parameter | Meaning |
|---|---|
| aggregation: coarsen | describe the coarsening rate to be used in each direction |
Definition at line 48 of file MueLu_AggregationStructuredAlgorithm_decl.hpp.
| using MueLu::AggregationStructuredAlgorithm< LocalOrdinal, GlobalOrdinal, Node >::local_graph_type = typename LWGraph_kokkos::local_graph_type |
Definition at line 53 of file MueLu_AggregationStructuredAlgorithm_decl.hpp.
| using MueLu::AggregationStructuredAlgorithm< LocalOrdinal, GlobalOrdinal, Node >::non_const_row_map_type = typename local_graph_type::row_map_type::non_const_type |
Definition at line 54 of file MueLu_AggregationStructuredAlgorithm_decl.hpp.
| using MueLu::AggregationStructuredAlgorithm< LocalOrdinal, GlobalOrdinal, Node >::size_type = typename local_graph_type::size_type |
Definition at line 55 of file MueLu_AggregationStructuredAlgorithm_decl.hpp.
| using MueLu::AggregationStructuredAlgorithm< LocalOrdinal, GlobalOrdinal, Node >::entries_type = typename local_graph_type::entries_type |
Definition at line 56 of file MueLu_AggregationStructuredAlgorithm_decl.hpp.
| using MueLu::AggregationStructuredAlgorithm< LocalOrdinal, GlobalOrdinal, Node >::device_type = typename local_graph_type::device_type |
Definition at line 57 of file MueLu_AggregationStructuredAlgorithm_decl.hpp.
| using MueLu::AggregationStructuredAlgorithm< LocalOrdinal, GlobalOrdinal, Node >::execution_space = typename local_graph_type::device_type::execution_space |
Definition at line 58 of file MueLu_AggregationStructuredAlgorithm_decl.hpp.
| using MueLu::AggregationStructuredAlgorithm< LocalOrdinal, GlobalOrdinal, Node >::memory_space = typename local_graph_type::device_type::memory_space |
Definition at line 59 of file MueLu_AggregationStructuredAlgorithm_decl.hpp.
| using MueLu::AggregationStructuredAlgorithm< LocalOrdinal, GlobalOrdinal, Node >::LOVectorView = decltype(std::declval<LOVector>().getLocalViewDevice(Tpetra::Access::ReadWrite)) |
Definition at line 61 of file MueLu_AggregationStructuredAlgorithm_decl.hpp.
| using MueLu::AggregationStructuredAlgorithm< LocalOrdinal, GlobalOrdinal, Node >::constIntTupleView = typename Kokkos::View<const int[3], device_type> |
Definition at line 62 of file MueLu_AggregationStructuredAlgorithm_decl.hpp.
| using MueLu::AggregationStructuredAlgorithm< LocalOrdinal, GlobalOrdinal, Node >::constLOTupleView = typename Kokkos::View<const LO[3], device_type> |
Definition at line 63 of file MueLu_AggregationStructuredAlgorithm_decl.hpp.
|
inline |
Constructor.
Definition at line 68 of file MueLu_AggregationStructuredAlgorithm_decl.hpp.
|
inlinevirtual |
Destructor.
Definition at line 71 of file MueLu_AggregationStructuredAlgorithm_decl.hpp.
| void MueLu::AggregationStructuredAlgorithm< LocalOrdinal, GlobalOrdinal, Node >::BuildAggregatesNonKokkos | ( | const Teuchos::ParameterList & | params, |
| const LWGraph & | graph, | ||
| Aggregates & | aggregates, | ||
| typename AggregationAlgorithmBase< LocalOrdinal, GlobalOrdinal, Node >::AggStatHostType & | aggStat, | ||
| LO & | numNonAggregatedNodes | ||
| ) | const |
Local aggregation.
Definition at line 34 of file MueLu_AggregationStructuredAlgorithm_def.hpp.
| void MueLu::AggregationStructuredAlgorithm< LocalOrdinal, GlobalOrdinal, Node >::BuildGraphOnHost | ( | const LWGraph & | graph, |
| RCP< IndexManager > & | geoData, | ||
| const LO | dofsPerNode, | ||
| RCP< CrsGraph > & | myGraph, | ||
| RCP< const Map > & | coarseCoordinatesFineMap, | ||
| RCP< const Map > & | coarseCoordinatesMap | ||
| ) | const |
Local aggregation.
Definition at line 103 of file MueLu_AggregationStructuredAlgorithm_def.hpp.
| void MueLu::AggregationStructuredAlgorithm< LocalOrdinal, GlobalOrdinal, Node >::BuildAggregates | ( | const Teuchos::ParameterList & | params, |
| const LWGraph_kokkos & | graph, | ||
| Aggregates & | aggregates, | ||
| typename AggregationAlgorithmBase< LocalOrdinal, GlobalOrdinal, Node >::AggStatType & | aggStat, | ||
| LO & | numNonAggregatedNodes | ||
| ) | const |
Build aggregates object.
Definition at line 390 of file MueLu_AggregationStructuredAlgorithm_def.hpp.
| void MueLu::AggregationStructuredAlgorithm< LocalOrdinal, GlobalOrdinal, Node >::BuildGraph | ( | const LWGraph_kokkos & | graph, |
| RCP< IndexManager_kokkos > & | geoData, | ||
| const LO | dofsPerNode, | ||
| RCP< CrsGraph > & | myGraph | ||
| ) | const |
Build a CrsGraph instead of aggregates.
Definition at line 430 of file MueLu_AggregationStructuredAlgorithm_def.hpp.
|
inlinevirtual |
Return a simple one-line description of this object.
Reimplemented from MueLu::Describable.
Definition at line 107 of file MueLu_AggregationStructuredAlgorithm_decl.hpp.
|
private |
Definition at line 235 of file MueLu_AggregationStructuredAlgorithm_def.hpp.
|
private |
Definition at line 294 of file MueLu_AggregationStructuredAlgorithm_def.hpp.