LOCA::Epetra::Group Class Reference

Extension of the NOX::Epetra::Group to LOCA. More...

#include <LOCA_Epetra_Group.H>

Inheritance diagram for LOCA::Epetra::Group:

Inheritance graph
[legend]
Collaboration diagram for LOCA::Epetra::Group:

Collaboration graph
[legend]

List of all members.

Public Member Functions

 Group (const Teuchos::RCP< LOCA::GlobalData > &global_data, Teuchos::ParameterList &printingParams, const Teuchos::RCP< LOCA::Epetra::Interface::Required > &i, NOX::Epetra::Vector &initialGuess, const LOCA::ParameterVector &p)
 Constructor with NO linear system (VERY LIMITED).
 Group (const Teuchos::RCP< LOCA::GlobalData > &global_data, Teuchos::ParameterList &printingParams, const Teuchos::RCP< LOCA::Epetra::Interface::Required > &i, NOX::Epetra::Vector &initialGuess, const Teuchos::RCP< NOX::Epetra::LinearSystem > &linSys, const LOCA::ParameterVector &p)
 Standard Constructor enabling most LOCA support.
 Group (const Teuchos::RCP< LOCA::GlobalData > &global_data, Teuchos::ParameterList &printingParams, const Teuchos::RCP< LOCA::Epetra::Interface::TimeDependent > &i, NOX::Epetra::Vector &initialGuess, const Teuchos::RCP< NOX::Epetra::LinearSystem > &linSys, const Teuchos::RCP< NOX::Epetra::LinearSystem > &shiftedLinSys, const LOCA::ParameterVector &p)
 Constructor with time-dependent interface and shifted linear system.
 Group (const Teuchos::RCP< LOCA::GlobalData > &global_data, Teuchos::ParameterList &printingParams, const Teuchos::RCP< LOCA::Epetra::Interface::TimeDependentMatrixFree > &i, NOX::Epetra::Vector &initialGuess, const Teuchos::RCP< NOX::Epetra::LinearSystem > &linSys, const Teuchos::RCP< NOX::Epetra::LinearSystem > &shiftedLinSys, const LOCA::ParameterVector &p)
 Constructor with time-dependent matrix-free interface and shifted linear system.
 Group (const Group &source, NOX::CopyType type=NOX::DeepCopy)
 Copy constructor. If type is DeepCopy, takes ownership of valid shared Jacobian and shared preconditioning matrix.
virtual ~Group ()
 Destructor.
virtual Groupoperator= (const Group &source)
 Assignment operator.
virtual Teuchos::RCP
< NOX::Epetra::Interface::Required
getUserInterface ()
 Return the userInterface.
virtual void printSolution (const NOX::Epetra::Vector &x, const double conParam) const
 Call the user interface print() routine, any vector.
void setScaleVector (const NOX::Abstract::Vector &s)
 Sets the scale vector.
void setJacobianOperatorForSolve (const Teuchos::RCP< const Epetra_Operator > &op) const
 Sets the Jacobian operator.
virtual Teuchos::RCP< const
NOX::Epetra::LinearSystem
getComplexLinearSystem () const
 Return the Linear System.
virtual Teuchos::RCP
< NOX::Epetra::LinearSystem
getComplexLinearSystem ()
 Return the Linear System.
virtual void getComplexMaps (Teuchos::RCP< const Epetra_BlockMap > &baseMap, Teuchos::RCP< const Epetra_BlockMap > &globalMap) const
Overloaded NOX::Epetra::Group methods.
virtual NOX::Abstract::Groupoperator= (const NOX::Abstract::Group &source)
 Assignment operator.
virtual NOX::Abstract::Groupoperator= (const NOX::Epetra::Group &source)
 Assignment operator.
virtual Teuchos::RCP
< NOX::Abstract::Group
clone (NOX::CopyType type=NOX::DeepCopy) const
 Cloning function.
virtual
NOX::Abstract::Group::ReturnType 
computeF ()
 Overloaded computeF().
virtual
NOX::Abstract::Group::ReturnType 
computeJacobian ()
 Overloaded computeJacobian().
Implementation of LOCA::Abstract::TransposeSolveGroup methods.
virtual
NOX::Abstract::Group::ReturnType 
applyJacobianTransposeInverse (Teuchos::ParameterList &params, const NOX::Abstract::Vector &input, NOX::Abstract::Vector &result) const
 Solve Jacobian-tranpose system.
virtual
NOX::Abstract::Group::ReturnType 
applyJacobianTransposeInverseMultiVector (Teuchos::ParameterList &params, const NOX::Abstract::MultiVector &input, NOX::Abstract::MultiVector &result) const
 Solve Jacobian-tranpose system with multiple right-hand sides.
