MueLu Version of the Day
Loading...
Searching...
No Matches
MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node > Class Template Reference

Preconditioner (wrapped as a Xpetra::Operator) for Maxwell's equations in curl-curl form. More...

#include <MueLu_RefMaxwell_decl.hpp>

Inheritance diagram for MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >:
MueLu::VerboseObject

Public Types

typedef Teuchos::ScalarTraits< Scalar >::magnitudeType magnitudeType
 
typedef Teuchos::ScalarTraits< Scalar >::coordinateType coordinateType
 
typedef Xpetra::MultiVector< coordinateType, LO, GO, NO > RealValuedMultiVector
 

Public Member Functions

 RefMaxwell ()
 Constructor.
 
 RefMaxwell (Teuchos::RCP< Hierarchy > HH, Teuchos::RCP< Hierarchy > H22)
 Constructor with Hierarchies.
 
 RefMaxwell (const Teuchos::RCP< Matrix > &SM_Matrix, const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< Matrix > &Ms_Matrix, const Teuchos::RCP< Matrix > &M0inv_Matrix, const Teuchos::RCP< Matrix > &M1_Matrix, const Teuchos::RCP< MultiVector > &Nullspace, const Teuchos::RCP< RealValuedMultiVector > &Coords, Teuchos::ParameterList &List, bool ComputePrec=true)
 
 RefMaxwell (const Teuchos::RCP< Matrix > &SM_Matrix, const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< Matrix > &M0inv_Matrix, const Teuchos::RCP< Matrix > &M1_Matrix, const Teuchos::RCP< MultiVector > &Nullspace, const Teuchos::RCP< RealValuedMultiVector > &Coords, Teuchos::ParameterList &List, bool ComputePrec=true)
 
 RefMaxwell (const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< Matrix > &M0inv_Matrix, const Teuchos::RCP< Matrix > &M1_Matrix, const Teuchos::RCP< MultiVector > &Nullspace, const Teuchos::RCP< RealValuedMultiVector > &Coords, Teuchos::ParameterList &List)
 
 RefMaxwell (const Teuchos::RCP< Matrix > &SM_Matrix, const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< Matrix > &M1_Matrix, const Teuchos::RCP< MultiVector > &Nullspace, const Teuchos::RCP< RealValuedMultiVector > &Coords, Teuchos::ParameterList &List, bool ComputePrec)
 
 RefMaxwell (const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< Matrix > &M1_Matrix, const Teuchos::RCP< MultiVector > &Nullspace, const Teuchos::RCP< RealValuedMultiVector > &Coords, Teuchos::ParameterList &List)
 
 RefMaxwell (const Teuchos::RCP< Matrix > &SM_Matrix, Teuchos::ParameterList &List, bool ComputePrec=true)
 
virtual ~RefMaxwell ()
 Destructor.
 
Teuchos::RCP< const Map > getDomainMap () const
 Returns the Xpetra::Map object associated with the domain of this operator.
 
Teuchos::RCP< const Map > getRangeMap () const
 Returns the Xpetra::Map object associated with the range of this operator.
 
const Teuchos::RCP< Matrix > & getJacobian () const
 Returns Jacobian matrix SM.
 
void setParameters (Teuchos::ParameterList &list)
 Set parameters.
 
void compute (bool reuse=false)
 Setup the preconditioner.
 
void buildProlongator ()
 Setup the prolongator for the (1,1)-block.
 
void formCoarseMatrix ()
 Compute P11^{T}*A*P11 efficiently.
 
void resetMatrix (Teuchos::RCP< Matrix > SM_Matrix_new, bool ComputePrec=true)
 Reset system matrix.
 
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
 
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 residual (const MultiVector &X, const MultiVector &B, MultiVector &R) const
 Compute a residual R = B - (*this) * X.
 
- 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
 

Private Member Functions

void initialize (const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< Matrix > &Ms_Matrix, const Teuchos::RCP< Matrix > &M0inv_Matrix, const Teuchos::RCP< Matrix > &M1_Matrix, const Teuchos::RCP< MultiVector > &Nullspace, const Teuchos::RCP< RealValuedMultiVector > &Coords, Teuchos::ParameterList &List)
 
void setFineLevelSmoother ()
 Set the fine level smoother.
 
void applyInverseAdditive (const MultiVector &RHS, MultiVector &X) const
 apply additive algorithm for 2x2 solve
 
void solveH (const MultiVector &RHS, MultiVector &X) const
 apply solve to 1-1 block only
 
