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

Shifted Laplacian Helmholtz solver. More...

#include <MueLu_ShiftedLaplacian_decl.hpp>

Inheritance diagram for MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >:
MueLu::BaseClass MueLu::VerboseObject MueLu::Describable Teuchos::VerboseObject< VerboseObject > Teuchos::Describable Teuchos::VerboseObjectBase Teuchos::LabeledObject

Public Member Functions

 ShiftedLaplacian ()
 Constructors. More...
 
virtual ~ShiftedLaplacian ()
 
void setParameters (Teuchos::RCP< Teuchos::ParameterList > paramList)
 
void setProblemMatrix (RCP< Matrix > &A)
 
void setProblemMatrix (RCP< Tpetra::CrsMatrix< SC, LO, GO, NO > > &TpetraA)
 
void setPreconditioningMatrix (RCP< Matrix > &P)
 
void setPreconditioningMatrix (RCP< Tpetra::CrsMatrix< SC, LO, GO, NO > > &TpetraP)
 
void setstiff (RCP< Matrix > &K)
 
void setstiff (RCP< Tpetra::CrsMatrix< SC, LO, GO, NO > > &TpetraK)
 
void setmass (RCP< Matrix > &M)
 
void setmass (RCP< Tpetra::CrsMatrix< SC, LO, GO, NO > > &TpetraM)
 
void setcoords (RCP< MultiVector > &Coords)
 
void setNullSpace (RCP< MultiVector > NullSpace)
 
void setLevelShifts (std::vector< Scalar > levelshifts)
 
void initialize ()
 
void setupFastRAP ()
 
void setupSlowRAP ()
 
void setupNormalRAP ()
 
void setupSolver ()
 
void resetLinearProblem ()
 
int solve (const RCP< TMV > B, RCP< TMV > &X)
 
void multigrid_apply (const RCP< MultiVector > B, RCP< MultiVector > &X)
 
void multigrid_apply (const RCP< Tpetra::MultiVector< SC, LO, GO, NO > > B, RCP< Tpetra::MultiVector< SC, LO, GO, NO > > &X)
 
int GetIterations ()
 
Teuchos::ScalarTraits< Scalar >
::magnitudeType 
GetResidual ()
 
- Public Member Functions inherited from MueLu::BaseClass
virtual ~BaseClass ()
 Destructor. More...
 
- 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
 
- Public Member Functions inherited from MueLu::Describable
virtual ~Describable ()
 Destructor. More...
 
virtual std::string ShortClassName () const
 Return the class name of the object, without template parameters and without namespace. More...
 
virtual void describe (Teuchos::FancyOStream &out_arg, const VerbLevel verbLevel=Default) const
 
virtual std::string description () const
 Return a simple one-line description of this object. More...
 
void describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default) const
 Print the object with some verbosity level to an FancyOStream object. More...
 
- Public Member Functions inherited from Teuchos::Describable
void describe (std::ostream &out, const EVerbosityLevel verbLevel=verbLevel_default) const
 
 LabeledObject ()
 
virtual ~LabeledObject ()
 
virtual void setObjectLabel (const std::string &objectLabel)
 
virtual std::string getObjectLabel () const
 
DescribableStreamManipulatorState describe (const Describable &describable, const EVerbosityLevel verbLevel=Describable::verbLevel_default)
 
std::ostream & operator<< (std::ostream &os, const DescribableStreamManipulatorState &d)
 

Public Attributes

RCP< FactoryManagerManager_
 

Private Types

typedef Tpetra::Vector< SC, LO,
GO, NO > 
TVEC
 
typedef Tpetra::MultiVector
< SC, LO, GO, NO > 
TMV
 
typedef Tpetra::Operator< SC,
LO, GO, NO > 
OP
 

Private Attributes

int numPDEs_
 
std::string Smoother_
 
std::string Aggregation_
 
std::string Nullspace_
 
int numLevels_
 
int coarseGridSize_
 
double omega_
 
std::vector< SC > levelshifts_
 
int iters_
 
int blksize_
 
double tol_
 
int nsweeps_
 
int ncycles_
 
int cycles_
 
int subiters_
 
int option_
 
int nproblems_
 
int solverType_
 
int restart_size_
 
int recycle_size_
 
int smoother_sweeps_
 
Scalar smoother_damping_
 
int krylov_type_
 
int krylov_iterations_
 
int krylov_preconditioner_
 
double ilu_leveloffill_
 
double ilu_abs_thresh_
 
double ilu_rel_thresh_
 
double ilu_diagpivotthresh_
 
double ilu_drop_tol_
 
double ilu_fill_tol_
 
double ilu_relax_val_
 
std::string ilu_rowperm_
 
std::string ilu_colperm_
 
std::string ilu_drop_rule_
 
std::string ilu_normtype_
 
std::string ilu_milutype_
 
int schwarz_overlap_
 
bool schwarz_usereorder_
 
Tpetra::CombineMode schwarz_combinemode_
 
std::string schwarz_ordermethod_
 
bool GridTransfersExist_
 
bool isSymmetric_
 