Implementation of LOCA::MultiContinuation::AbstractGroup virtual methods.
virtual void copy (const NOX::Abstract::Group &source)
 Copy.
virtual void setParams (const ParameterVector &p)
 Set the parameters.
virtual void setParam (int paramID, double val)
 Set parameter indexed by paramID.
virtual void setParam (string paramID, double val)
 Set parameter indexed by paramID.
const LOCA::ParameterVectorgetParams () const
 Return a const reference to the ParameterVector owned by the group.
virtual double getParam (int paramID) const
 Return copy of parameter indexed by paramID.
virtual double getParam (string paramID) const
 Return copy of parameter indexed by paramID.
virtual void preProcessContinuationStep (LOCA::Abstract::Iterator::StepStatus stepStatus)
 Perform any preprocessing before a continuation step starts.
virtual void postProcessContinuationStep (LOCA::Abstract::Iterator::StepStatus stepStatus)
 Perform any postprocessing after a continuation step finishes.
virtual void projectToDraw (const NOX::Abstract::Vector &x, double *px) const
 Projects solution to a few scalars for multiparameter continuation.
virtual int projectToDrawDimension () const
 Returns the dimension of the project to draw array.
virtual double computeScaledDotProduct (const NOX::Abstract::Vector &a, const NOX::Abstract::Vector &b) const
 Compute a scaled dot product.
virtual void printSolution (const double conParam) const
 Call the user interface print() routine, solution vector.
virtual void printSolution (const NOX::Abstract::Vector &x, const double conParam) const
 Call the user interface print() routine, any vector.
virtual void scaleVector (NOX::Abstract::Vector &x) const
 Scales a vector using scaling vector.
Implementation of LOCA::Homotopy::AbstractGroup virtual methods.
virtual
NOX::Abstract::Group::ReturnType 
augmentJacobianForHomotopy (double a, double b)
 Replace Jacobian $J$ by $aJ+bI$ where $I$ is the identity matrix.
Implementation of LOCA::TimeDependent::AbstractGroup virtual methods.
virtual
NOX::Abstract::Group::ReturnType 
computeShiftedMatrix (double alpha, double beta)
 Compute the shifted matrix.
virtual
NOX::Abstract::Group::ReturnType 
applyShiftedMatrix (const NOX::Abstract::Vector &input, NOX::Abstract::Vector &result) const
 Multiply the shifted matrix by a vector.
virtual
NOX::Abstract::Group::ReturnType 
applyShiftedMatrixMultiVector (const NOX::Abstract::MultiVector &input, NOX::Abstract::MultiVector &result) const
 Multiply the shifted matrix by a multi-vector.
virtual
NOX::Abstract::Group::ReturnType 
applyShiftedMatrixInverseMultiVector (Teuchos::ParameterList &params, const NOX::Abstract::MultiVector &input, NOX::Abstract::MultiVector &result) const
 Apply the inverse of the shifted matrix by a multi-vector, as needed by the shift-and-invert and generalized Cayley transformations.
Implementation of LOCA::Hopf::MooreSpence::AbstractGroup virtual methods.
virtual bool isComplex () const
 Is $J+i\omega B$ valid.
virtual
NOX::Abstract::Group::ReturnType 
computeComplex (double frequency)
 Compute $J+i\omega B$.
virtual
NOX::Abstract::Group::ReturnType 
applyComplex (const NOX::Abstract::Vector &input_real, const NOX::Abstract::Vector &input_imag, NOX::Abstract::Vector &result_real, NOX::Abstract::Vector &result_imag) const
 Compute $(J+i\omega B)(y+iz)$.
virtual
NOX::Abstract::Group::ReturnType 
applyComplexMultiVector (const NOX::Abstract::MultiVector &input_real, const NOX::Abstract::MultiVector &input_imag, NOX::Abstract::MultiVector &result_real, NOX::Abstract::MultiVector &result_imag) const
 Compute $(J+i\omega B)(y+iz)$.
virtual
NOX::Abstract::Group::ReturnType 
applyComplexInverseMultiVector (Teuchos::ParameterList &params, const NOX::Abstract::MultiVector &input_real, const NOX::Abstract::MultiVector &input_imag, NOX::Abstract::MultiVector &result_real, NOX::Abstract::MultiVector &result_imag) const
 Solve $(J+i\omega B)(y+iz) = a+ib$.