void solve22 (const MultiVector &RHS, MultiVector &X) const
 apply solve to 2-2 block only
 
void allocateMemory (int numVectors) const
 allocate multivectors for solve
 
void dump (const Matrix &A, std::string name) const
 dump out matrix
 
void dump (const MultiVector &X, std::string name) const
 dump out multivector
 
void dumpCoords (const RealValuedMultiVector &X, std::string name) const
 dump out real-valued multivector
 
void dump (const Teuchos::ArrayRCP< bool > &v, std::string name) const
 dump out boolean ArrayView
 
void dump (const Kokkos::View< bool *, typename Node::device_type > &v, std::string name) const
 dump out boolean Kokkos::View
 
Teuchos::RCP< Teuchos::TimeMonitor > getTimer (std::string name, RCP< const Teuchos::Comm< int > > comm=Teuchos::null) const
 get a (synced) timer
 

Private Attributes

Teuchos::RCP< HierarchyHierarchyH_
 Two hierarchies: one for the coarse (1,1)-block, another for the (2,2)-block.
 
Teuchos::RCP< HierarchyHierarchy22_
 
Teuchos::RCP< SmootherBasePreSmoother_
 
Teuchos::RCP< SmootherBasePostSmoother_
 
Teuchos::RCP< SmootherPrototypePreSmootherData_
 
Teuchos::RCP< SmootherPrototypePostSmootherData_
 
RCP< Operator > thyraPrecOpH_
 
RCP< Operator > thyraPrecOp22_
 
Teuchos::RCP< Matrix > SM_Matrix_
 Various matrices.
 
Teuchos::RCP< Matrix > D0_Matrix_
 
Teuchos::RCP< Matrix > D0_T_Matrix_
 
Teuchos::RCP< Matrix > M0inv_Matrix_
 
Teuchos::RCP< Matrix > M1_Matrix_
 
Teuchos::RCP< Matrix > Ms_Matrix_
 
Teuchos::RCP< Matrix > A_nodal_Matrix_
 
Teuchos::RCP< Matrix > P11_
 
Teuchos::RCP< Matrix > R11_
 
Teuchos::RCP< Matrix > AH_
 
Teuchos::RCP< Matrix > A22_
 
Teuchos::RCP< Matrix > Addon_Matrix_
 
Teuchos::RCP< const Map > D0origDomainMap_
 
Teuchos::RCP< const Import > D0origImporter_
 
Kokkos::View< bool *, typename Node::device_type > BCrowsKokkos_
 Vectors for BCs.
 
Kokkos::View< bool *, typename Node::device_type > BCcolsKokkos_
 
Kokkos::View< bool *, typename Node::device_type > BCdomainKokkos_
 
int BCedges_
 
int BCnodes_
 
Teuchos::ArrayRCP< bool > BCrows_
 
Teuchos::ArrayRCP< bool > BCcols_
 
Teuchos::ArrayRCP< bool > BCdomain_
 
Teuchos::RCP< MultiVector > Nullspace_
 Nullspace.
 
Teuchos::RCP< RealValuedMultiVectorCoords_
 Coordinates.
 
Teuchos::RCP< RealValuedMultiVectorCoordsH_
 
Teuchos::RCP< MultiVector > NullspaceH_
 Nullspace for (1,1) problem.
 
Teuchos::RCP< const Import > ImporterH_
 Importer to coarse (1,1) hierarchy.
 
Teuchos::RCP< const Import > Importer22_
 
bool D0_T_R11_colMapsMatch_
 
bool allEdgesBoundary_
 
bool allNodesBoundary_
 
Teuchos::ParameterList parameterList_
 Parameter lists.
 
Teuchos::ParameterList precList11_
 
Teuchos::ParameterList precList22_
 
Teuchos::ParameterList smootherList_
 
Teuchos::RCP< Teuchos::ParameterList > AH_AP_reuse_data_
 
Teuchos::RCP< Teuchos::ParameterList > AH_RAP_reuse_data_
 
Teuchos::RCP< Teuchos::ParameterList > A22_AP_reuse_data_
 
Teuchos::RCP< Teuchos::ParameterList > A22_RAP_reuse_data_
 
bool disable_addon_
 Some options.
 
bool dump_matrices_
 
bool useKokkos_
 
bool use_as_preconditioner_
 
bool implicitTranspose_
 
bool fuseProlongationAndUpdate_
 
bool syncTimers_
 
bool enable_reuse_
 
bool skipFirstLevel_
 
bool applyBCsToAnodal_
 
bool applyBCsToH_
 
bool applyBCsTo22_
 