RCP< Matrix > K_
 
RCP< Matrix > M_
 
RCP< Matrix > A_
 
RCP< Matrix > P_
 
RCP< MultiVector > Coords_
 
RCP< MultiVector > NullSpace_
 
RCP< HierarchyHierarchy_
 
RCP< TentativePFactoryTentPfact_
 
RCP< PFactoryPfact_
 
RCP< PgPFactoryPgPfact_
 
RCP< TransPFactoryTransPfact_
 
RCP< GenericRFactoryRfact_
 
RCP< RAPFactoryAcfact_
 
RCP< RAPShiftFactoryAcshift_
 
RCP< AmalgamationFactoryAmalgfact_
 
RCP< CoalesceDropFactoryDropfact_
 
RCP< CoupledAggregationFactoryAggfact_
 
RCP< UncoupledAggregationFactoryUCaggfact_
 
RCP< CoarseMapFactoryCoarseMapfact_
 
RCP< SmootherPrototypesmooProto_
 
RCP< SmootherPrototypecoarsestSmooProto_
 
RCP< SmootherFactorysmooFact_
 
RCP< SmootherFactorycoarsestSmooFact_
 
Teuchos::ParameterList coarsestSmooList_
 
std::string precType_
 
Teuchos::ParameterList precList_
 
RCP
< MueLu::ShiftedLaplacianOperator
< SC, LO, GO, NO > > 
MueLuOp_
 
RCP< Tpetra::CrsMatrix< SC, LO,
GO, NO > > 
TpetraA_
 

Additional Inherited Members

- 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 ()
 
- Static Public Attributes inherited from Teuchos::Describable
static const EVerbosityLevel verbLevel_default
 
- 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 = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
class MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >

Shifted Laplacian Helmholtz solver.

This class provides a black box solver for indefinite Helmholtz problems. An AMG-Shifted Laplacian is used as a preconditioner for Krylov iterative solvers in Belos.

Definition at line 108 of file MueLu_ShiftedLaplacian_decl.hpp.

Member Typedef Documentation

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
typedef Tpetra::Vector<SC,LO,GO,NO> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TVEC
private

Definition at line 112 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
typedef Tpetra::MultiVector<SC,LO,GO,NO> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TMV
private

Definition at line 113 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
typedef Tpetra::Operator<SC,LO,GO,NO> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::OP
private

Definition at line 114 of file MueLu_ShiftedLaplacian_decl.hpp.

Constructor & Destructor Documentation

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::ShiftedLaplacian ( )
inline

Constructors.

Definition at line 129 of file MueLu_ShiftedLaplacian_decl.hpp.

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

Definition at line 80 of file MueLu_ShiftedLaplacian_def.hpp.

Member Function Documentation

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setParameters ( Teuchos::RCP< Teuchos::ParameterList paramList)

Definition at line 84 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setProblemMatrix ( RCP< Matrix > &  A)

Definition at line 125 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setProblemMatrix ( RCP< Tpetra::CrsMatrix< SC, LO, GO, NO > > &  TpetraA)

Definition at line 140 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setPreconditioningMatrix ( RCP< Matrix > &  P)

Definition at line 151 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setPreconditioningMatrix ( RCP< Tpetra::CrsMatrix< SC, LO, GO, NO > > &  TpetraP)

Definition at line 159 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setstiff ( RCP< Matrix > &  K)

Definition at line 169 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setstiff ( RCP< Tpetra::CrsMatrix< SC, LO, GO, NO > > &  TpetraK)

Definition at line 176 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setmass ( RCP< Matrix > &  M)

Definition at line 185 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setmass ( RCP< Tpetra::CrsMatrix< SC, LO, GO, NO > > &  TpetraM)

Definition at line 192 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setcoords ( RCP< MultiVector > &  Coords)

Definition at line 201 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setNullSpace ( RCP< MultiVector >  NullSpace)

Definition at line 208 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setLevelShifts ( std::vector< Scalar levelshifts)

Definition at line 215 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::initialize ( )

Definition at line 224 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setupFastRAP ( )

Definition at line 414 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setupSlowRAP ( )

Definition at line 427 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setupNormalRAP ( )

Definition at line 446 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::setupSolver ( )

Definition at line 464 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::resetLinearProblem ( )

Definition at line 490 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::solve ( const RCP< TMV B,
RCP< TMV > &  X 
)

Definition at line 501 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::multigrid_apply ( const RCP< MultiVector >  B,
RCP< MultiVector > &  X 
)

Definition at line 516 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
void MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::multigrid_apply ( const RCP< Tpetra::MultiVector< SC, LO, GO, NO > >  B,
RCP< Tpetra::MultiVector< SC, LO, GO, NO > > &  X 
)

Definition at line 525 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::GetIterations ( )

Definition at line 538 of file MueLu_ShiftedLaplacian_def.hpp.

template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node >
Teuchos::ScalarTraits< Scalar >::magnitudeType MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::GetResidual ( )

Definition at line 552 of file MueLu_ShiftedLaplacian_def.hpp.

