|
NOX Development
|
Anasazi operator for computing generalized eigenvalues using Cayley transformations. More...
#include <LOCA_AnasaziOperator_Cayley.H>


Public Member Functions | |
| Cayley (const Teuchos::RCP< LOCA::GlobalData > &global_data, const Teuchos::RCP< LOCA::Parameter::SublistParser > &topParams, const Teuchos::RCP< Teuchos::ParameterList > &eigenParams, const Teuchos::RCP< Teuchos::ParameterList > &solverParams, const Teuchos::RCP< LOCA::TimeDependent::AbstractGroup > &grp) | |
| Constructor. | |
| virtual | ~Cayley () |
| Destructor. | |
| virtual const std::string & | label () const |
| Return name of this operator. | |
| virtual void | apply (const NOX::Abstract::MultiVector &input, NOX::Abstract::MultiVector &output) const |
| Apply the operator. | |
| virtual void | preProcessSeedVector (NOX::Abstract::MultiVector &ivec) |
| PreProcess the random seed vector. | |
| virtual void | transformEigenvalue (double &ev_r, double &ev_i) const |
| Transform eigenvalue. | |
| virtual NOX::Abstract::Group::ReturnType | rayleighQuotient (NOX::Abstract::Vector &evec_r, NOX::Abstract::Vector &evec_i, double &rq_r, double &rq_i) const |
| Compute Rayleigh quotient. | |
Public Member Functions inherited from LOCA::AnasaziOperator::AbstractStrategy | |
| AbstractStrategy () | |
| Constructor. | |
| virtual | ~AbstractStrategy () |
| Destructor. | |
| virtual void | beginPostProcessing () |
| Hook to precompute info for subsequent repeated calls to tranformEigenvalue and rayleighQuotient. | |
Protected Attributes | |
| Teuchos::RCP< LOCA::GlobalData > | globalData |
| Global data. | |
| std::string | myLabel |
| Name of this operator. | |
| Teuchos::RCP< Teuchos::ParameterList > | eigenParams |
| Stores parameters relating to the operator. | |
| Teuchos::RCP< Teuchos::ParameterList > | solverParams |
| Stores linear solver parameters. | |
| Teuchos::RCP< LOCA::TimeDependent::AbstractGroup > | grp |
| Stores group representing Jacobian and Mass matrix. | |
| Teuchos::RCP< NOX::Abstract::MultiVector > | tmp_r |
| Stores a temporary vector for computing Rayleigh quotients. | |
| Teuchos::RCP< NOX::Abstract::MultiVector > | tmp_i |
| Stores a temporary vector for computing Rayleigh quotients. | |
| double | sigma |
| Stores Cayley pole | |
| double | mu |
| Stores Cayley zero | |
Anasazi operator for computing generalized eigenvalues using Cayley transformations.
This class implements the LOCA::AnasaziOperator::AbstractStrategy interface for computing generalized eigenvalues 

![\[
J z = \lambda M z
*\]](form_349.png)
where 

![\[
(J - \sigma M) z = (J - \mu M) r
\]](form_351.png)
where 

The parameters used by this class supplied in the constructor are:


Also the grp argument to the constructor must be a child of LOCA::TimeDependent::AbstractGroup for the shift-invert operations.
| LOCA::AnasaziOperator::Cayley::Cayley | ( | const Teuchos::RCP< LOCA::GlobalData > & | global_data, |
| const Teuchos::RCP< LOCA::Parameter::SublistParser > & | topParams, | ||
| const Teuchos::RCP< Teuchos::ParameterList > & | eigenParams, | ||
| const Teuchos::RCP< Teuchos::ParameterList > & | solverParams, | ||
| const Teuchos::RCP< LOCA::TimeDependent::AbstractGroup > & | grp | ||
| ) |
Constructor.
Argument grp must be of type LOCA::TimeDependent::AbstractGroup. See class description for a list of eigenParams.
References eigenParams, mu, and sigma.
|
virtual |
Apply the operator.
Applies the inverse of the shifted operator, i.e., solves
![\[
(J-\omega I)z = M r
\]](form_354.png)
for 


Implements LOCA::AnasaziOperator::AbstractStrategy.
References NOX::Abstract::MultiVector::clone(), NOX::Abstract::MultiVector::numVectors(), NOX::Abstract::Group::Ok, and NOX::ShapeCopy.
|
virtual |
Return name of this operator.
Implements LOCA::AnasaziOperator::AbstractStrategy.
|
virtual |
PreProcess the random seed vector.
Performs one backward Euler iteration on the random initial seed vector, to satisfy contraints
Reimplemented from LOCA::AnasaziOperator::AbstractStrategy.
References NOX::Abstract::MultiVector::clone(), NOX::Abstract::MultiVector::numVectors(), NOX::Abstract::Group::Ok, and NOX::ShapeCopy.
|
virtual |
Compute Rayleigh quotient.
Computes the Rayleigh quotient 

Implements LOCA::AnasaziOperator::AbstractStrategy.
References NOX::Abstract::Vector::createMultiVector(), NOX::Abstract::Vector::innerProduct(), NOX::Abstract::Group::Ok, NOX::Abstract::Vector::scale(), and NOX::ShapeCopy.
|
virtual |
Transform eigenvalue.
Transforms the given eigenvalue to the eigenvalue of the Jacobian-mass matrix system by shifting and inverting it.
Implements LOCA::AnasaziOperator::AbstractStrategy.