MueLu  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
MueLu::Maxwell_Utils< Scalar, LocalOrdinal, GlobalOrdinal, Node > Class Template Reference

Utility functions for Maxwell. More...

#include <MueLu_Maxwell_Utils_decl.hpp>

Inheritance diagram for MueLu::Maxwell_Utils< Scalar, LocalOrdinal, GlobalOrdinal, Node >:
MueLu::VerboseObject Teuchos::VerboseObject< VerboseObject > Teuchos::VerboseObjectBase

Public Types

typedef Teuchos::ScalarTraits
< Scalar >::magnitudeType 
magnitudeType
 

Static Public Member Functions

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. More...
 
static void detectBoundaryConditionsSM (RCP< Matrix > &SM_Matrix, RCP< Matrix > &D0_Matrix, magnitudeType rowSumTol, 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, bool &allEdgesBoundary, bool &allNodesBoundary)
 Detect Dirichlet boundary conditions. More...
 
static RCP< Matrix > removeExplicitZeros (const RCP< Matrix > &A, const magnitudeType tolerance, const bool keepDiagonal=true, const size_t expectedNNZperRow=0)
 Remove explicit zeros. More...
 
static void removeExplicitZeros (Teuchos::ParameterList &parameterList, RCP< Matrix > &D0_Matrix, RCP< Matrix > &SM_Matrix, RCP< Matrix > &M1_Matrix, RCP< Matrix > &Ms_Matrix)
 
static void removeExplicitZeros (Teuchos::ParameterList &parameterList, RCP< Matrix > &D0_Matrix, RCP< Matrix > &SM_Matrix)
 
static void thresholdedAbs (const RCP< Matrix > &A, const magnitudeType thresholded)
 
static void setMatvecParams (Matrix &A, RCP< ParameterList > matvecParams)
 Sets matvec params on a matrix. More...
 
static RCP< Xpetra::Matrix
< Scalar, LocalOrdinal,
GlobalOrdinal, Node > > 
PtAPWrapper (const RCP< Matrix > &A, const RCP< Matrix > &P, Teuchos::ParameterList &params, std::string &label)
 Performs an P^T AP. More...
 
- Static Public Member Functions inherited from MueLu::VerboseObject
static void SetMueLuOStream (const Teuchos::RCP< Teuchos::FancyOStream > &mueluOStream)
 
static void SetMueLuOFileStream (const std::string &filename)
 
static Teuchos::RCP
< Teuchos::FancyOStream
GetMueLuOStream ()
 
static void SetDefaultVerbLevel (const VerbLevel defaultVerbLevel)
 Set the default (global) verbosity level. More...
 
static VerbLevel GetDefaultVerbLevel ()
 Get the default (global) verbosity level. More...
 
- Static Public Member Functions inherited from Teuchos::VerboseObject< VerboseObject >
static void setDefaultVerbLevel (const EVerbosityLevel defaultVerbLevel)
 
static EVerbosityLevel getDefaultVerbLevel ()
 
- Static Public Member Functions inherited from Teuchos::VerboseObjectBase
static void setDefaultOStream (const RCP< FancyOStream > &defaultOStream)
 
static RCP< FancyOStreamgetDefaultOStream ()
 

Additional Inherited Members

- Public Member Functions inherited from MueLu::VerboseObject
VerbLevel GetVerbLevel () const
 Get the verbosity level. More...
 
void SetVerbLevel (const VerbLevel verbLevel)
 Set the verbosity level of this object. More...
 
int GetProcRankVerbose () const
 Get proc rank used for printing. Do not use this information for any other purpose. More...
 
int SetProcRankVerbose (int procRank) const
 Set proc rank used for printing. More...
 
bool IsPrint (MsgType type, int thisProcRankOnly=-1) const
 Find out whether we need to print out information for a specific message type. More...
 
Teuchos::FancyOStreamGetOStream (MsgType type, int thisProcRankOnly=0) const
 Get an output stream for outputting the input message type. More...
 
Teuchos::FancyOStreamGetBlackHole () const
 
 VerboseObject ()
 
virtual ~VerboseObject ()
 Destructor. More...
 
- Public Member Functions inherited from Teuchos::VerboseObject< VerboseObject >
 VerboseObject (const EVerbosityLevel verbLevel=VERB_DEFAULT, const RCP< FancyOStream > &oStream=Teuchos::null)
 
virtual const VerboseObjectsetVerbLevel (const EVerbosityLevel verbLevel) const
 
virtual const VerboseObjectsetOverridingVerbLevel (const EVerbosityLevel verbLevel) const
 
virtual EVerbosityLevel getVerbLevel () const
 
TEUCHOSPARAMETERLIST_LIB_DLL_EXPORT
RCP< const ParameterList
getValidVerboseObjectSublist ()
 