Implementation of LOCA::Hopf::MinimallyAugmented::AbstractGroup virtual methods.
virtual
NOX::Abstract::Group::ReturnType 
applyComplexTranspose (const NOX::Abstract::Vector &input_real, const NOX::Abstract::Vector &input_imag, NOX::Abstract::Vector &result_real, NOX::Abstract::Vector &result_imag) const
virtual
NOX::Abstract::Group::ReturnType 
applyComplexTransposeMultiVector (const NOX::Abstract::MultiVector &input_real, const NOX::Abstract::MultiVector &input_imag, NOX::Abstract::MultiVector &result_real, NOX::Abstract::MultiVector &result_imag) const
virtual
NOX::Abstract::Group::ReturnType 
applyComplexTransposeInverseMultiVector (Teuchos::ParameterList &params, const NOX::Abstract::MultiVector &input_real, const NOX::Abstract::MultiVector &input_imag, NOX::Abstract::MultiVector &result_real, NOX::Abstract::MultiVector &result_imag) const
 Solve $(J+i\omega B)^H (x + iy) = a+ib$.

Protected Member Functions

virtual void resetIsValid ()
 resets the isValid flags to false

Protected Attributes

Teuchos::RCP< LOCA::GlobalDataglobalData
 Global data.
Teuchos::ParameterList & printParams
 Printing parameters.
LOCA::ParameterVector params
 Parameter vector.
Teuchos::RCP
< LOCA::Epetra::Interface::Required
userInterface
 Reference to the user supplied interface functions.
Teuchos::RCP
< LOCA::Epetra::Interface::TimeDependent
userInterfaceTime
 Interface for shifted-matrix.
Teuchos::RCP
< LOCA::Epetra::Interface::TimeDependentMatrixFree
userInterfaceTimeMF
 Interface for matrix-free shifted-matrix.
Teuchos::RCP
< NOX::SharedObject
< NOX::Epetra::LinearSystem,
LOCA::Epetra::Group > > 
shiftedSharedLinearSystem
 Shared shifted linear system.
bool isValidShiftedPrec
 Is preconditioner for shifted matrix valid.
double alpha_
 $\alpha$ for matrix-free shifted matrix
double beta_
 $\beta$ for matrix-free shifted matrix
Teuchos::RCP< Epetra_Vector > tmpVectorPtr2
 Extra vector needed for intermediate calculations of LOCA routines.
Teuchos::RCP
< NOX::Abstract::Vector
scaleVecPtr
 Stores a pointer to the scale vector.
Teuchos::RCP
< LOCA::Epetra::TransposeLinearSystem::AbstractStrategy
tls_strategy
 Stores transpose linear solver strategy.
Teuchos::RCP
< NOX::SharedObject
< NOX::Epetra::LinearSystem,
LOCA::Epetra::Group > > 
complexSharedLinearSystem
 Shared complex system.
Teuchos::RCP
< EpetraExt::BlockCrsMatrix > 
complexMatrix
 Complex matrix.
Teuchos::RCP
< EpetraExt::BlockVector > 
complexVec
 Complex vector.
bool isValidComplex
 Is complex matrix valid.
bool isValidComplexPrec
 Is complex matrix preconditioner valid.


Detailed Description

Extension of the NOX::Epetra::Group to LOCA.

This class extends the NOX::Epetra::Group to LOCA enabling continuation and bifurcation capabilities using Epetra. It is derived from the NOX::Epetra::Group (basic Epetra support), the LOCA::Abstract::Group (brings in all LOCA abstract base classes), and the LOCA::Abstract::TransposeSolveGroup (for applyJacobianTransposeInverse() methods). It stores a parameter vector for setting/retrieving parameter values and overloads the computeF() and computeJacobian() methods of the NOX::Epetra::Group parent class to set the entire contents of the parameter vector in the problem interface before calling the NOX::Epetra::Group computeF() and computeJacobian().

Since it is derived from the LOCA::Abstract::Group (which is in turn derived from all FiniteDifference groups), it uses the finite-difference implementations for all parameter derivatives and second derivatives. However this behavior can be modified by calling the setDerivUtils() method of the LOCA::MultiContinuation::FiniteDifferenceGroup parent class.

This class provides complete support for all continuation and bifurcation methods including shift-invert and Cayley methods for computing eigenvalues and Hopf bifurcations. However this support is only enabled by calling the appropriate constructor described below.

Definition at line 104 of file LOCA_Epetra_Group.H.


Constructor & Destructor Documentation

LOCA::Epetra::Group::Group ( const Teuchos::RCP< LOCA::GlobalData > &  global_data,
Teuchos::ParameterList &  printingParams,
const Teuchos::RCP< LOCA::Epetra::Interface::Required > &  i,
NOX::Epetra::Vector initialGuess,
const LOCA::ParameterVector p 
)

Constructor with NO linear system (VERY LIMITED).

WARNING: If this constructor is used, then methods that require a Jacobian or preconditioning will not be available. You will be limited to simple algorithms like nonlinear-CG with no preconditioning.

Definition at line 66 of file LOCA_Epetra_Group.C.