Member Data Documentation

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<FactoryManager> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Manager_

Definition at line 223 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::numPDEs_
private

Definition at line 229 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
std::string MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Smoother_
private

Definition at line 234 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
std::string MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Aggregation_
private

Definition at line 234 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
std::string MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Nullspace_
private

Definition at line 234 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::numLevels_
private

Definition at line 235 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::coarseGridSize_
private

Definition at line 235 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
double MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::omega_
private

Definition at line 238 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
std::vector<SC> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::levelshifts_
private

Definition at line 239 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::iters_
private

Definition at line 244 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::blksize_
private

Definition at line 244 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
double MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::tol_
private

Definition at line 245 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::nsweeps_
private

Definition at line 246 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::ncycles_
private

Definition at line 246 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::cycles_
private

Definition at line 247 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::subiters_
private

Definition at line 247 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::option_
private

Definition at line 247 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::nproblems_
private

Definition at line 247 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::solverType_
private

Definition at line 247 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::restart_size_
private

Definition at line 248 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::recycle_size_
private

Definition at line 248 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::smoother_sweeps_
private

Definition at line 251 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
Scalar MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::smoother_damping_
private

Definition at line 252 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::krylov_type_
private

Definition at line 253 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::krylov_iterations_
private

Definition at line 254 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::krylov_preconditioner_
private

Definition at line 255 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
double MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::ilu_leveloffill_
private

Definition at line 256 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
double MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::ilu_abs_thresh_
private

Definition at line 256 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
double MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::ilu_rel_thresh_
private

Definition at line 256 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
double MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::ilu_diagpivotthresh_
private

Definition at line 256 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
double MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::ilu_drop_tol_
private

Definition at line 257 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
double MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::ilu_fill_tol_
private

Definition at line 257 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
double MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::ilu_relax_val_
private

Definition at line 257 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
std::string MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::ilu_rowperm_
private

Definition at line 258 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
std::string MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::ilu_colperm_
private

Definition at line 258 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
std::string MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::ilu_drop_rule_
private

Definition at line 258 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
std::string MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::ilu_normtype_
private

Definition at line 258 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
std::string MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::ilu_milutype_
private

Definition at line 258 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
int MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::schwarz_overlap_
private

Definition at line 259 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
bool MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::schwarz_usereorder_
private

Definition at line 260 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
Tpetra::CombineMode MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::schwarz_combinemode_
private

Definition at line 261 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
std::string MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::schwarz_ordermethod_
private

Definition at line 262 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
bool MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::GridTransfersExist_
private

Definition at line 265 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
bool MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::isSymmetric_
private

Definition at line 266 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<Matrix> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::K_
private

Definition at line 273 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<Matrix> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::M_
private

Definition at line 273 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<Matrix> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::A_
private

Definition at line 273 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<Matrix> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::P_
private

Definition at line 273 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<MultiVector> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Coords_
private

Definition at line 274 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<MultiVector> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::NullSpace_
private

Definition at line 274 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<Hierarchy> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Hierarchy_
private

Definition at line 277 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<TentativePFactory> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TentPfact_
private

Definition at line 280 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<PFactory> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Pfact_
private

Definition at line 281 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<PgPFactory> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::PgPfact_
private

Definition at line 282 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<TransPFactory> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TransPfact_
private

Definition at line 283 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<GenericRFactory> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Rfact_
private

Definition at line 284 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<RAPFactory> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Acfact_
private

Definition at line 285 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<RAPShiftFactory> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Acshift_
private

Definition at line 286 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<AmalgamationFactory> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Amalgfact_
private

Definition at line 287 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<CoalesceDropFactory> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Dropfact_
private

Definition at line 288 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<CoupledAggregationFactory> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Aggfact_
private

Definition at line 289 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<UncoupledAggregationFactory> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::UCaggfact_
private

Definition at line 290 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<CoarseMapFactory> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::CoarseMapfact_
private

Definition at line 291 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<SmootherPrototype> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::smooProto_
private

Definition at line 292 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<SmootherPrototype> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::coarsestSmooProto_
private

Definition at line 292 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<SmootherFactory> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::smooFact_
private

Definition at line 293 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP<SmootherFactory> MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::coarsestSmooFact_
private

Definition at line 293 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
Teuchos::ParameterList MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::coarsestSmooList_
private

Definition at line 294 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
std::string MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::precType_
private

Definition at line 295 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
Teuchos::ParameterList MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::precList_
private

Definition at line 296 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP< MueLu::ShiftedLaplacianOperator<SC,LO,GO,NO> > MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::MueLuOp_
private

Definition at line 299 of file MueLu_ShiftedLaplacian_decl.hpp.

template<class Scalar = DefaultScalar, class LocalOrdinal = DefaultLocalOrdinal, class GlobalOrdinal = DefaultGlobalOrdinal, class Node = DefaultNode>
RCP< Tpetra::CrsMatrix<SC,LO,GO,NO> > MueLu::ShiftedLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraA_
private

Definition at line 300 of file MueLu_ShiftedLaplacian_decl.hpp.


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