Anasazi Version of the Day
Loading...
Searching...
No Matches
List of all members
Anasazi::Experimental::TraceMinDavidsonSolMgr< ScalarType, MV, OP > Class Template Reference

The Anasazi::TraceMinDavidsonSolMgr provides a flexible solver manager over the TraceMinDavidson eigensolver. More...

#include <AnasaziTraceMinDavidsonSolMgr.hpp>

Inheritance diagram for Anasazi::Experimental::TraceMinDavidsonSolMgr< ScalarType, MV, OP >:
Anasazi::Experimental::TraceMinBaseSolMgr< ScalarType, MV, OP > Anasazi::SolverManager< ScalarType, MV, OP >

Constructors

 TraceMinDavidsonSolMgr (const Teuchos::RCP< Eigenproblem< ScalarType, MV, OP > > &problem, Teuchos::ParameterList &pl)
 Basic constructor for TraceMinDavidsonSolMgr.
 

Additional Inherited Members

- Public Member Functions inherited from Anasazi::Experimental::TraceMinBaseSolMgr< ScalarType, MV, OP >
 TraceMinBaseSolMgr (const RCP< Eigenproblem< ScalarType, MV, OP > > &problem, Teuchos::ParameterList &pl)
 Basic constructor for TraceMinBaseSolMgr.
 
virtual ~TraceMinBaseSolMgr ()
 Destructor.
 
const Eigenproblem< ScalarType, MV, OP > & getProblem () const
 Return the eigenvalue problem.
 
int getNumIters () const
 Get the iteration count for the most recent call to solve().
 
Teuchos::Array< RCP< Teuchos::Time > > getTimers () const
 Return the timers for this object.
 
ReturnType solve ()
 This method performs possibly repeated calls to the underlying eigensolver's iterate() routine until the problem has been solved (as decided by the solver manager) or the solver manager decides to quit.
 
void setGlobalStatusTest (const RCP< StatusTest< ScalarType, MV, OP > > &global)
 Set the status test defining global convergence.
 
const RCP< StatusTest< ScalarType, MV, OP > > & getGlobalStatusTest () const
 Get the status test defining global convergence.
 
void setLockingStatusTest (const RCP< StatusTest< ScalarType, MV, OP > > &locking)
 Set the status test defining locking.
 
const RCP< StatusTest< ScalarType, MV, OP > > & getLockingStatusTest () const
 Get the status test defining locking.
 
void setDebugStatusTest (const RCP< StatusTest< ScalarType, MV, OP > > &debug)
 Set the status test for debugging.
 
const RCP< StatusTest< ScalarType, MV, OP > > & getDebugStatusTest () const
 Get the status test for debugging.
 
- Public Member Functions inherited from Anasazi::SolverManager< ScalarType, MV, OP >
 SolverManager ()
 Empty constructor.
 
virtual ~SolverManager ()
 Destructor.
 
- Protected Member Functions inherited from Anasazi::Experimental::TraceMinBaseSolMgr< ScalarType, MV, OP >
void copyPartOfState (const TraceMinBaseState< ScalarType, MV > &oldState, TraceMinBaseState< ScalarType, MV > &newState, const std::vector< int > indToCopy) const
 
void setParameters (Teuchos::ParameterList &pl) const
 
void printParameters (std::ostream &os) const
 
virtual RCP< TraceMinBase< ScalarType, MV, OP > > createSolver (const RCP< SortManager< typename Teuchos::ScalarTraits< ScalarType >::magnitudeType > > &sorter, const RCP< StatusTest< ScalarType, MV, OP > > &outputtest, const RCP< MatOrthoManager< ScalarType, MV, OP > > &ortho, Teuchos::ParameterList &plist)=0
 
virtual bool needToRestart (const RCP< TraceMinBase< ScalarType, MV, OP > > solver)=0
 
virtual bool performRestart (int &numRestarts, RCP< TraceMinBase< ScalarType, MV, OP > > solver)=0
 
- Protected Attributes inherited from Anasazi::Experimental::TraceMinBaseSolMgr< ScalarType, MV, OP >
RCP< Eigenproblem< ScalarType, MV, OP > > problem_
 
int numIters_
 
int blockSize_
 
int numBlocks_
 
int numRestartBlocks_
 
RCP< OutputManager< ScalarType > > printer_
 
MagnitudeType convTol_
 
bool relConvTol_
 
enum ResType convNorm_
 
MagnitudeType lockTol_
 
int maxLocked_
 
int lockQuorum_
 