int numItersH_
 
int numIters22_
 
std::string mode_
 
Teuchos::RCP< MultiVector > P11res_
 Temporary memory.
 
Teuchos::RCP< MultiVector > P11x_
 
Teuchos::RCP< MultiVector > P11resSubComm_
 
Teuchos::RCP< MultiVector > P11xSubComm_
 
Teuchos::RCP< MultiVector > D0res_
 
Teuchos::RCP< MultiVector > D0x_
 
Teuchos::RCP< MultiVector > D0resSubComm_
 
Teuchos::RCP< MultiVector > D0xSubComm_
 
Teuchos::RCP< MultiVector > residual_
 
Teuchos::RCP< MultiVector > P11resTmp_
 
Teuchos::RCP< MultiVector > D0resTmp_
 
Teuchos::RCP< MultiVector > D0TR11Tmp_
 

Additional Inherited Members

- 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 ()
 

Detailed Description

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
class MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >

Preconditioner (wrapped as a Xpetra::Operator) for Maxwell's equations in curl-curl form.

This uses a 2x2 block reformulation.

Reference: P. Bochev, J. Hu, C. Siefert, and R. Tuminaro. "An algebraic multigrid approach based on a compatible gauge reformulation of Maxwell's equations." SIAM Journal on Scientific Computing, 31(1), 557-583.

Parameter list options:

  • refmaxwell: mode - a string specifying the order of solve of the block system. Allowed values are: "additive" (default), "121", "212", "1", "2"
  • refmaxwell: disable addon - bool specifing whether the addon should be built for stabilization. Default: "true"
  • refmaxwell: use as preconditioner - bool specifing whether RefMaxwell is used as a preconditioner or as a solver.
  • refmaxwell: dump matrices - bool specifing whether the matrices should be dumped. Default: "false"
  • refmaxwell: prolongator compute algorithm - a string specifying the algorithm to build the prolongator. Allowed values are: "mat-mat" and "gustavson"
  • refmaxwell: 11list and refmaxwell: 22list - parameter list for the multigrid hierarchies on 11 and 22 blocks
  • refmaxwell: subsolves on subcommunicators - bool redistribute the two subsolves to disjoint sub-communicators (so that the additive solve can occur in parallel) Default: "false"

Definition at line 121 of file MueLu_RefMaxwell_decl.hpp.

Member Typedef Documentation

◆ magnitudeType

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
typedef Teuchos::ScalarTraits<Scalar>::magnitudeType MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::magnitudeType

Definition at line 128 of file MueLu_RefMaxwell_decl.hpp.

◆ coordinateType

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
typedef Teuchos::ScalarTraits<Scalar>::coordinateType MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::coordinateType

Definition at line 129 of file MueLu_RefMaxwell_decl.hpp.

◆ RealValuedMultiVector

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
typedef Xpetra::MultiVector<coordinateType,LO,GO,NO> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::RealValuedMultiVector

Definition at line 130 of file MueLu_RefMaxwell_decl.hpp.

Constructor & Destructor Documentation

◆ RefMaxwell() [1/8]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::RefMaxwell ( )
inline

Constructor.

Definition at line 133 of file MueLu_RefMaxwell_decl.hpp.

◆ RefMaxwell() [2/8]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::RefMaxwell ( Teuchos::RCP< Hierarchy > HH,
Teuchos::RCP< Hierarchy > H22 )
inline

Constructor with Hierarchies.

Definition at line 142 of file MueLu_RefMaxwell_decl.hpp.

◆ RefMaxwell() [3/8]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::RefMaxwell ( const Teuchos::RCP< Matrix > & SM_Matrix,
const Teuchos::RCP< Matrix > & D0_Matrix,
const Teuchos::RCP< Matrix > & Ms_Matrix,
const Teuchos::RCP< Matrix > & M0inv_Matrix,
const Teuchos::RCP< Matrix > & M1_Matrix,
const Teuchos::RCP< MultiVector > & Nullspace,
const Teuchos::RCP< RealValuedMultiVector > & Coords,
Teuchos::ParameterList & List,
bool ComputePrec = true )
inline

Constructor with Jacobian (with add on)

Parameters
[in]SM_MatrixJacobian
[in]D0_MatrixDiscrete Gradient
[in]Ms_MatrixEdge mass matrix for the nodal aggregates
[in]M0inv_MatrixInverse of lumped nodal mass matrix (add on only)
[in]M1_MatrixEdge mass matrix for the add on
[in]NullspaceNull space (needed for periodic)
[in]CoordsNodal coordinates
[in]ListParameter list
[in]ComputePrecIf true, compute the preconditioner immediately