LOCA::Epetra::Group::Group ( const Teuchos::RCP< LOCA::GlobalData > &  global_data,
Teuchos::ParameterList &  printingParams,
const Teuchos::RCP< LOCA::Epetra::Interface::Required > &  i,
NOX::Epetra::Vector initialGuess,
const Teuchos::RCP< NOX::Epetra::LinearSystem > &  linSys,
const LOCA::ParameterVector p 
)

Standard Constructor enabling most LOCA support.

This is the most commonly used constructor and provides support for all LOCA algorithms except shift-invert and Cayley transformations and Hopf bifurcations.

Definition at line 95 of file LOCA_Epetra_Group.C.

LOCA::Epetra::Group::Group ( const Teuchos::RCP< LOCA::GlobalData > &  global_data,
Teuchos::ParameterList &  printingParams,
const Teuchos::RCP< LOCA::Epetra::Interface::TimeDependent > &  i,
NOX::Epetra::Vector initialGuess,
const Teuchos::RCP< NOX::Epetra::LinearSystem > &  linSys,
const Teuchos::RCP< NOX::Epetra::LinearSystem > &  shiftedLinSys,
const LOCA::ParameterVector p 
)

Constructor with time-dependent interface and shifted linear system.

Use this constructor to enable shift-invert and Cayley transformations or Hopf bifurcations. It requires another interface to compute the shifted matrix $\alpha J + \beta M$ where $J$ is the Jacobian matrix and $M$ is the mass matrix, and a linear system object to solve this system. Setting linSys = shiftedLinSys is a valid option for passing the shifted solver, but this will cause the shifted matrix to overwrite the Jacobian possibly resulting in more matrix fills.

Definition at line 125 of file LOCA_Epetra_Group.C.

References shiftedSharedLinearSystem.

LOCA::Epetra::Group::Group ( const Teuchos::RCP< LOCA::GlobalData > &  global_data,
Teuchos::ParameterList &  printingParams,
const Teuchos::RCP< LOCA::Epetra::Interface::TimeDependentMatrixFree > &  i,
NOX::Epetra::Vector initialGuess,
const Teuchos::RCP< NOX::Epetra::LinearSystem > &  linSys,
const Teuchos::RCP< NOX::Epetra::LinearSystem > &  shiftedLinSys,
const LOCA::ParameterVector p 
)

Constructor with time-dependent matrix-free interface and shifted linear system.

This constructor may also be used for shift-invert and Cayley transformations, but should be only be used for a matrix-free method for solving the shifted system.

Definition at line 159 of file LOCA_Epetra_Group.C.

References shiftedSharedLinearSystem.

LOCA::Epetra::Group::Group ( const Group source,
NOX::CopyType  type = NOX::DeepCopy 
)

Copy constructor. If type is DeepCopy, takes ownership of valid shared Jacobian and shared preconditioning matrix.

Definition at line 193 of file LOCA_Epetra_Group.C.

References complexSharedLinearSystem, NOX::DeepCopy, scaleVecPtr, and shiftedSharedLinearSystem.

LOCA::Epetra::Group::~Group (  )  [virtual]

Destructor.

Reimplemented from NOX::Epetra::Group.

Definition at line 228 of file LOCA_Epetra_Group.C.


Member Function Documentation

LOCA::Epetra::Group & LOCA::Epetra::Group::operator= ( const Group source  )  [virtual]

NOX::Abstract::Group & LOCA::Epetra::Group::operator= ( const NOX::Abstract::Group source  )  [virtual]

Assignment operator.

Reimplemented from NOX::Epetra::Group.

Definition at line 262 of file LOCA_Epetra_Group.C.

References operator=().

NOX::Abstract::Group & LOCA::Epetra::Group::operator= ( const NOX::Epetra::Group source  )  [virtual]

Assignment operator.

Reimplemented from NOX::Epetra::Group.

Definition at line 269 of file LOCA_Epetra_Group.C.

References operator=().

Teuchos::RCP< NOX::Abstract::Group > LOCA::Epetra::Group::clone ( NOX::CopyType  type = NOX::DeepCopy  )  const [virtual]

Cloning function.

Reimplemented from NOX::Epetra::Group.

Definition at line 276 of file LOCA_Epetra_Group.C.

NOX::Abstract::Group::ReturnType LOCA::Epetra::Group::computeF (  )  [virtual]

Overloaded computeF().

Calls LOCA::Epetra::Interface::setParams before evalulating F.

Reimplemented from NOX::Epetra::Group.

Definition at line 282 of file LOCA_Epetra_Group.C.

References NOX::Epetra::Group::isF(), NOX::Abstract::Group::Ok, params, and userInterface.