TEUCHOSPARAMETERLIST_LIB_DLL_EXPORT
void 
setupVerboseObjectSublist (ParameterList *paramList)
 
TEUCHOSPARAMETERLIST_LIB_DLL_EXPORT
void 
readVerboseObjectSublist (ParameterList *paramList, RCP< FancyOStream > *oStream, EVerbosityLevel *verbLevel)
 
void readVerboseObjectSublist (ParameterList *paramList, VerboseObject< ObjectType > *verboseObject)
 
- Public Member Functions inherited from Teuchos::VerboseObjectBase
virtual ~VerboseObjectBase ()
 
 VerboseObjectBase (const RCP< FancyOStream > &oStream=Teuchos::null)
 
virtual const VerboseObjectBasesetOStream (const RCP< FancyOStream > &oStream) const
 
virtual const VerboseObjectBasesetOverridingOStream (const RCP< FancyOStream > &oStream) const
 
virtual VerboseObjectBasesetLinePrefix (const std::string &linePrefix)
 
virtual RCP< FancyOStreamgetOStream () const
 
virtual RCP< FancyOStreamgetOverridingOStream () const
 
virtual std::string getLinePrefix () const
 
virtual OSTab getOSTab (const int tabs=1, const std::string &linePrefix="") const
 
- Protected Member Functions inherited from Teuchos::VerboseObject< VerboseObject >
void initializeVerboseObject (const EVerbosityLevel verbLevel=VERB_DEFAULT, const RCP< FancyOStream > &oStream=Teuchos::null)
 
- Protected Member Functions inherited from Teuchos::VerboseObjectBase
void initializeVerboseObjectBase (const RCP< FancyOStream > &oStream=Teuchos::null)
 
virtual void informUpdatedVerbosityState () const
 

Detailed Description

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

Utility functions for Maxwell.

Definition at line 72 of file MueLu_Maxwell_Utils_decl.hpp.

Member Typedef Documentation

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

Definition at line 77 of file MueLu_Maxwell_Utils_decl.hpp.

Member Function Documentation

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

Detect Dirichlet boundary conditions.

Definition at line 67 of file MueLu_Maxwell_Utils_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::Maxwell_Utils< Scalar, LocalOrdinal, GlobalOrdinal, Node >::detectBoundaryConditionsSM ( RCP< Matrix > &  SM_Matrix,
RCP< Matrix > &  D0_Matrix,
magnitudeType  rowSumTol,
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,
bool &  allEdgesBoundary,
bool &  allNodesBoundary 
)
static

Detect Dirichlet boundary conditions.

Definition at line 138 of file MueLu_Maxwell_Utils_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > MueLu::Maxwell_Utils< Scalar, LocalOrdinal, GlobalOrdinal, Node >::removeExplicitZeros ( const RCP< Matrix > &  A,
const magnitudeType  tolerance,
const bool  keepDiagonal = true,
const size_t  expectedNNZperRow = 0 
)
static

Remove explicit zeros.

Definition at line 190 of file MueLu_Maxwell_Utils_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::Maxwell_Utils< Scalar, LocalOrdinal, GlobalOrdinal, Node >::removeExplicitZeros ( Teuchos::ParameterList parameterList,
RCP< Matrix > &  D0_Matrix,
RCP< Matrix > &  SM_Matrix,
RCP< Matrix > &  M1_Matrix,
RCP< Matrix > &  Ms_Matrix 
)
static

Definition at line 206 of file MueLu_Maxwell_Utils_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
static void MueLu::Maxwell_Utils< Scalar, LocalOrdinal, GlobalOrdinal, Node >::removeExplicitZeros ( Teuchos::ParameterList parameterList,
RCP< Matrix > &  D0_Matrix,
RCP< Matrix > &  SM_Matrix 
)
inlinestatic

Definition at line 121 of file MueLu_Maxwell_Utils_decl.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::Maxwell_Utils< Scalar, LocalOrdinal, GlobalOrdinal, Node >::thresholdedAbs ( const RCP< Matrix > &  A,
const magnitudeType  thresholded 
)
static

Definition at line 253 of file MueLu_Maxwell_Utils_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::Maxwell_Utils< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setMatvecParams ( Matrix &  A,
RCP< ParameterList matvecParams 
)
static

Sets matvec params on a matrix.

Definition at line 279 of file MueLu_Maxwell_Utils_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > MueLu::Maxwell_Utils< Scalar, LocalOrdinal, GlobalOrdinal, Node >::PtAPWrapper ( const RCP< Matrix > &  A,
const RCP< Matrix > &  P,
Teuchos::ParameterList params,
std::string &  label 
)
static

Performs an P^T AP.

Definition at line 291 of file MueLu_Maxwell_Utils_def.hpp.


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