Definition at line 162 of file MueLu_RefMaxwell_decl.hpp.

◆ RefMaxwell() [4/8]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::RefMaxwell ( const Teuchos::RCP< Matrix > & SM_Matrix,
const Teuchos::RCP< Matrix > & D0_Matrix,
const Teuchos::RCP< Matrix > & M0inv_Matrix,
const Teuchos::RCP< Matrix > & M1_Matrix,
const Teuchos::RCP< MultiVector > & Nullspace,
const Teuchos::RCP< RealValuedMultiVector > & Coords,
Teuchos::ParameterList & List,
bool ComputePrec = true )
inline

Constructor with Jacobian (with add on)

Parameters
[in]SM_MatrixJacobian
[in]D0_MatrixDiscrete Gradient
[in]M0inv_MatrixInverse of lumped nodal mass matrix (add on only)
[in]M1_MatrixEdge mass matrix for the
[in]NullspaceNull space (needed for periodic)
[in]CoordsNodal coordinates
[in]ListParameter list
[in]ComputePrecIf true, compute the preconditioner immediately

Definition at line 187 of file MueLu_RefMaxwell_decl.hpp.

◆ RefMaxwell() [5/8]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::RefMaxwell ( const Teuchos::RCP< Matrix > & D0_Matrix,
const Teuchos::RCP< Matrix > & M0inv_Matrix,
const Teuchos::RCP< Matrix > & M1_Matrix,
const Teuchos::RCP< MultiVector > & Nullspace,
const Teuchos::RCP< RealValuedMultiVector > & Coords,
Teuchos::ParameterList & List )
inline

Constructor without Jacobian (with add on)

Parameters
[in]D0_MatrixDiscrete Gradient
[in]M0inv_MatrixInverse of lumped nodal mass matrix (add on only)
[in]M1_MatrixEdge mass matrix for the
[in]NullspaceNull space (needed for periodic)
[in]CoordsNodal coordinates
[in]ListParameter list

Definition at line 209 of file MueLu_RefMaxwell_decl.hpp.

◆ RefMaxwell() [6/8]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::RefMaxwell ( const Teuchos::RCP< Matrix > & SM_Matrix,
const Teuchos::RCP< Matrix > & D0_Matrix,
const Teuchos::RCP< Matrix > & M1_Matrix,
const Teuchos::RCP< MultiVector > & Nullspace,
const Teuchos::RCP< RealValuedMultiVector > & Coords,
Teuchos::ParameterList & List,
bool ComputePrec )
inline

Constructor with Jacobian (no add on)

Parameters
[in]SM_MatrixJacobian
[in]D0_MatrixDiscrete Gradient
[in]M1_MatrixEdge mass matrix for the
[in]NullspaceNull space (needed for periodic)
[in]CoordsNodal coordinates
[in]ListParameter list
[in]ComputePrecIf true, compute the preconditioner immediately

Definition at line 229 of file MueLu_RefMaxwell_decl.hpp.

◆ RefMaxwell() [7/8]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::RefMaxwell ( const Teuchos::RCP< Matrix > & D0_Matrix,
const Teuchos::RCP< Matrix > & M1_Matrix,
const Teuchos::RCP< MultiVector > & Nullspace,
const Teuchos::RCP< RealValuedMultiVector > & Coords,
Teuchos::ParameterList & List )
inline

Constructor without Jacobian (no add on)

Parameters
[in]D0_MatrixDiscrete Gradient
[in]M1_MatrixEdge mass matrix for the
[in]NullspaceNull space (needed for periodic)
[in]CoordsNodal coordinates
[in]ListParameter list

Definition at line 249 of file MueLu_RefMaxwell_decl.hpp.

◆ RefMaxwell() [8/8]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::RefMaxwell ( const Teuchos::RCP< Matrix > & SM_Matrix,
Teuchos::ParameterList & List,
bool ComputePrec = true )
inline

Constructor with parameter list

Parameters
[in]SM_MatrixJacobian
[in]ListParameter list
[in]ComputePrecIf true, compute the preconditioner immediately

Definition at line 264 of file MueLu_RefMaxwell_decl.hpp.

◆ ~RefMaxwell()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
virtual MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::~RefMaxwell ( )
inlinevirtual

Destructor.

Definition at line 287 of file MueLu_RefMaxwell_decl.hpp.

Member Function Documentation

◆ getDomainMap()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP< const Xpetra::Map< LocalOrdinal, GlobalOrdinal, Node > > MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getDomainMap ( ) const