NOX::Abstract::Group::ReturnType LOCA::Epetra::Group::computeJacobian (  )  [virtual]

Overloaded computeJacobian().

Calls LOCA::Epetra::Interface::setParams before evalulating J.

Reimplemented from NOX::Epetra::Group.

Definition at line 295 of file LOCA_Epetra_Group.C.

References NOX::Epetra::Group::isJacobian(), NOX::Abstract::Group::Ok, params, and userInterface.

Referenced by computeComplex().

NOX::Abstract::Group::ReturnType LOCA::Epetra::Group::applyJacobianTransposeInverse ( Teuchos::ParameterList &  params,
const NOX::Abstract::Vector input,
NOX::Abstract::Vector result 
) const [virtual]

Solve Jacobian-tranpose system.

In addition to all regular linear solver parameters, this method references the following additional parameters:

  • "Transpose Solver Method" -- [string] (default: "Transpose Preconditioner") Method for preconditioning the transpose linear system (LOCA::Epetra::TransposeLinearSystem::Factory). Available choices are:
    • "Transpose Preconditioner" -- Use the transpose of the preconditioner for the original system.
    • "Left Preconditioning" -- Use the transpose of the preconditioner, and apply using left preconditioning.
    • "Explicit Transpose" -- Form the transpose of the matrix and compute the preconditioner. This method is available only if Trilinos is configured with EpetraExt support (--enable-epetraext).

Implements LOCA::Abstract::TransposeSolveGroup.

Definition at line 308 of file LOCA_Epetra_Group.C.

References LOCA::Epetra::TransposeLinearSystem::Factory::create(), NOX::SharedObject< Object, Owner >::getObject(), globalData, NOX::Abstract::Group::NotConverged, NOX::Abstract::Group::Ok, NOX::Epetra::Group::sharedLinearSystem, tls_strategy, and NOX::Epetra::Group::xVector.

NOX::Abstract::Group::ReturnType LOCA::Epetra::Group::applyJacobianTransposeInverseMultiVector ( Teuchos::ParameterList &  params,
const NOX::Abstract::MultiVector input,
NOX::Abstract::MultiVector result 
) const [virtual]

Solve Jacobian-tranpose system with multiple right-hand sides.

In addition to all regular linear solver parameters, this method references the following additional parameters:

  • "Transpose Solver Method" -- [string] (default: "Transpose Preconditioner") Method for preconditioning the transpose linear system (LOCA::Epetra::TransposeLinearSystem::Factory). Available choices are:
    • "Transpose Preconditioner" -- Use the transpose of the preconditioner for the original system.
    • "Left Preconditioning" -- Use the transpose of the preconditioner, and apply using left preconditioning.
    • "Explicit Transpose" -- Form the transpose of the matrix and compute the preconditioner. This method is available only if Trilinos is configured with EpetraExt support (--enable-epetraext).

Implements LOCA::Abstract::TransposeSolveGroup.

Definition at line 356 of file LOCA_Epetra_Group.C.

References LOCA::Epetra::TransposeLinearSystem::Factory::create(), NOX::SharedObject< Object, Owner >::getObject(), globalData, NOX::Abstract::Group::NotConverged, NOX::Abstract::MultiVector::numVectors(), NOX::Abstract::Group::Ok, NOX::Epetra::Group::sharedLinearSystem, tls_strategy, and NOX::Epetra::Group::xVector.

void LOCA::Epetra::Group::copy ( const NOX::Abstract::Group source  )  [virtual]

Copy.

Reimplemented from LOCA::Abstract::Group.

Definition at line 412 of file LOCA_Epetra_Group.C.

Referenced by operator=().

void LOCA::Epetra::Group::setParams ( const ParameterVector p  )  [virtual]

Set the parameters.

Implements LOCA::MultiContinuation::AbstractGroup.

Definition at line 418 of file LOCA_Epetra_Group.C.

References params, and resetIsValid().

void LOCA::Epetra::Group::setParam ( int  paramID,
double  val 
) [virtual]

Set parameter indexed by paramID.

Implements LOCA::MultiContinuation::AbstractGroup.

Definition at line 425 of file LOCA_Epetra_Group.C.

References params, resetIsValid(), and LOCA::ParameterVector::setValue().

void LOCA::Epetra::Group::setParam ( string  paramID,
double  val 
) [virtual]

Set parameter indexed by paramID.

Implements LOCA::MultiContinuation::AbstractGroup.

Definition at line 432 of file LOCA_Epetra_Group.C.

References params, resetIsValid(), and LOCA::ParameterVector::setValue().

const LOCA::ParameterVector & LOCA::Epetra::Group::getParams (  )  const [virtual]

Return a const reference to the ParameterVector owned by the group.

Implements LOCA::MultiContinuation::AbstractGroup.

