MueLu Version of the Day
Loading...
Searching...
No Matches
MueLu_MultiPhys_def.hpp
Go to the documentation of this file.
1// @HEADER
2// *****************************************************************************
3// MueLu: A package for multigrid based preconditioning
4//
5// Copyright 2012 NTESS and the MueLu contributors.
6// SPDX-License-Identifier: BSD-3-Clause
7// *****************************************************************************
8// @HEADER
9
10#ifndef MUELU_MULTIPHYS_DEF_HPP
11#define MUELU_MULTIPHYS_DEF_HPP
12
13#include <sstream>
14#include "MueLu_ConfigDefs.hpp"
15
16#include "Xpetra_Map.hpp"
18#include "Xpetra_MatrixUtils.hpp"
19
21#include "MueLu_SaPFactory.hpp"
22#include "MueLu_AggregationExportFactory.hpp"
23#include "MueLu_Utilities.hpp"
24#include "MueLu_Level.hpp"
25#include "MueLu_Hierarchy.hpp"
26#include "MueLu_RAPFactory.hpp"
27#include "MueLu_Monitor.hpp"
28#include "MueLu_PerfUtils.hpp"
29#include "MueLu_ParameterListInterpreter.hpp"
30#include "MueLu_HierarchyManager.hpp"
31#include <MueLu_HierarchyUtils.hpp>
35
36#ifdef HAVE_MUELU_CUDA
37#include "cuda_profiler_api.h"
38#endif
39
40namespace MueLu {
41
42template <class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
43const Teuchos::RCP<const Xpetra::Map<LocalOrdinal, GlobalOrdinal, Node>> MultiPhys<Scalar, LocalOrdinal, GlobalOrdinal, Node>::getDomainMap() const {
44 return AmatMultiphysics_->getDomainMap();
45}
46
47template <class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
48const Teuchos::RCP<const Xpetra::Map<LocalOrdinal, GlobalOrdinal, Node>> MultiPhys<Scalar, LocalOrdinal, GlobalOrdinal, Node>::getRangeMap() const {
49 return AmatMultiphysics_->getRangeMap();
50}
51
52template <class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
54 // this operator only makes sense for the Combo when using TransP for R
55
56 list.set("multigrid algorithm", "combine");
57 list.set("combine: numBlks", nBlks_);
58
59 // Make sure verbosity gets passed to the sublists
60 std::string verbosity = list.get("verbosity", "high");
62
63 arrayOfParamLists_.resize(nBlks_);
64 for (int i = 0; i < nBlks_; i++) {
65 std::string listName = "subblockList" + Teuchos::toString(i);
66 if (list.isSublist(listName)) {
67 arrayOfParamLists_[i] = Teuchos::rcpFromRef(list.sublist(listName));
68 } else
69 TEUCHOS_TEST_FOR_EXCEPTION(true, Exceptions::RuntimeError, "Must provide sublist " + listName);
70
71 arrayOfParamLists_[i]->set("verbosity", arrayOfParamLists_[i]->get("verbosity", verbosity));
72 if (OmitSubblockSmoother_) {
73 arrayOfParamLists_[i]->set("smoother: pre or post", "none");
74 arrayOfParamLists_[i]->set("smoother: type", "none");
75 }
76 }
77
78 // Are we using Kokkos?
79 useKokkos_ = !Node::is_serial;
80 useKokkos_ = list.get("use kokkos refactor", useKokkos_);
81
82 paramListMultiphysics_ = Teuchos::rcpFromRef(list);
83}
84
85template <class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
87 /*
88
89 Create a set of AMG hierarchies whose interpolation matrices are used to build on combined
90 AMG hierarchy for a multiphysics problem
91
92 */
93
94 //#ifdef HAVE_MUELU_CUDA
95 // if (paramListMultiphysics_.get<bool>("multiphysics: cuda profile setup", false)) cudaProfilerStart();
96 //#endif
97
98 std::string timerLabel;
99 if (reuse)
100 timerLabel = "MueLu MultiPhys: compute (reuse)";
101 else
102 timerLabel = "MueLu MultiPhys: compute";
103 RCP<Teuchos::TimeMonitor> tmCompute = getTimer(timerLabel);
104
106 // Generate the (iii,iii) Hierarchy
107
108 for (int iii = 0; iii < nBlks_; iii++) {
109 if (arrayOfCoords_ != Teuchos::null) {
110 if (arrayOfCoords_[iii] != Teuchos::null) {
111 arrayOfParamLists_[iii]->sublist("user data").set("Coordinates", arrayOfCoords_[iii]);
112 }
113 }
114
115 if (arrayOfMaterials_ != Teuchos::null) {
116 if (arrayOfMaterials_[iii] != Teuchos::null) {
117 arrayOfParamLists_[iii]->sublist("user data").set("Material", arrayOfMaterials_[iii]);
118 }
119 }
120
121 bool wantToRepartition = false;
122 if (paramListMultiphysics_->isParameter("repartition: enable"))
123 wantToRepartition = paramListMultiphysics_->get<bool>("repartition: enable");
124
125 arrayOfParamLists_[iii]->set("repartition: enable", wantToRepartition);
126 arrayOfParamLists_[iii]->set("repartition: rebalance P and R", true);
127 arrayOfParamLists_[iii]->set("repartition: explicit via new copy rebalance P and R", true);
128
129 if (paramListMultiphysics_->isParameter("repartition: use subcommunicators"))
130 arrayOfParamLists_[iii]->set("repartition: use subcommunicators", paramListMultiphysics_->isParameter("repartition: use subcommunicators"));
131 else
132 arrayOfParamLists_[iii]->set("repartition: use subcommunicators", true);
133 }
134 // repartitioning should only happen when createing the individual P's , not
135 // when combiing them
136
137 paramListMultiphysics_->set<bool>("repartition: enable", false);
138
139 bool useMaxLevels = false;
140 if (paramListMultiphysics_->isParameter("combine: useMaxLevels"))
141 useMaxLevels = paramListMultiphysics_->get<bool>("combine: useMaxLevels");
142
143 LO maxLevels = useMaxLevels ? 0 : std::numeric_limits<LO>::max();
144 for (int i = 0; i < nBlks_; i++) {
145 std::string operatorLabel = "MultiPhys (" + Teuchos::toString(i) + "," + Teuchos::toString(i) + ")";
146 arrayOfAuxMatrices_[i]->setObjectLabel(operatorLabel);
147 arrayOfHierarchies_[i] = MueLu::CreateXpetraPreconditioner(arrayOfAuxMatrices_[i], *arrayOfParamLists_[i]);
148 LO tempNlevels = arrayOfHierarchies_[i]->GetGlobalNumLevels();
149 if (useMaxLevels) {
150 if (tempNlevels > maxLevels) maxLevels = tempNlevels;
151 } else {
152 if (tempNlevels < maxLevels) maxLevels = tempNlevels;
153 }
154 }
155
156 hierarchyMultiphysics_ = rcp(new Hierarchy("Combo"));
157 for (LO i = 0; i < maxLevels; i++) {
158 hierarchyMultiphysics_->AddNewLevel();
159 }
160 for (int i = 0; i < nBlks_; i++) {
161 std::string subblkName = "Psubblock" + Teuchos::toString(i);
162 MueLu::HierarchyUtils<SC, LO, GO, NO>::CopyBetweenHierarchies(*(arrayOfHierarchies_[i]), *(hierarchyMultiphysics_), "P", subblkName, "RCP<Matrix>");
163
164 std::string subblkOpName = "Operatorsubblock" + Teuchos::toString(i);
165 MueLu::HierarchyUtils<SC, LO, GO, NO>::CopyBetweenHierarchies(*(arrayOfHierarchies_[i]), *(hierarchyMultiphysics_), "A", subblkOpName, "RCP<Matrix>");
166
167 // Copy remaining levels, if needed
168 if (useMaxLevels) {
169 const auto numLevelsBlk = arrayOfHierarchies_[i]->GetNumLevels();
170 const auto numGlobalLevelsBlk = arrayOfHierarchies_[i]->GetGlobalNumLevels();
171 if (numLevelsBlk == numGlobalLevelsBlk) {
172 auto crsLevel = arrayOfHierarchies_[i]->GetLevel(numLevelsBlk - 1);
173 TEUCHOS_ASSERT(crsLevel->IsAvailable("A"));
174 for (int levelId = numLevelsBlk; levelId < maxLevels; ++levelId) {
175 auto level = hierarchyMultiphysics_->GetLevel(levelId);
176 MueLu::HierarchyUtils<SC, LO, GO, NO>::CopyBetweenLevels(*crsLevel, *level, "A", subblkOpName, "RCP<Matrix>");
177 }
178 }
179 }
180 }
181 paramListMultiphysics_->set("coarse: max size", 1);
182 paramListMultiphysics_->set("max levels", maxLevels);
183
184 AmatMultiphysics_->setObjectLabel("A: block " + Teuchos::toString(nBlks_) + " x " + Teuchos::toString(nBlks_) + "multiphysics matrix");
185
186 // Rip off non-serializable data before validation
187 Teuchos::ParameterList nonSerialListMultiphysics, processedListMultiphysics;
188 MueLu::ExtractNonSerializableData(*paramListMultiphysics_, processedListMultiphysics, nonSerialListMultiphysics);
189
190 // Rip off the subblock List stuff as we don't need it any more and I think it messes up validator
191
192 Teuchos::ParameterList stripped;
193 for (ParameterList::ConstIterator inListEntry = processedListMultiphysics.begin(); inListEntry != processedListMultiphysics.end(); inListEntry++) {
194 const std::string& levelName = inListEntry->first;
195 if (levelName.find("subblockList") != 0) stripped.setEntry(inListEntry->first, inListEntry->second);
196 }
197
198 RCP<HierarchyManager<SC, LO, GO, NO>> mueLuFactory = rcp(new ParameterListInterpreter<SC, LO, GO, NO>(stripped, AmatMultiphysics_->getDomainMap()->getComm()));
199 hierarchyMultiphysics_->setlib(AmatMultiphysics_->getDomainMap()->lib());
200 hierarchyMultiphysics_->SetProcRankVerbose(AmatMultiphysics_->getDomainMap()->getComm()->getRank());
201
202 // We don't need nullspace or coordinates, since we don't use them when just combining prolongators that have been already created
203 hierarchyMultiphysics_->GetLevel(0)->Set("A", AmatMultiphysics_);
204
205 // Stick the non-serializible data on the hierarchy.
206 // Not sure that we need this, since we don't use it in building the multiphysics hierarchy
207 HierarchyUtils<SC, LO, GO, NO>::AddNonSerializableDataToHierarchy(*mueLuFactory, *hierarchyMultiphysics_, nonSerialListMultiphysics);
208 mueLuFactory->SetupHierarchy(*hierarchyMultiphysics_);
209
210 describe(GetOStream(Runtime0));
211}
212
213template <class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
214Teuchos::RCP<Teuchos::TimeMonitor> MultiPhys<Scalar, LocalOrdinal, GlobalOrdinal, Node>::getTimer(std::string name, RCP<const Teuchos::Comm<int>> comm) const {
215 if (IsPrint(Timings)) {
216 if (!syncTimers_)
217 return Teuchos::rcp(new Teuchos::TimeMonitor(*Teuchos::TimeMonitor::getNewTimer(name)));
218 else {
219 if (comm.is_null())
220 return Teuchos::rcp(new Teuchos::SyncTimeMonitor(*Teuchos::TimeMonitor::getNewTimer(name), AmatMultiphysics_->getRowMap()->getComm().ptr()));
221 else
222 return Teuchos::rcp(new Teuchos::SyncTimeMonitor(*Teuchos::TimeMonitor::getNewTimer(name), comm.ptr()));
223 }
224 } else
225 return Teuchos::null;
226}
227
228template <class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
229void MultiPhys<Scalar, LocalOrdinal, GlobalOrdinal, Node>::resetMatrix(RCP<Matrix> AmatMultiphysics_new, bool ComputePrec) {
230 bool reuse = !AmatMultiphysics_.is_null();
231 AmatMultiphysics_ = AmatMultiphysics_new;
232 if (ComputePrec) compute(reuse);
233}
234
235template <class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
236void MultiPhys<Scalar, LocalOrdinal, GlobalOrdinal, Node>::applyInverse(const MultiVector& RHS, MultiVector& X) const {
237 hierarchyMultiphysics_->Iterate(RHS, X, 1, true);
238}
239
240template <class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
241void MultiPhys<Scalar, LocalOrdinal, GlobalOrdinal, Node>::apply(const MultiVector& RHS, MultiVector& X,
242 Teuchos::ETransp /* mode */,
243 Scalar /* alpha */,
244 Scalar /* beta */) const {
245 RCP<Teuchos::TimeMonitor> tm = getTimer("MueLu MultiPhys: solve");
246 hierarchyMultiphysics_->Iterate(RHS, X, 1, true);
247}
248
249template <class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
253
254template <class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
256 initialize(const Teuchos::RCP<Matrix>& AmatMultiPhysics,
257 const Teuchos::ArrayRCP<RCP<Matrix>> arrayOfAuxMatrices,
258 const Teuchos::ArrayRCP<Teuchos::RCP<MultiVector>> arrayOfNullspaces,
259 const Teuchos::ArrayRCP<Teuchos::RCP<RealValuedMultiVector>> arrayOfCoords,
260 const int nBlks,
261 Teuchos::ParameterList& List,
262 const Teuchos::ArrayRCP<Teuchos::RCP<MultiVector>> arrayOfMaterials) {
263 arrayOfHierarchies_.resize(nBlks_);
264 for (int i = 0; i < nBlks_; i++) arrayOfHierarchies_[i] = Teuchos::null;
265
266 // Default settings
267 useKokkos_ = false;
268 enable_reuse_ = false;
269 syncTimers_ = false;
270
271 // set parameters
272 setParameters(List);
273
274} // initialize
275
276template <class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
278 describe(Teuchos::FancyOStream& out, const Teuchos::EVerbosityLevel /* verbLevel */) const {
279 std::ostringstream oss;
280
281 RCP<const Teuchos::Comm<int>> comm = AmatMultiphysics_->getDomainMap()->getComm();
282
283 oss << "\n--------------------------------------------------------------------------------\n"
284 << "--- MultiPhysics Summary ---\n"
285 "--------------------------------------------------------------------------------"
286 << std::endl;
287 oss << std::endl;
288
289 GlobalOrdinal numRows;
290 GlobalOrdinal nnz;
291
292 AmatMultiphysics_->getRowMap()->getComm()->barrier();
293
294 for (int i = 0; i < nBlks_; i++) {
295 numRows = arrayOfAuxMatrices_[i]->getGlobalNumRows();
296 nnz = arrayOfAuxMatrices_[i]->getGlobalNumEntries();
297 Xpetra::global_size_t tt = numRows;
298 int rowspacer = 3;
299 while (tt != 0) {
300 tt /= 10;
301 rowspacer++;
302 }
303 tt = nnz;
304 int nnzspacer = 2;
305 while (tt != 0) {
306 tt /= 10;
307 nnzspacer++;
308 }
309
310 oss << "block " << std::setw(rowspacer) << " rows " << std::setw(nnzspacer) << " nnz " << std::setw(9) << " nnz/row" << std::endl;
311 oss << "(" << Teuchos::toString(i) << ", " << Teuchos::toString(i) << ")" << std::setw(rowspacer) << numRows << std::setw(nnzspacer) << nnz << std::setw(9) << as<double>(nnz) / numRows << std::endl;
312 }
313 oss << std::endl;
314
315 out << oss.str();
316
317 for (int i = 0; i < nBlks_; i++) {
318 arrayOfHierarchies_[i]->describe(out, GetVerbLevel());
319 }
320
321} // describe
322
323} // namespace MueLu
324
325#define MUELU_MULTIPHYS_SHORT
326#endif // ifdef MUELU_MULTIPHYS_DEF_HPP
Various adapters that will create a MueLu preconditioner that is an Xpetra::Matrix.
MueLu::DefaultScalar Scalar
MueLu::DefaultGlobalOrdinal GlobalOrdinal
Exception throws to report errors in the internal logical of the program.
static void CopyBetweenLevels(Level &fromLevel, Level &toLevel, const std::string fromLabel, const std::string toLabel, const std::string dataType)
static void AddNonSerializableDataToHierarchy(HierarchyManager &HM, Hierarchy &H, const ParameterList &nonSerialList)
Add non-serializable data to Hierarchy.
static void CopyBetweenHierarchies(Hierarchy &fromHierarchy, Hierarchy &toHierarchy, const std::string fromLabel, const std::string toLabel, const std::string dataType)
Provides methods to build a multigrid hierarchy and apply multigrid cycles.
const Teuchos::RCP< const Map > getRangeMap() const
Returns the Xpetra::Map object associated with the range of this operator.
Teuchos::RCP< Teuchos::TimeMonitor > getTimer(std::string name, RCP< const Teuchos::Comm< int > > comm=Teuchos::null) const
get a (synced) timer
void compute(bool reuse=false)
Setup the preconditioner.
void applyInverse(const MultiVector &RHS, MultiVector &X) const
apply standard MultiPhys cycle
void initialize(const Teuchos::RCP< Matrix > &AmatMultiPhysics, const Teuchos::ArrayRCP< RCP< Matrix > > arrayOfAuxMatrices, const Teuchos::ArrayRCP< Teuchos::RCP< MultiVector > > arrayOfNullspaces, const Teuchos::ArrayRCP< Teuchos::RCP< RealValuedMultiVector > > arrayOfCoords, const int nBlks, Teuchos::ParameterList &List, const Teuchos::ArrayRCP< Teuchos::RCP< MultiVector > > arrayOfMaterials)
void setParameters(Teuchos::ParameterList &list)
Set parameters.
void resetMatrix(Teuchos::RCP< Matrix > SM_Matrix_new, bool ComputePrec=true)
Reset system matrix.
const Teuchos::RCP< const Map > getDomainMap() const
Returns the Xpetra::Map object associated with the domain of this operator.
bool hasTransposeApply() const
Indicates whether this operator supports applying the adjoint operator.
void describe(Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::VERB_HIGH) const
void apply(const MultiVector &X, MultiVector &Y, Teuchos::ETransp mode=Teuchos::NO_TRANS, Scalar alpha=Teuchos::ScalarTraits< Scalar >::one(), Scalar beta=Teuchos::ScalarTraits< Scalar >::zero()) const
static void SetDefaultVerbLevel(const VerbLevel defaultVerbLevel)
Set the default (global) verbosity level.
Namespace for MueLu classes and methods.
long ExtractNonSerializableData(const Teuchos::ParameterList &inList, Teuchos::ParameterList &serialList, Teuchos::ParameterList &nonSerialList)
Extract non-serializable data from level-specific sublists and move it to a separate parameter list.
@ Runtime0
One-liner description of what is happening.
@ Timings
Print all timing information.
MsgType toVerbLevel(const std::string &verbLevelStr)
Teuchos::RCP< MueLu::Hierarchy< Scalar, LocalOrdinal, GlobalOrdinal, Node > > CreateXpetraPreconditioner(Teuchos::RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > op, const Teuchos::ParameterList &inParamList)
Helper function to create a MueLu preconditioner that can be used by Xpetra.Given an Xpetra::Matrix,...