bool useLocking_
 
bool relLockTol_
 
enum ResType lockNorm_
 
enum WhenToShiftType whenToShift_
 
MagnitudeType traceThresh_
 
MagnitudeType shiftTol_
 
enum HowToShiftType howToShift_
 
bool useMultipleShifts_
 
bool relShiftTol_
 
bool considerClusters_
 
std::string shiftNorm_
 
int maxKrylovIter_
 
std::string ortho_
 
std::string which_
 
enum SaddleSolType saddleSolType_
 
bool projectAllVecs_
 
bool projectLockedVecs_
 
bool computeAllRes_
 
bool useRHSR_
 
bool useHarmonic_
 
bool noSort_
 
MagnitudeType alpha_
 
RCP< Teuchos::Time > _timerSolve
 
RCP< Teuchos::Time > _timerRestarting
 
RCP< Teuchos::Time > _timerLocking
 
RCP< StatusTest< ScalarType, MV, OP > > globalTest_
 
RCP< StatusTest< ScalarType, MV, OP > > lockingTest_
 
RCP< StatusTest< ScalarType, MV, OP > > debugTest_
 

Detailed Description

template<class ScalarType, class MV, class OP>
class Anasazi::Experimental::TraceMinDavidsonSolMgr< ScalarType, MV, OP >

The Anasazi::TraceMinDavidsonSolMgr provides a flexible solver manager over the TraceMinDavidson eigensolver.

This solver manager implements a hard-locking mechanism, whereby eigenpairs designated to be locked are moved from the eigensolver and placed in auxilliary storage. The eigensolver is then restarted and continues to iterate, orthogonal to the locked eigenvectors.

The solver manager provides to the solver a StatusTestCombo object constructed as follows:
   combo = globaltest OR lockingtest OR debugtest
where

Additionally, the solver manager will terminate and restart solve() when the subspace is full, and it will terminate solve and return after a specified number of restarts.

Much of this behavior is controlled via parameters and options passed to the solver manager. For more information, see TraceMinDavidsonSolMgr().

Author
Alicia Klinvex
Examples
TraceMinDavidsonGeneralizedEx.cpp, TraceMinDavidsonLaplacianEx.cpp, TraceMinDavidsonSpecTransEx.cpp, and TraceMinDavidsonUserOpEx.cpp.

Definition at line 110 of file AnasaziTraceMinDavidsonSolMgr.hpp.

Constructor & Destructor Documentation

◆ TraceMinDavidsonSolMgr()

template<class ScalarType , class MV , class OP >
Anasazi::Experimental::TraceMinDavidsonSolMgr< ScalarType, MV, OP >::TraceMinDavidsonSolMgr ( const Teuchos::RCP< Eigenproblem< ScalarType, MV, OP > > &  problem,
Teuchos::ParameterList &  pl 
)

Basic constructor for TraceMinDavidsonSolMgr.

This constructor accepts the Eigenproblem to be solved in addition to a parameter list of options for the solver manager. Since this class inherits from TraceMinBaseSolMgr, it accepts the same options as TraceMinBaseSolMgr(), with a few additions:

  • "Use Harmonic Ritz Values" - a bool specifying whether to compute the harmonic Ritz values. Unless you're computing interior eigenpairs, this should be false. Default: false
  • "Block Size" - an int specifying the block size to be used by the underlying solver. If the eigenvalues are clustered, you may want to use a larger block size to capture the correct multiplicity. Default: 1
  • "Num Blocks" - an int specifying the maximum number of blocks in the subspace. After we compute this many blocks, we will restart.
  • "Num Restart Blocks" - an int specifying how many blocks we keep when restarting. We will extract the most significant blocks from the previous restart and use them to reinitialize TraceMinDavidson. Default: NEV / block size
  • "Maximum Restarts" - an int specifying the maximum number of restarts to be performed. Default: 50

A special note about Jacobi-Davidson:
Since Jacobi-Davidson is a special case of TraceMin-Davidson, it does not have its own solver class. If you want to run Jacobi-Davidson, all you need to do is set the following options:

  • "When To Shift" = "Always" (which is the default)
  • "How To Choose Shift" = "Ritz Values" (not recommended)

Choosing the Ritz shifts to be equal to the Ritz values destroys TraceMin-Davidson's guaranteed global convergence, so it is recommended that you consider TraceMin-Davidson (which is identical in every other way) with its default adjusted Ritz shifts instead.

Definition at line 199 of file AnasaziTraceMinDavidsonSolMgr.hpp.


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