46 #ifndef MUELU_MAXWELL_UTILS_DECL_HPP 47 #define MUELU_MAXWELL_UTILS_DECL_HPP 52 #include "Xpetra_Map_fwd.hpp" 53 #include "Xpetra_Matrix_fwd.hpp" 54 #include "Xpetra_MatrixFactory_fwd.hpp" 55 #include "Xpetra_MultiVectorFactory_fwd.hpp" 56 #include "Xpetra_VectorFactory_fwd.hpp" 57 #include "Xpetra_CrsMatrixWrap_fwd.hpp" 62 #ifdef HAVE_MUELU_KOKKOS_REFACTOR 67 #if defined(HAVE_MUELU_STRATIMIKOS) && defined(HAVE_MUELU_THYRA) 68 #include <Thyra_LinearOpWithSolveBase.hpp> 83 class Maxwell_Utils :
public VerboseObject {
85 #undef MUELU_MAXWELL_UTILS_SHORT 89 typedef typename Teuchos::ScalarTraits<Scalar>::magnitudeType
magnitudeType;
95 RCP<Matrix> & D0_Matrix,
105 Teuchos::ArrayRCP<bool> & BCrows,
106 Teuchos::ArrayRCP<bool> & BCcols,
107 Teuchos::ArrayRCP<bool> & BCdomain,
108 bool & allEdgesBoundary,
109 bool & allNodesBoundary);
113 RCP<Matrix> & D0_Matrix,
114 RCP<Matrix> & SM_Matrix,
115 RCP<Matrix> & M1_Matrix,
116 RCP<Matrix> & Ms_Matrix);
119 RCP<Matrix> & D0_Matrix,
120 RCP<Matrix> & SM_Matrix) {
126 static void setMatvecParams(Matrix& A, RCP<ParameterList> matvecParams);
128 #if defined(HAVE_MUELU_STRATIMIKOS) && defined(HAVE_MUELU_THYRA) 130 static RCP<Thyra::PreconditionerBase<Scalar> > setupStratimikosPreconditioner(RCP<Xpetra::Matrix<Scalar,LocalOrdinal,GlobalOrdinal,Node> > A,
131 RCP<ParameterList> params);
141 #define MUELU_REFMAXWELL_SHORT 142 #endif // MUELU_REFMAXWELL_DECL_HPP static void removeExplicitZeros(Teuchos::ParameterList ¶meterList, RCP< Matrix > &D0_Matrix, RCP< Matrix > &SM_Matrix)
MueLu::DefaultLocalOrdinal LocalOrdinal
#define HAVE_MUELU_KOKKOS_REFACTOR
static void removeExplicitZeros(Teuchos::ParameterList ¶meterList, RCP< Matrix > &D0_Matrix, RCP< Matrix > &SM_Matrix, RCP< Matrix > &M1_Matrix, RCP< Matrix > &Ms_Matrix)
Remove explicit zeros.
Namespace for MueLu classes and methods.
MueLu::DefaultScalar Scalar
MueLu::DefaultGlobalOrdinal GlobalOrdinal
Teuchos::ScalarTraits< Scalar >::magnitudeType magnitudeType
static void setMatvecParams(Matrix &A, RCP< ParameterList > matvecParams)
Sets matvec params on a matrix.
static void detectBoundaryConditionsSM(RCP< Matrix > &SM_Matrix, RCP< Matrix > &D0_Matrix, magnitudeType rowSumTol, int &BCedges, int &BCnodes, Teuchos::ArrayRCP< bool > &BCrows, Teuchos::ArrayRCP< bool > &BCcols, Teuchos::ArrayRCP< bool > &BCdomain, bool &allEdgesBoundary, bool &allNodesBoundary)
Detect Dirichlet boundary conditions.