10 #ifndef MUELU_MAXWELL_UTILS_DEF_HPP
11 #define MUELU_MAXWELL_UTILS_DEF_HPP
17 #include "Xpetra_Map.hpp"
24 #include "MueLu_ThresholdAFilterFactory.hpp"
25 #include "MueLu_Utilities.hpp"
26 #include "MueLu_RAPFactory.hpp"
30 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
35 Kokkos::View<bool*, typename Node::device_type::memory_space>& BCrowsKokkos_,
36 Kokkos::View<bool*, typename Node::device_type::memory_space>& BCcolsKokkos_,
37 Kokkos::View<bool*, typename Node::device_type::memory_space>& BCdomainKokkos_,
43 bool& allEdgesBoundary_,
44 bool& allNodesBoundary_) {
57 BCcolsKokkos_ = Kokkos::View<bool*, typename Node::device_type>(Kokkos::ViewAllocateWithoutInitializing(
"dirichletCols"), D0_Matrix_->getColMap()->getLocalNumElements());
58 BCdomainKokkos_ = Kokkos::View<bool*, typename Node::device_type>(Kokkos::ViewAllocateWithoutInitializing(
"dirichletDomains"), D0_Matrix_->getDomainMap()->getLocalNumElements());
61 auto BCrowsKokkos = BCrowsKokkos_;
62 Kokkos::parallel_reduce(
63 BCrowsKokkos_.size(), KOKKOS_LAMBDA(
int i,
int& sum) {
69 auto BCdomainKokkos = BCdomainKokkos_;
70 Kokkos::parallel_reduce(
71 BCdomainKokkos_.size(), KOKKOS_LAMBDA(
int i,
int& sum) {
72 if (BCdomainKokkos(i))
82 BCcols_.
resize(D0_Matrix_->getColMap()->getLocalNumElements());
83 BCdomain_.
resize(D0_Matrix_->getDomainMap()->getLocalNumElements());
86 for (
auto it = BCrows_.
begin(); it != BCrows_.
end(); ++it)
89 for (
auto it = BCdomain_.
begin(); it != BCdomain_.
end(); ++it)
94 MueLu_sumAll(SM_Matrix_->getRowMap()->getComm(), BCedgesLocal, BCedges_);
95 MueLu_sumAll(SM_Matrix_->getRowMap()->getComm(), BCnodesLocal, BCnodes_);
97 allEdgesBoundary_ = Teuchos::as<Xpetra::global_size_t>(BCedges_) >= D0_Matrix_->getRangeMap()->getGlobalNumElements();
98 allNodesBoundary_ = Teuchos::as<Xpetra::global_size_t>(BCnodes_) >= D0_Matrix_->getDomainMap()->getGlobalNumElements();
101 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
105 Kokkos::View<bool*, typename Node::device_type::memory_space>& BCrowsKokkos_,
106 Kokkos::View<bool*, typename Node::device_type::memory_space>& BCcolsKokkos_,
107 Kokkos::View<bool*, typename Node::device_type::memory_space>& BCdomainKokkos_,
110 bool& allEdgesBoundary_,
111 bool& allNodesBoundary_) {
116 int BCedgesLocal = 0;
117 int BCnodesLocal = 0;
124 BCcolsKokkos_ = Kokkos::View<bool*, typename Node::device_type>(Kokkos::ViewAllocateWithoutInitializing(
"dirichletCols"), D0_Matrix_->getColMap()->getLocalNumElements());
125 BCdomainKokkos_ = Kokkos::View<bool*, typename Node::device_type>(Kokkos::ViewAllocateWithoutInitializing(
"dirichletDomains"), D0_Matrix_->getDomainMap()->getLocalNumElements());
128 auto BCrowsKokkos = BCrowsKokkos_;
129 Kokkos::parallel_reduce(
130 BCrowsKokkos_.size(), KOKKOS_LAMBDA(
int i,
int& sum) {
136 auto BCdomainKokkos = BCdomainKokkos_;
137 Kokkos::parallel_reduce(
138 BCdomainKokkos_.size(), KOKKOS_LAMBDA(
int i,
int& sum) {
139 if (BCdomainKokkos(i))
145 MueLu_sumAll(SM_Matrix_->getRowMap()->getComm(), BCedgesLocal, BCedges_);
146 MueLu_sumAll(SM_Matrix_->getRowMap()->getComm(), BCnodesLocal, BCnodes_);
148 allEdgesBoundary_ = Teuchos::as<Xpetra::global_size_t>(BCedges_) >= D0_Matrix_->getRangeMap()->getGlobalNumElements();
149 allNodesBoundary_ = Teuchos::as<Xpetra::global_size_t>(BCnodes_) >= D0_Matrix_->getDomainMap()->getGlobalNumElements();
152 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
156 const bool keepDiagonal,
157 const size_t expectedNNZperRow) {
161 fineLevel.
Set(
"A", A);
162 fineLevel.
setlib(A->getDomainMap()->lib());
165 ThreshFact->
Build(fineLevel);
169 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
175 bool defaultFilter =
false;
180 if (parameterList_.
get<
bool>(
"refmaxwell: filter D0",
true) && D0_Matrix_->getLocalMaxNumRowEntries() > 2) {
181 D0_Matrix_ = removeExplicitZeros(D0_Matrix_, 1e-8,
false, 2);
184 defaultFilter =
true;
187 if (!M1_Matrix_.
is_null() && parameterList_.
get<
bool>(
"refmaxwell: filter M1", defaultFilter)) {
188 RCP<Vector> diag = VectorFactory::Build(M1_Matrix_->getRowMap());
190 M1_Matrix_->getLocalDiagCopy(*diag);
193 M1_Matrix_ = removeExplicitZeros(M1_Matrix_, threshold,
true);
196 if (!Ms_Matrix_.
is_null() && parameterList_.
get<
bool>(
"refmaxwell: filter Ms", defaultFilter)) {
197 RCP<Vector> diag = VectorFactory::Build(Ms_Matrix_->getRowMap());
199 Ms_Matrix_->getLocalDiagCopy(*diag);
202 Ms_Matrix_ = removeExplicitZeros(Ms_Matrix_, threshold,
true);
205 if (!SM_Matrix_.
is_null() && parameterList_.
get<
bool>(
"refmaxwell: filter SM", defaultFilter)) {
206 RCP<Vector> diag = VectorFactory::Build(SM_Matrix_->getRowMap());
208 SM_Matrix_->getLocalDiagCopy(*diag);
211 SM_Matrix_ = removeExplicitZeros(SM_Matrix_, threshold,
true);
215 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
219 using ATS = Kokkos::ArithTraits<Scalar>;
220 using impl_Scalar =
typename ATS::val_type;
221 using impl_ATS = Kokkos::ArithTraits<impl_Scalar>;
222 using range_type = Kokkos::RangePolicy<LO, typename NO::execution_space>;
224 const impl_Scalar impl_SC_ONE = impl_ATS::one();
225 const impl_Scalar impl_SC_ZERO = impl_ATS::zero();
228 auto lclMat = A->getLocalMatrixDevice();
229 Kokkos::parallel_for(
231 range_type(0, lclMat.nnz()),
232 KOKKOS_LAMBDA(
const size_t i) {
233 if (impl_ATS::magnitude(lclMat.values(i)) > threshold)
234 lclMat.values(i) = impl_SC_ONE;
236 lclMat.values(i) = impl_SC_ZERO;
241 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
246 xpImporter->setDistributorParameters(matvecParams);
249 xpExporter->setDistributorParameters(matvecParams);
252 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
256 Level fineLevel, coarseLevel;
262 fineLevel.
Set(
"A", A);
263 coarseLevel.
Set(
"P", P);
264 coarseLevel.
setlib(A->getDomainMap()->lib());
265 fineLevel.
setlib(A->getDomainMap()->lib());
271 rapList.
set(
"transpose: use implicit",
true);
272 rapList.
set(
"rap: fix zero diagonals", params.
get<
bool>(
"rap: fix zero diagonals",
true));
274 rapList.
set(
"rap: triple product", params.
get<
bool>(
"rap: triple product",
false));
284 #define MUELU_MAXWELL_UTILS_SHORT
285 #endif // ifdef MUELU_MAXWELL_UTILS_DEF_HPP
static void DetectDirichletColsAndDomains(const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Teuchos::ArrayRCP< bool > &dirichletRows, Teuchos::ArrayRCP< bool > dirichletCols, Teuchos::ArrayRCP< bool > dirichletDomain)
Detects Dirichlet columns & domains from a list of Dirichlet rows.
#define MueLu_sumAll(rcpComm, in, out)
T & Get(const std::string &ename, const FactoryBase *factory=NoFactory::get())
Get data without decrementing associated storage counter (i.e., read-only access). Usage: Level->Get< RCP<Matrix> >("A", factory) if factory == NULL => use default factory.
T & get(const std::string &name, T def_value)
static void ApplyRowSumCriterion(const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Magnitude rowSumTol, Teuchos::ArrayRCP< bool > &dirichletRows)
Apply Rowsum Criterion.
RCP< const ParameterList > GetValidParameterList() const
Return a const parameter list of valid parameters that setParameterList() will accept.
void SetPreviousLevel(const RCP< Level > &previousLevel)
ParameterList & set(std::string const &name, T &&value, std::string const &docString="", RCP< const ParameterEntryValidator > const &validator=null)
void SetFactoryManager(const RCP< const FactoryManagerBase > &factoryManager)
Set default factories (used internally by Hierarchy::SetLevel()).
void setlib(Xpetra::UnderlyingLib lib2)
void resize(const size_type n, const T &val=T())
virtual void SetParameterList(const Teuchos::ParameterList ¶mList)
Set parameters from a parameter list and return with default values.
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)
Class that holds all level-specific information.
Teuchos::ScalarTraits< Scalar >::magnitudeType magnitudeType
static void setMatvecParams(Matrix &A, RCP< ParameterList > matvecParams)
Sets matvec params on a matrix.
static Teuchos::ArrayRCP< const bool > DetectDirichletRows(const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Magnitude &tol=Teuchos::ScalarTraits< Magnitude >::zero(), bool count_twos_as_dirichlet=false)
Detect Dirichlet rows.
static RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > PtAPWrapper(const RCP< Matrix > &A, const RCP< Matrix > &P, Teuchos::ParameterList ¶ms, const std::string &label)
Performs an P^T AP.
virtual void setObjectLabel(const std::string &objectLabel)
static void detectBoundaryConditionsSM(RCP< Matrix > &SM_Matrix, RCP< Matrix > &D0_Matrix, magnitudeType rowSumTol, bool useKokkos_, Kokkos::View< bool *, typename Node::device_type::memory_space > &BCrowsKokkos, Kokkos::View< bool *, typename Node::device_type::memory_space > &BCcolsKokkos, Kokkos::View< bool *, typename Node::device_type::memory_space > &BCdomainKokkos, int &BCedges, int &BCnodes, Teuchos::ArrayRCP< bool > &BCrows, Teuchos::ArrayRCP< bool > &BCcols, Teuchos::ArrayRCP< bool > &BCdomain, bool &allEdgesBoundary, bool &allNodesBoundary)
Detect Dirichlet boundary conditions.
void Set(const std::string &ename, const T &entry, const FactoryBase *factory=NoFactory::get())
void Build(Level ¤tLevel) const
Build an object with this factory.
void SetLevelID(int levelID)
Set level number.
Factory for building coarse matrices.
static void thresholdedAbs(const RCP< Matrix > &A, const magnitudeType thresholded)
static Kokkos::View< bool *, typename NO::device_type::memory_space > DetectDirichletRows_kokkos(const Matrix &A, const Magnitude &tol=Teuchos::ScalarTraits< typename Teuchos::ScalarTraits< SC >::magnitudeType >::zero(), const bool count_twos_as_dirichlet=false)
Detect Dirichlet rows.
Factory for building a thresholded operator.
static RCP< Matrix > removeExplicitZeros(const RCP< Matrix > &A, const magnitudeType tolerance, const bool keepDiagonal=true, const size_t expectedNNZperRow=0)
Remove explicit zeros.
void Request(const FactoryBase &factory)
Increment the storage counter for all the inputs of a factory.