Returns the Xpetra::Map object associated with the domain of this operator.

Definition at line 113 of file MueLu_RefMaxwell_def.hpp.

◆ getRangeMap()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP< const Xpetra::Map< LocalOrdinal, GlobalOrdinal, Node > > MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getRangeMap ( ) const

Returns the Xpetra::Map object associated with the range of this operator.

Definition at line 119 of file MueLu_RefMaxwell_def.hpp.

◆ getJacobian()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
const Teuchos::RCP< Matrix > & MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getJacobian ( ) const
inline

Returns Jacobian matrix SM.

Definition at line 296 of file MueLu_RefMaxwell_decl.hpp.

◆ setParameters()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setParameters ( Teuchos::ParameterList & list)

Set parameters.

Definition at line 125 of file MueLu_RefMaxwell_def.hpp.

◆ compute()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::compute ( bool reuse = false)

Setup the preconditioner.

Definition at line 228 of file MueLu_RefMaxwell_def.hpp.

◆ buildProlongator()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::buildProlongator ( )

Setup the prolongator for the (1,1)-block.

Definition at line 1163 of file MueLu_RefMaxwell_def.hpp.

◆ formCoarseMatrix()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::formCoarseMatrix ( )

Compute P11^{T}*A*P11 efficiently.

Definition at line 1956 of file MueLu_RefMaxwell_def.hpp.

◆ resetMatrix()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::resetMatrix ( Teuchos::RCP< Matrix > SM_Matrix_new,
bool ComputePrec = true )

Reset system matrix.

Definition at line 2095 of file MueLu_RefMaxwell_def.hpp.

◆ apply()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::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

Returns in Y the result of a Xpetra::Operator applied to a Xpetra::MultiVector X.

Parameters
[in]X- MultiVector of dimension NumVectors to multiply with matrix.
[out]Y- MultiVector of dimension NumVectors containing result.

Definition at line 2313 of file MueLu_RefMaxwell_def.hpp.

◆ hasTransposeApply()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
bool MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::hasTransposeApply ( ) const

Indicates whether this operator supports applying the adjoint operator.

Definition at line 2379 of file MueLu_RefMaxwell_def.hpp.

◆ describe()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::describe ( Teuchos::FancyOStream & out,
const Teuchos::EVerbosityLevel verbLevel = Teuchos::VERB_HIGH ) const

Definition at line 2475 of file MueLu_RefMaxwell_def.hpp.

◆ residual()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::residual ( const MultiVector & X,
const MultiVector & B,
MultiVector & R ) const
inline

Compute a residual R = B - (*this) * X.

Definition at line 329 of file MueLu_RefMaxwell_decl.hpp.

◆ initialize()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::initialize ( const Teuchos::RCP< Matrix > & D0_Matrix,
const Teuchos::RCP< Matrix > & Ms_Matrix,
const Teuchos::RCP< Matrix > & M0inv_Matrix,
const Teuchos::RCP< Matrix > & M1_Matrix,
const Teuchos::RCP< MultiVector > & Nullspace,
const Teuchos::RCP< RealValuedMultiVector > & Coords,
Teuchos::ParameterList & List )
private