Definition at line 439 of file LOCA_Epetra_Group.C.

References params.

double LOCA::Epetra::Group::getParam ( int  paramID  )  const [virtual]

Return copy of parameter indexed by paramID.

Implements LOCA::MultiContinuation::AbstractGroup.

Definition at line 445 of file LOCA_Epetra_Group.C.

References LOCA::ParameterVector::getValue(), and params.

double LOCA::Epetra::Group::getParam ( string  paramID  )  const [virtual]

Return copy of parameter indexed by paramID.

Implements LOCA::MultiContinuation::AbstractGroup.

Definition at line 451 of file LOCA_Epetra_Group.C.

References LOCA::ParameterVector::getValue(), and params.

void LOCA::Epetra::Group::preProcessContinuationStep ( LOCA::Abstract::Iterator::StepStatus  stepStatus  )  [virtual]

Perform any preprocessing before a continuation step starts.

The stepStatus argument indicates whether the previous step was successful. The implementation here is to call the corresponding method in the interface.

Reimplemented from LOCA::MultiContinuation::AbstractGroup.

Definition at line 457 of file LOCA_Epetra_Group.C.

References userInterface.

void LOCA::Epetra::Group::postProcessContinuationStep ( LOCA::Abstract::Iterator::StepStatus  stepStatus  )  [virtual]

Perform any postprocessing after a continuation step finishes.

The stepStatus argument indicates whether the step was successful. The implementation here is to call the corresponding method in the interface.

Reimplemented from LOCA::MultiContinuation::AbstractGroup.

Definition at line 464 of file LOCA_Epetra_Group.C.

References userInterface.

void LOCA::Epetra::Group::projectToDraw ( const NOX::Abstract::Vector x,
double *  px 
) const [virtual]

Projects solution to a few scalars for multiparameter continuation.

This method is called every time a solution is saved by the multiparameter continuation code MF for later visualization and should project the solution vector down to a few scalars. The array px will be preallocated to the proper length given by projectToDrawDimension().

The implementation here is to call the corresponding method in the interface.

Reimplemented from LOCA::MultiContinuation::AbstractGroup.

Definition at line 471 of file LOCA_Epetra_Group.C.

References userInterface.

int LOCA::Epetra::Group::projectToDrawDimension (  )  const [virtual]

Returns the dimension of the project to draw array.

The implementation here is to call the corresponding method in the interface.

Reimplemented from LOCA::MultiContinuation::AbstractGroup.

Definition at line 480 of file LOCA_Epetra_Group.C.

References userInterface.

double LOCA::Epetra::Group::computeScaledDotProduct ( const NOX::Abstract::Vector a,
const NOX::Abstract::Vector b 
) const [virtual]

Compute a scaled dot product.

The implementation here uses the scaling vector $s$ if one is supplied:

\[ \sum_{i=1}^n a_i*b_i*s_i*s_i. \]

If the scaling vector is not provided, the standard dot product is used.

Reimplemented from LOCA::MultiContinuation::AbstractGroup.

Definition at line 486 of file LOCA_Epetra_Group.C.

References NOX::Abstract::Vector::clone(), NOX::DeepCopy, NOX::Abstract::Vector::innerProduct(), NOX::Abstract::Vector::length(), and scaleVecPtr.

void LOCA::Epetra::Group::printSolution ( const double  conParam  )  const [virtual]

Call the user interface print() routine, solution vector.

Reimplemented from LOCA::MultiContinuation::AbstractGroup.

Definition at line 506 of file LOCA_Epetra_Group.C.

References NOX::Epetra::Group::xVector.

Referenced by printSolution().

void LOCA::Epetra::Group::printSolution ( const NOX::Abstract::Vector x,
const double  conParam 
) const [virtual]

Call the user interface print() routine, any vector.

Reimplemented from LOCA::MultiContinuation::AbstractGroup.

Definition at line 512 of file LOCA_Epetra_Group.C.

References printSolution().

void LOCA::Epetra::Group::scaleVector ( NOX::Abstract::Vector x  )  const [virtual]

Scales a vector using scaling vector.

The implementation here uses the scaling vector $s$ if one is supplied:

\[ x_i = a_i*s_i. \]

If the scaling vector is not provided, the vector is rescaled by the square root of its length.

Reimplemented from LOCA::MultiContinuation::AbstractGroup.

Definition at line 519 of file LOCA_Epetra_Group.C.

References NOX::Abstract::Vector::length(), NOX::Abstract::Vector::scale(), and scaleVecPtr.

NOX::Abstract::Group::ReturnType LOCA::Epetra::Group::augmentJacobianForHomotopy ( double  a,
double  b 
) [virtual]

NOX::Abstract::Group::ReturnType LOCA::Epetra::Group::computeShiftedMatrix ( double  alpha,
double  beta 
) [virtual]

NOX::Abstract::Group::ReturnType LOCA::Epetra::Group::applyShiftedMatrix ( const NOX::Abstract::Vector input,
NOX::Abstract::Vector result 
) const [virtual]

NOX::Abstract::Group::ReturnType LOCA::Epetra::Group::applyShiftedMatrixMultiVector ( const NOX::Abstract::MultiVector input,
NOX::Abstract::MultiVector result 
) const [virtual]

Multiply the shifted matrix by a multi-vector.

Reimplemented from LOCA::Abstract::Group.

Definition at line 648 of file LOCA_Epetra_Group.C.

References applyShiftedMatrix(), globalData, NOX::Abstract::MultiVector::numVectors(), and NOX::Abstract::Group::Ok.

NOX::Abstract::Group::ReturnType LOCA::Epetra::Group::applyShiftedMatrixInverseMultiVector ( Teuchos::ParameterList &  params,
const NOX::Abstract::MultiVector input,
NOX::Abstract::MultiVector result 
) const [virtual]

bool LOCA::Epetra::Group::isComplex (  )  const [virtual]

Is $J+i\omega B$ valid.

Reimplemented from LOCA::Abstract::Group.

Definition at line 727 of file LOCA_Epetra_Group.C.

References isValidComplex.

NOX::Abstract::Group::ReturnType LOCA::Epetra::Group::computeComplex ( double  frequency  )  [virtual]

NOX::Abstract::Group::ReturnType LOCA::Epetra::Group::applyComplex ( const NOX::Abstract::Vector input_real,
const NOX::Abstract::Vector input_imag,
NOX::Abstract::Vector result_real,
NOX::Abstract::Vector result_imag 
) const [virtual]

NOX::Abstract::Group::ReturnType LOCA::Epetra::Group::applyComplexMultiVector ( const NOX::Abstract::MultiVector input_real,
const NOX::Abstract::MultiVector input_imag,
NOX::Abstract::MultiVector result_real,
NOX::Abstract::MultiVector result_imag 
) const [virtual]

NOX::Abstract::Group::ReturnType LOCA::Epetra::Group::applyComplexInverseMultiVector ( Teuchos::ParameterList &  params,
const NOX::Abstract::MultiVector input_real,
const NOX::Abstract::MultiVector input_imag,
NOX::Abstract::MultiVector result_real,
NOX::Abstract::MultiVector result_imag 
) const [virtual]

NOX::Abstract::Group::ReturnType LOCA::Epetra::Group::applyComplexTranspose ( const NOX::Abstract::Vector input_real,
const NOX::Abstract::Vector input_imag,
NOX::Abstract::Vector result_real,
NOX::Abstract::Vector result_imag 
) const [virtual]

NOX::Abstract::Group::ReturnType LOCA::Epetra::Group::applyComplexTransposeMultiVector ( const NOX::Abstract::MultiVector input_real,
const NOX::Abstract::MultiVector input_imag,
NOX::Abstract::MultiVector result_real,
NOX::Abstract::MultiVector result_imag 
) const [virtual]

Computes conjugate-tranpose matrix vector product $ (J+i\omega B)^H (x + iy) $.

Reimplemented from LOCA::Abstract::Group.

Definition at line 1107 of file LOCA_Epetra_Group.C.

References applyComplexTranspose(), globalData, NOX::Abstract::MultiVector::numVectors(), and NOX::Abstract::Group::Ok.

NOX::Abstract::Group::ReturnType LOCA::Epetra::Group::applyComplexTransposeInverseMultiVector ( Teuchos::ParameterList &  params,
const NOX::Abstract::MultiVector input_real,
const NOX::Abstract::MultiVector input_imag,
NOX::Abstract::MultiVector result_real,
NOX::Abstract::MultiVector result_imag 
) const [virtual]

Teuchos::RCP< NOX::Epetra::Interface::Required > LOCA::Epetra::Group::getUserInterface (  )  [virtual]

Return the userInterface.

Definition at line 1289 of file LOCA_Epetra_Group.C.

References userInterface.

void LOCA::Epetra::Group::printSolution ( const NOX::Epetra::Vector x,
const double  conParam 
) const [virtual]

Call the user interface print() routine, any vector.

Definition at line 1295 of file LOCA_Epetra_Group.C.

References NOX::Epetra::Vector::getEpetraVector(), and userInterface.

void LOCA::Epetra::Group::setScaleVector ( const NOX::Abstract::Vector s  ) 

Sets the scale vector.

Definition at line 1302 of file LOCA_Epetra_Group.C.

References NOX::Abstract::Vector::clone(), NOX::DeepCopy, and scaleVecPtr.

void LOCA::Epetra::Group::setJacobianOperatorForSolve ( const Teuchos::RCP< const Epetra_Operator > &  op  )  const

Sets the Jacobian operator.

Definition at line 1310 of file LOCA_Epetra_Group.C.

References NOX::SharedObject< Object, Owner >::getObject(), and NOX::Epetra::Group::sharedLinearSystem.

Teuchos::RCP< const NOX::Epetra::LinearSystem > LOCA::Epetra::Group::getComplexLinearSystem (  )  const [virtual]

Return the Linear System.

Definition at line 1328 of file LOCA_Epetra_Group.C.

References complexSharedLinearSystem.

Teuchos::RCP< NOX::Epetra::LinearSystem > LOCA::Epetra::Group::getComplexLinearSystem (  )  [virtual]

Return the Linear System.

Definition at line 1334 of file LOCA_Epetra_Group.C.

References complexSharedLinearSystem.

void LOCA::Epetra::Group::resetIsValid (  )  [protected, virtual]

resets the isValid flags to false

Reimplemented from NOX::Epetra::Group.

Definition at line 1319 of file LOCA_Epetra_Group.C.

References isValidComplex, isValidComplexPrec, and isValidShiftedPrec.

Referenced by setParam(), and setParams().


Member Data Documentation

Teuchos::ParameterList& LOCA::Epetra::Group::printParams [protected]

Printing parameters.

Definition at line 545 of file LOCA_Epetra_Group.H.

Referenced by applyComplexTransposeInverseMultiVector(), and computeComplex().

Parameter vector.

Definition at line 548 of file LOCA_Epetra_Group.H.

Referenced by computeF(), computeJacobian(), getParam(), getParams(), operator=(), setParam(), and setParams().

Interface for matrix-free shifted-matrix.

Definition at line 557 of file LOCA_Epetra_Group.H.

Referenced by applyShiftedMatrix(), and computeShiftedMatrix().

Shared shifted linear system.

Definition at line 561 of file LOCA_Epetra_Group.H.

Referenced by applyShiftedMatrix(), applyShiftedMatrixInverseMultiVector(), computeComplex(), computeShiftedMatrix(), Group(), and operator=().

bool LOCA::Epetra::Group::isValidShiftedPrec [mutable, protected]

Is preconditioner for shifted matrix valid.

Definition at line 564 of file LOCA_Epetra_Group.H.

Referenced by applyShiftedMatrixInverseMultiVector(), operator=(), and resetIsValid().

double LOCA::Epetra::Group::alpha_ [protected]

$\alpha$ for matrix-free shifted matrix

Definition at line 567 of file LOCA_Epetra_Group.H.

Referenced by applyShiftedMatrix(), computeShiftedMatrix(), and operator=().

double LOCA::Epetra::Group::beta_ [protected]

$\beta$ for matrix-free shifted matrix

Definition at line 570 of file LOCA_Epetra_Group.H.

Referenced by applyShiftedMatrix(), computeShiftedMatrix(), and operator=().

Teuchos::RCP<Epetra_Vector> LOCA::Epetra::Group::tmpVectorPtr2 [protected]

Extra vector needed for intermediate calculations of LOCA routines.

NOTE: there already is a tmpVectorPtr in the NOX::Epetra::Group. This is a second temporary vector if that one extra isn't enough.

Definition at line 576 of file LOCA_Epetra_Group.H.

Referenced by augmentJacobianForHomotopy().

Stores a pointer to the scale vector.

Definition at line 579 of file LOCA_Epetra_Group.H.

Referenced by computeScaledDotProduct(), Group(), operator=(), scaleVector(), and setScaleVector().

Stores transpose linear solver strategy.

Definition at line 582 of file LOCA_Epetra_Group.H.

Referenced by applyComplexTransposeInverseMultiVector(), applyJacobianTransposeInverse(), and applyJacobianTransposeInverseMultiVector().

Teuchos::RCP<EpetraExt::BlockCrsMatrix> LOCA::Epetra::Group::complexMatrix [protected]

Teuchos::RCP<EpetraExt::BlockVector> LOCA::Epetra::Group::complexVec [protected]

Is complex matrix valid.

Definition at line 594 of file LOCA_Epetra_Group.H.

Referenced by computeComplex(), isComplex(), operator=(), and resetIsValid().

bool LOCA::Epetra::Group::isValidComplexPrec [mutable, protected]

Is complex matrix preconditioner valid.

Definition at line 597 of file LOCA_Epetra_Group.H.

Referenced by applyComplexInverseMultiVector(), operator=(), and resetIsValid().


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

Generated on Wed Oct 21 14:28:30 2009 for Nonlinear Solver Project by  doxygen 1.5.9