/usr/include/trilinos/AnasaziTraceMinSolMgr.hpp is in libtrilinos-anasazi-dev 12.10.1-3.
This file is owned by root:root, with mode 0o644.
The actual contents of the file can be viewed below.
1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 25 26 27 28 29 30 31 32 33 34 35 36 37 38 39 40 41 42 43 44 45 46 47 48 49 50 51 52 53 54 55 56 57 58 59 60 61 62 63 64 65 66 67 68 69 70 71 72 73 74 75 76 77 78 79 80 81 82 83 84 85 86 87 88 89 90 91 92 93 94 95 96 97 98 99 100 101 102 103 104 105 106 107 108 109 110 111 112 113 114 115 116 117 118 119 120 121 122 123 124 125 126 127 128 129 130 131 132 133 134 135 136 137 138 139 140 141 142 143 144 145 146 147 148 149 150 151 152 153 154 155 156 157 158 159 160 161 162 163 164 165 166 167 168 169 170 171 172 173 174 175 176 177 178 179 180 181 182 183 184 185 186 187 188 189 190 191 192 193 194 195 196 197 198 199 200 201 | // @HEADER
// ***********************************************************************
//
// Anasazi: Block Eigensolvers Package
// Copyright (2004) Sandia Corporation
//
// Under terms of Contract DE-AC04-94AL85000, there is a non-exclusive
// license for use of this work by or on behalf of the U.S. Government.
//
// This library is free software; you can redistribute it and/or modify
// it under the terms of the GNU Lesser General Public License as
// published by the Free Software Foundation; either version 2.1 of the
// License, or (at your option) any later version.
//
// This library is distributed in the hope that it will be useful, but
// WITHOUT ANY WARRANTY; without even the implied warranty of
// MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
// Lesser General Public License for more details.
//
// You should have received a copy of the GNU Lesser General Public
// License along with this library; if not, write to the Free Software
// Foundation, Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301
// USA
// Questions? Contact Michael A. Heroux (maherou@sandia.gov)
//
// ***********************************************************************
// @HEADER
#ifndef ANASAZI_TRACEMIN_SOLMGR_HPP
#define ANASAZI_TRACEMIN_SOLMGR_HPP
/*! \file AnasaziTraceMinSolMgr.hpp
* \brief The Anasazi::TraceMinSolMgr provides a solver manager for the TraceMin eigensolver with a constant subspace dimension.
*
* For TraceMin with expanding subspaces, please see Anasazi::TraceMinDavidsonSolMgr.
*/
#include "AnasaziConfigDefs.hpp"
#include "AnasaziTypes.hpp"
#include "AnasaziEigenproblem.hpp"
#include "AnasaziSolverUtils.hpp"
#include "AnasaziTraceMin.hpp"
#include "AnasaziTraceMinBaseSolMgr.hpp"
#include "AnasaziBasicSort.hpp"
#include "AnasaziStatusTestResNorm.hpp"
#include "AnasaziStatusTestWithOrdering.hpp"
#include "AnasaziStatusTestCombo.hpp"
#include "AnasaziStatusTestOutput.hpp"
#include "AnasaziBasicOutputManager.hpp"
#include "Teuchos_BLAS.hpp"
#include "Teuchos_LAPACK.hpp"
#include "Teuchos_TimeMonitor.hpp"
#ifdef TEUCHOS_DEBUG
# include <Teuchos_FancyOStream.hpp>
#endif
#ifdef HAVE_MPI
#include <mpi.h>
#endif
namespace Anasazi {
namespace Experimental {
template<class ScalarType, class MV, class OP>
/*! \class TraceMinSolMgr
*
* \brief The Anasazi::TraceMinSolMgr provides a flexible solver manager over the TraceMin 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:<br>
* <tt>combo = globaltest OR lockingtest OR debugtest</tt><br>
* where
* - \c globaltest terminates computation when global convergence has been detected.<br>
* It is encapsulated in a StatusTestWithOrdering object, to ensure that computation is terminated
* only after the most significant eigenvalues/eigenvectors have met the convergence criteria.<br>
* If not specified via setGlobalStatusTest(), \c globaltest is a StatusTestResNorm object which tests the
* 2-norms of the direct residuals relative to the Ritz values.
* - \c lockingtest halts TraceMin::iterate() in order to deflate converged eigenpairs for locking.<br>
* It will query the underlying TraceMin eigensolver to determine when eigenvectors should be locked.<br>
* If not specified via setLockingStatusTest(), \c lockingtest is a StatusTestResNorm object.
* - \c debugtest allows a user to specify additional monitoring of the iteration, encapsulated in a StatusTest object<br>
* If not specified via setDebugStatusTest(), \c debugtest is ignored.<br>
* In most cases, it should return ::Failed; if it returns ::Passed, solve() will throw an AnasaziError exception.
*
* Additionally, the solver manager will terminate solve() after a specified number of iterations.
*
* Much of this behavior is controlled via parameters and options passed to the
* solver manager. For more information, see TraceMinSolMgr().
\ingroup anasazi_solver_framework
\author Alicia Klinvex
*/
class TraceMinSolMgr : public TraceMinBaseSolMgr<ScalarType,MV,OP> {
private:
typedef MultiVecTraits<ScalarType,MV> MVT;
typedef OperatorTraits<ScalarType,MV,OP> OPT;
typedef Teuchos::ScalarTraits<ScalarType> SCT;
typedef typename Teuchos::ScalarTraits<ScalarType>::magnitudeType MagnitudeType;
typedef Teuchos::ScalarTraits<MagnitudeType> MT;
public:
//! @name Constructors
//@{
/*! \brief Basic constructor for TraceMinSolMgr.
*
* 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:
* - \c "Block Size" - an \c int specifying the block size to be used by the underlying solver.
* A larger block size means more work per iteration, but it may also decrease the number of
* iterations required. Default: 2*problem->getNEV()
* - \c "Maximum Iterations" - an \c int specifying the maximum number of TraceMin iterations to be performed. Default: 100
*/
TraceMinSolMgr( const Teuchos::RCP<Eigenproblem<ScalarType,MV,OP> > &problem,
Teuchos::ParameterList &pl );
//@}
private:
int maxits_;
// Test whether we have exceeded the maximum number of iterations
bool exceededMaxIter() { return (this->iter_ >= maxits_); };
// TraceMin does not restart, so this will always return false
bool needToRestart(const Teuchos::RCP< TraceMinBase<ScalarType,MV,OP> > solver) { return false; };
// TraceMin does not restart, so this will throw an exception
bool performRestart(int &numRestarts, Teuchos::RCP< TraceMinBase<ScalarType,MV,OP> > solver)
{ TEUCHOS_TEST_FOR_EXCEPTION(true, std::logic_error, "Anasazi::TraceMinSolMgr::performRestart(): TraceMin does not perform restarts!"); };
// Returns a new TraceMin solver object
Teuchos::RCP< TraceMinBase<ScalarType,MV,OP> > createSolver(
const Teuchos::RCP<SortManager<typename Teuchos::ScalarTraits<ScalarType>::magnitudeType> > &sorter,
const Teuchos::RCP<StatusTest<ScalarType,MV,OP> > &outputtest,
const Teuchos::RCP<MatOrthoManager<ScalarType,MV,OP> > &ortho,
Teuchos::ParameterList &plist
);
};
///////////////////////////////////////////////////////////////////////////////////////////////////
// Constructor - accepts maximum iterations in addition to the other parameters of the abstract base class
template<class ScalarType, class MV, class OP>
TraceMinSolMgr<ScalarType,MV,OP>::TraceMinSolMgr( const Teuchos::RCP<Eigenproblem<ScalarType,MV,OP> > &problem, Teuchos::ParameterList &pl ) :
TraceMinBaseSolMgr<ScalarType,MV,OP>(problem,pl)
{
// Get the maximum number of iterations
maxits_ = pl.get("Maximum Iterations", 100);
TEUCHOS_TEST_FOR_EXCEPTION(maxits_ < 1, std::invalid_argument, "Anasazi::TraceMinSolMgr::constructor(): \"Maximum Iterations\" must be strictly positive.");
// block size: default is 2* nev()
// TODO: Find out minimum value
this->blockSize_ = pl.get("Block Size",2*this->problem_->getNEV());
TEUCHOS_TEST_FOR_EXCEPTION(this->blockSize_ < this->problem_->getNEV(), std::invalid_argument,
"Anasazi::TraceMinSolMgr::constructor(): \"Block Size\" must be greater than or equal to the number of desired eigenpairs.");
this->useHarmonic_ = pl.get("Use Harmonic Ritz Values", false);
TEUCHOS_TEST_FOR_EXCEPTION(this->useHarmonic_, std::invalid_argument,
"Anasazi::TraceMinSolMgr::constructor(): Please disable the harmonic Ritz values. It doesn't make sense to use them with TraceMin, which does not use expanding subspaces. Perhaps you wanted TraceMin-Davidson?");
// TraceMin does not restart, so the number of blocks and number of restart blocks will always be 1
this->numBlocks_ = 1;
this->numRestartBlocks_ = 1;
TEUCHOS_TEST_FOR_EXCEPTION(static_cast<ptrdiff_t>(this->numBlocks_)*this->blockSize_ + this->maxLocked_ > MVT::GetGlobalLength(*this->problem_->getInitVec()),
std::invalid_argument,
"Anasazi::TraceMinSolMgr::constructor(): Potentially impossible orthogonality requests. Reduce basis size or locking size.");
TEUCHOS_TEST_FOR_EXCEPTION(this->maxLocked_ + this->blockSize_ < this->problem_->getNEV(), std::invalid_argument,
"Anasazi::TraceMinDavidsonSolMgr: Not enough storage space for requested number of eigenpairs.");
}
///////////////////////////////////////////////////////////////////////////////////////////////////
// Returns a new TraceMin solver object
template <class ScalarType, class MV, class OP>
Teuchos::RCP< TraceMinBase<ScalarType,MV,OP> > TraceMinSolMgr<ScalarType,MV,OP>::createSolver(
const Teuchos::RCP<SortManager<typename Teuchos::ScalarTraits<ScalarType>::magnitudeType> > &sorter,
const Teuchos::RCP<StatusTest<ScalarType,MV,OP> > &outputtest,
const Teuchos::RCP<MatOrthoManager<ScalarType,MV,OP> > &ortho,
Teuchos::ParameterList &plist
)
{
return Teuchos::rcp( new TraceMin<ScalarType,MV,OP>(this->problem_,sorter,this->printer_,outputtest,ortho,plist) );
}
}} // end Anasazi namespace
#endif /* ANASAZI_TRACEMIN_SOLMGR_HPP */
|