Initialize with matrices except the Jacobian (don't compute the preconditioner)

Parameters
[in]D0_MatrixDiscrete Gradient
[in]Ms_MatrixEdge mass matrix for nodal aggregates
[in]M0inv_MatrixInverse of lumped nodal mass matrix (add on only)
[in]M1_MatrixEdge mass matrix for add on
[in]NullspaceNull space (needed for periodic)
[in]CoordsNodal coordinates
[in]ListParameter list

Definition at line 2385 of file MueLu_RefMaxwell_def.hpp.

◆ setFineLevelSmoother()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setFineLevelSmoother ( )
private

Set the fine level smoother.

Definition at line 964 of file MueLu_RefMaxwell_def.hpp.

◆ applyInverseAdditive()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::applyInverseAdditive ( const MultiVector & RHS,
MultiVector & X ) const
private

apply additive algorithm for 2x2 solve

Definition at line 2105 of file MueLu_RefMaxwell_def.hpp.

◆ solveH()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::solveH ( const MultiVector & RHS,
MultiVector & X ) const
private

apply solve to 1-1 block only

Definition at line 2242 of file MueLu_RefMaxwell_def.hpp.

◆ solve22()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::solve22 ( const MultiVector & RHS,
MultiVector & X ) const
private

apply solve to 2-2 block only

Definition at line 2276 of file MueLu_RefMaxwell_def.hpp.

◆ allocateMemory()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::allocateMemory ( int numVectors) const
private

allocate multivectors for solve

Definition at line 1036 of file MueLu_RefMaxwell_def.hpp.

◆ dump() [1/4]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::dump ( const Matrix & A,
std::string name ) const
private

dump out matrix

Definition at line 1098 of file MueLu_RefMaxwell_def.hpp.

◆ dump() [2/4]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::dump ( const MultiVector & X,
std::string name ) const
private

dump out multivector

Definition at line 1107 of file MueLu_RefMaxwell_def.hpp.

◆ dumpCoords()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::dumpCoords ( const RealValuedMultiVector & X,
std::string name ) const
private

dump out real-valued multivector

Definition at line 1116 of file MueLu_RefMaxwell_def.hpp.

◆ dump() [3/4]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::dump ( const Teuchos::ArrayRCP< bool > & v,
std::string name ) const
private

dump out boolean ArrayView

Definition at line 1125 of file MueLu_RefMaxwell_def.hpp.

◆ dump() [4/4]

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::dump ( const Kokkos::View< bool *, typename Node::device_type > & v,
std::string name ) const
private

dump out boolean Kokkos::View

Definition at line 1135 of file MueLu_RefMaxwell_def.hpp.

◆ getTimer()

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP< Teuchos::TimeMonitor > MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getTimer ( std::string name,
RCP< const Teuchos::Comm< int > > comm = Teuchos::null ) const
private

get a (synced) timer

Definition at line 1147 of file MueLu_RefMaxwell_def.hpp.

Member Data Documentation

◆ HierarchyH_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<Hierarchy> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::HierarchyH_
private

Two hierarchies: one for the coarse (1,1)-block, another for the (2,2)-block.

Definition at line 393 of file MueLu_RefMaxwell_decl.hpp.

◆ Hierarchy22_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<Hierarchy> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Hierarchy22_
private

Definition at line 393 of file MueLu_RefMaxwell_decl.hpp.

◆ PreSmoother_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<SmootherBase> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::PreSmoother_
private

Definition at line 394 of file MueLu_RefMaxwell_decl.hpp.

◆ PostSmoother_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<SmootherBase> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::PostSmoother_
private

Definition at line 394 of file MueLu_RefMaxwell_decl.hpp.

◆ PreSmootherData_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<SmootherPrototype> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::PreSmootherData_
private

Definition at line 395 of file MueLu_RefMaxwell_decl.hpp.

◆ PostSmootherData_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<SmootherPrototype> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::PostSmootherData_
private

Definition at line 395 of file MueLu_RefMaxwell_decl.hpp.

◆ thyraPrecOpH_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
RCP<Operator> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::thyraPrecOpH_
private

Definition at line 396 of file MueLu_RefMaxwell_decl.hpp.

◆ thyraPrecOp22_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
RCP<Operator> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::thyraPrecOp22_
private

Definition at line 396 of file MueLu_RefMaxwell_decl.hpp.

◆ SM_Matrix_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<Matrix> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::SM_Matrix_
private

Various matrices.

Definition at line 398 of file MueLu_RefMaxwell_decl.hpp.

◆ D0_Matrix_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<Matrix> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::D0_Matrix_
private

Definition at line 398 of file MueLu_RefMaxwell_decl.hpp.

◆ D0_T_Matrix_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<Matrix> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::D0_T_Matrix_
private

Definition at line 398 of file MueLu_RefMaxwell_decl.hpp.

◆ M0inv_Matrix_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<Matrix> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::M0inv_Matrix_
private

Definition at line 398 of file MueLu_RefMaxwell_decl.hpp.

◆ M1_Matrix_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<Matrix> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::M1_Matrix_
private

Definition at line 398 of file MueLu_RefMaxwell_decl.hpp.

◆ Ms_Matrix_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<Matrix> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Ms_Matrix_
private

Definition at line 398 of file MueLu_RefMaxwell_decl.hpp.

◆ A_nodal_Matrix_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<Matrix> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::A_nodal_Matrix_
private

Definition at line 399 of file MueLu_RefMaxwell_decl.hpp.

◆ P11_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<Matrix> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::P11_
private

Definition at line 399 of file MueLu_RefMaxwell_decl.hpp.

◆ R11_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<Matrix> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::R11_
private

Definition at line 399 of file MueLu_RefMaxwell_decl.hpp.

◆ AH_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<Matrix> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::AH_
private

Definition at line 399 of file MueLu_RefMaxwell_decl.hpp.

◆ A22_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<Matrix> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::A22_
private

Definition at line 399 of file MueLu_RefMaxwell_decl.hpp.

◆ Addon_Matrix_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<Matrix> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Addon_Matrix_
private

Definition at line 399 of file MueLu_RefMaxwell_decl.hpp.

◆ D0origDomainMap_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<const Map> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::D0origDomainMap_
private

Definition at line 400 of file MueLu_RefMaxwell_decl.hpp.

◆ D0origImporter_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<const Import> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::D0origImporter_
private

Definition at line 401 of file MueLu_RefMaxwell_decl.hpp.

◆ BCrowsKokkos_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Kokkos::View<bool*, typename Node::device_type> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::BCrowsKokkos_
private

Vectors for BCs.

Definition at line 403 of file MueLu_RefMaxwell_decl.hpp.

◆ BCcolsKokkos_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Kokkos::View<bool*, typename Node::device_type> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::BCcolsKokkos_
private

Definition at line 403 of file MueLu_RefMaxwell_decl.hpp.

◆ BCdomainKokkos_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Kokkos::View<bool*, typename Node::device_type> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::BCdomainKokkos_
private

Definition at line 403 of file MueLu_RefMaxwell_decl.hpp.

◆ BCedges_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
int MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::BCedges_
private

Definition at line 404 of file MueLu_RefMaxwell_decl.hpp.

◆ BCnodes_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
int MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::BCnodes_
private

Definition at line 404 of file MueLu_RefMaxwell_decl.hpp.

◆ BCrows_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::ArrayRCP<bool> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::BCrows_
private

Definition at line 405 of file MueLu_RefMaxwell_decl.hpp.

◆ BCcols_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::ArrayRCP<bool> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::BCcols_
private

Definition at line 405 of file MueLu_RefMaxwell_decl.hpp.

◆ BCdomain_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::ArrayRCP<bool> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::BCdomain_
private

Definition at line 405 of file MueLu_RefMaxwell_decl.hpp.

◆ Nullspace_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<MultiVector> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Nullspace_
private

Nullspace.

Definition at line 407 of file MueLu_RefMaxwell_decl.hpp.

◆ Coords_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<RealValuedMultiVector> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Coords_
private

Coordinates.

Definition at line 409 of file MueLu_RefMaxwell_decl.hpp.

◆ CoordsH_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<RealValuedMultiVector> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::CoordsH_
private

Definition at line 409 of file MueLu_RefMaxwell_decl.hpp.

◆ NullspaceH_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<MultiVector> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::NullspaceH_
private

Nullspace for (1,1) problem.

Definition at line 411 of file MueLu_RefMaxwell_decl.hpp.

◆ ImporterH_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<const Import> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::ImporterH_
private

Importer to coarse (1,1) hierarchy.

Definition at line 413 of file MueLu_RefMaxwell_decl.hpp.

◆ Importer22_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<const Import> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Importer22_
private

Definition at line 413 of file MueLu_RefMaxwell_decl.hpp.

◆ D0_T_R11_colMapsMatch_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
bool MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::D0_T_R11_colMapsMatch_
private

Definition at line 414 of file MueLu_RefMaxwell_decl.hpp.

◆ allEdgesBoundary_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
bool MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::allEdgesBoundary_
private

Definition at line 415 of file MueLu_RefMaxwell_decl.hpp.

◆ allNodesBoundary_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
bool MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::allNodesBoundary_
private

Definition at line 415 of file MueLu_RefMaxwell_decl.hpp.

◆ parameterList_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::ParameterList MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::parameterList_
private

Parameter lists.

Definition at line 417 of file MueLu_RefMaxwell_decl.hpp.

◆ precList11_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::ParameterList MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::precList11_
private

Definition at line 417 of file MueLu_RefMaxwell_decl.hpp.

◆ precList22_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::ParameterList MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::precList22_
private

Definition at line 417 of file MueLu_RefMaxwell_decl.hpp.

◆ smootherList_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::ParameterList MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::smootherList_
private

Definition at line 417 of file MueLu_RefMaxwell_decl.hpp.

◆ AH_AP_reuse_data_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<Teuchos::ParameterList> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::AH_AP_reuse_data_
private

Definition at line 418 of file MueLu_RefMaxwell_decl.hpp.

◆ AH_RAP_reuse_data_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<Teuchos::ParameterList> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::AH_RAP_reuse_data_
private

Definition at line 418 of file MueLu_RefMaxwell_decl.hpp.

◆ A22_AP_reuse_data_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<Teuchos::ParameterList> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::A22_AP_reuse_data_
private

Definition at line 419 of file MueLu_RefMaxwell_decl.hpp.

◆ A22_RAP_reuse_data_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<Teuchos::ParameterList> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::A22_RAP_reuse_data_
private

Definition at line 419 of file MueLu_RefMaxwell_decl.hpp.

◆ disable_addon_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
bool MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::disable_addon_
private

Some options.

Definition at line 421 of file MueLu_RefMaxwell_decl.hpp.

◆ dump_matrices_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
bool MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::dump_matrices_
private

Definition at line 421 of file MueLu_RefMaxwell_decl.hpp.

◆ useKokkos_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
bool MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::useKokkos_
private

Definition at line 421 of file MueLu_RefMaxwell_decl.hpp.

◆ use_as_preconditioner_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
bool MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::use_as_preconditioner_
private

Definition at line 421 of file MueLu_RefMaxwell_decl.hpp.

◆ implicitTranspose_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
bool MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::implicitTranspose_
private

Definition at line 421 of file MueLu_RefMaxwell_decl.hpp.

◆ fuseProlongationAndUpdate_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
bool MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::fuseProlongationAndUpdate_
private

Definition at line 421 of file MueLu_RefMaxwell_decl.hpp.

◆ syncTimers_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
bool MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::syncTimers_
private

Definition at line 421 of file MueLu_RefMaxwell_decl.hpp.

◆ enable_reuse_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
bool MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::enable_reuse_
private

Definition at line 421 of file MueLu_RefMaxwell_decl.hpp.

◆ skipFirstLevel_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
bool MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::skipFirstLevel_
private

Definition at line 421 of file MueLu_RefMaxwell_decl.hpp.

◆ applyBCsToAnodal_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
bool MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::applyBCsToAnodal_
private

Definition at line 422 of file MueLu_RefMaxwell_decl.hpp.

◆ applyBCsToH_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
bool MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::applyBCsToH_
private

Definition at line 422 of file MueLu_RefMaxwell_decl.hpp.

◆ applyBCsTo22_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
bool MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::applyBCsTo22_
private

Definition at line 422 of file MueLu_RefMaxwell_decl.hpp.

◆ numItersH_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
int MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::numItersH_
private

Definition at line 423 of file MueLu_RefMaxwell_decl.hpp.

◆ numIters22_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
int MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::numIters22_
private

Definition at line 423 of file MueLu_RefMaxwell_decl.hpp.

◆ mode_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
std::string MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::mode_
private

Definition at line 424 of file MueLu_RefMaxwell_decl.hpp.

◆ P11res_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<MultiVector> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::P11res_
mutableprivate

Temporary memory.

Definition at line 426 of file MueLu_RefMaxwell_decl.hpp.

◆ P11x_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<MultiVector> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::P11x_
private

Definition at line 426 of file MueLu_RefMaxwell_decl.hpp.

◆ P11resSubComm_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<MultiVector> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::P11resSubComm_
private

Definition at line 426 of file MueLu_RefMaxwell_decl.hpp.

◆ P11xSubComm_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<MultiVector> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::P11xSubComm_
private

Definition at line 426 of file MueLu_RefMaxwell_decl.hpp.

◆ D0res_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<MultiVector> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::D0res_
private

Definition at line 426 of file MueLu_RefMaxwell_decl.hpp.

◆ D0x_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<MultiVector> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::D0x_
private

Definition at line 426 of file MueLu_RefMaxwell_decl.hpp.

◆ D0resSubComm_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<MultiVector> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::D0resSubComm_
private

Definition at line 426 of file MueLu_RefMaxwell_decl.hpp.

◆ D0xSubComm_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<MultiVector> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::D0xSubComm_
private

Definition at line 426 of file MueLu_RefMaxwell_decl.hpp.

◆ residual_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<MultiVector> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::residual_
private

Definition at line 426 of file MueLu_RefMaxwell_decl.hpp.

◆ P11resTmp_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<MultiVector> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::P11resTmp_
private

Definition at line 426 of file MueLu_RefMaxwell_decl.hpp.

◆ D0resTmp_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<MultiVector> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::D0resTmp_
private

Definition at line 426 of file MueLu_RefMaxwell_decl.hpp.

◆ D0TR11Tmp_

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::RCP<MultiVector> MueLu::RefMaxwell< Scalar, LocalOrdinal, GlobalOrdinal, Node >::D0TR11Tmp_
private

Definition at line 426 of file MueLu_RefMaxwell_decl.hpp.


The documentation for this class was generated from the following files: