NOX Development
Loading...
Searching...
No Matches
Public Member Functions | List of all members
LOCA::TurningPoint::MinimallyAugmented::AbstractGroup Class Referenceabstract

Interface to underlying groups for turning point calculations using the minimally augmented formulation. More...

#include <LOCA_TurningPoint_MinimallyAugmented_AbstractGroup.H>

Inheritance diagram for LOCA::TurningPoint::MinimallyAugmented::AbstractGroup:
Inheritance graph
[legend]
Collaboration diagram for LOCA::TurningPoint::MinimallyAugmented::AbstractGroup:
Collaboration graph
[legend]

Public Member Functions

 AbstractGroup ()
 Default constructor.
 
virtual ~AbstractGroup ()
 Destructor.
 
Pure virtual methods

These methods must be defined by any concrete implementation

virtual NOX::Abstract::Group::ReturnType computeDwtJnDp (const std::vector< int > &paramIDs, const NOX::Abstract::Vector &w, const NOX::Abstract::Vector &nullVector, NOX::Abstract::MultiVector::DenseMatrix &result, bool isValid)=0
 Computes the derivative $\partial w^TJn/\partial p$.
 
virtual NOX::Abstract::Group::ReturnType computeDwtJDp (const std::vector< int > &paramIDs, const NOX::Abstract::Vector &w, NOX::Abstract::MultiVector &result, bool isValid)=0
 Computes the derivative $\partial w^TJ/\partial p$.
 
virtual NOX::Abstract::Group::ReturnType computeDwtJnDx (const NOX::Abstract::Vector &w, const NOX::Abstract::Vector &nullVector, NOX::Abstract::Vector &result)=0
 Computes the derivative $\frac{\partial w^TJn}{\partial x}$.
 
- Public Member Functions inherited from LOCA::TurningPoint::MooreSpence::AbstractGroup
 AbstractGroup ()
 Default constructor.
 
virtual NOX::Abstract::Group::ReturnType computeDJnDpMulti (const std::vector< int > &paramIDs, const NOX::Abstract::Vector &nullVector, NOX::Abstract::MultiVector &result, bool isValid)=0
 Computes the derivative $\partial Jn/\partial p$.
 
virtual NOX::Abstract::Group::ReturnType computeDJnDxaMulti (const NOX::Abstract::Vector &nullVector, const NOX::Abstract::MultiVector &aVector, NOX::Abstract::MultiVector &result)=0
 Computes the directional derivative $\frac{\partial Jn}{\partial x} a$ for the given direction $ a$.
 
virtual NOX::Abstract::Group::ReturnType computeDJnDxaMulti (const NOX::Abstract::Vector &nullVector, const NOX::Abstract::Vector &JnVector, const NOX::Abstract::MultiVector &aVector, NOX::Abstract::MultiVector &result)=0
 Computes the directional derivative $\frac{\partial Jn}{\partial x} a$ for the given direction $ a$.
 
virtual NOX::Abstract::Group::ReturnType computeDwtJnDxMulti (const NOX::Abstract::MultiVector &w, const NOX::Abstract::Vector &nullVector, NOX::Abstract::MultiVector &result)=0
 Computes the derivative $\frac{\partial w^TJn}{\partial x}$.
 
- Public Member Functions inherited from LOCA::MultiContinuation::AbstractGroup
 AbstractGroup ()
 Default constructor.
 
virtual void copy (const NOX::Abstract::Group &source)=0
 Copy the group (replaces operator = )
 
virtual void setParamsMulti (const std::vector< int > &paramIDs, const NOX::Abstract::MultiVector::DenseMatrix &vals)=0
 Set parameters indexed by (integer) paramIDs.
 
virtual void setParams (const LOCA::ParameterVector &p)=0
 Set the parameter vector in the group to p (pVector = p).
 
virtual void setParam (int paramID, double val)=0
 Set parameter indexed by (integer) paramID.
 
virtual void setParam (std::string paramID, double val)=0
 Set parameter indexed by (std::string) paramID.
 
virtual const LOCA::ParameterVectorgetParams () const =0
 Return a const reference to the ParameterVector owned by the group.
 
virtual double getParam (int paramID) const =0
 Return copy of parameter indexed by (integer) paramID.
 
virtual double getParam (std::string paramID) const =0
 Return copy of parameter indexed by (std::string) paramID.
 
virtual NOX::Abstract::Group::ReturnType computeDfDpMulti (const std::vector< int > &paramIDs, NOX::Abstract::MultiVector &dfdp, bool isValidF)=0
 
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) const
 Function to print out solution and parameter after successful step.
 
virtual void printSolution (const NOX::Abstract::Vector &, const double) const
 Function to print out a vector and parameter after successful step.
 
virtual void scaleVector (NOX::Abstract::Vector &x) const
 Scales a vector using scaling vector.
 
- Public Member Functions inherited from NOX::Abstract::Group
 Group ()
 Constructor.
 
virtual ~Group ()
 Destructor.
 
virtual NOX::Abstract::Groupoperator= (const NOX::Abstract::Group &source)=0
 Copies the source group into this group.
 
virtual void setX (const NOX::Abstract::Vector &y)=0
 Set the solution vector x to y.
 
virtual void computeX (const NOX::Abstract::Group &grp, const NOX::Abstract::Vector &d, double step)=0
 Compute x = grp.x + step * d.
 
virtual NOX::Abstract::Group::ReturnType computeF ()=0
 Compute and store F(x).
 
virtual NOX::Abstract::Group::ReturnType computeJacobian ()
 Compute and store Jacobian.
 
virtual NOX::Abstract::Group::ReturnType computeGradient ()
 Compute and store gradient.
 
virtual NOX::Abstract::Group::ReturnType computeNewton (Teuchos::ParameterList &params)
 Compute the Newton direction, using parameters for the linear solve.
 
virtual NOX::Abstract::Group::ReturnType applyJacobian (const NOX::Abstract::Vector &input, NOX::Abstract::Vector &result) const
 Applies Jacobian to the given input vector and puts the answer in the result.
 
virtual NOX::Abstract::Group::ReturnType applyJacobianTranspose (const NOX::Abstract::Vector &input, NOX::Abstract::Vector &result) const
 Applies Jacobian-Transpose to the given input vector and puts the answer in the result.
 
virtual NOX::Abstract::Group::ReturnType applyJacobianInverse (Teuchos::ParameterList &params, const NOX::Abstract::Vector &input, NOX::Abstract::Vector &result) const
 Applies the inverse of the Jacobian matrix to the given input vector and puts the answer in result.
 
virtual NOX::Abstract::Group::ReturnType applyRightPreconditioning (bool useTranspose, Teuchos::ParameterList &params, const NOX::Abstract::Vector &input, NOX::Abstract::Vector &result) const
 Apply right preconditiong to the given input vector.
 
virtual NOX::Abstract::Group::ReturnType applyJacobianMultiVector (const NOX::Abstract::MultiVector &input, NOX::Abstract::MultiVector &result) const
 applyJacobian for multiple right-hand sides
 
virtual NOX::Abstract::Group::ReturnType applyJacobianTransposeMultiVector (const NOX::Abstract::MultiVector &input, NOX::Abstract::MultiVector &result) const
 applyJacobianTranspose for multiple right-hand sides
 
virtual NOX::Abstract::Group::ReturnType applyJacobianInverseMultiVector (Teuchos::ParameterList &params, const NOX::Abstract::MultiVector &input, NOX::Abstract::MultiVector &result) const
 applyJacobianInverse for multiple right-hand sides
 
virtual NOX::Abstract::Group::ReturnType applyRightPreconditioningMultiVector (bool useTranspose, Teuchos::ParameterList &params, const NOX::Abstract::MultiVector &input, NOX::Abstract::MultiVector &result) const
 applyRightPreconditioning for multiple right-hand sides
 
virtual bool isF () const =0
 Return true if F is valid.
 
virtual bool isJacobian () const
 Return true if the Jacobian is valid.
 
virtual bool isGradient () const
 Return true if the gradient is valid.
 
virtual bool isNewton () const
 Return true if the Newton direction is valid.
 
virtual const NOX::Abstract::VectorgetX () const =0
 Return solution vector.
 
virtual const NOX::Abstract::VectorgetScaledX () const
 
virtual const NOX::Abstract::VectorgetF () const =0
 Return F(x)
 
virtual double getNormF () const =0
 Return 2-norm of F(x).
 
virtual const NOX::Abstract::VectorgetGradient () const =0
 Return gradient.
 
virtual const NOX::Abstract::VectorgetNewton () const =0
 Return Newton direction.
 
virtual Teuchos::RCP< const NOX::Abstract::VectorgetXPtr () const =0
 Return RCP to solution vector.
 
virtual Teuchos::RCP< const NOX::Abstract::VectorgetFPtr () const =0
 Return RCP to F(x)
 
virtual Teuchos::RCP< const NOX::Abstract::VectorgetGradientPtr () const =0
 Return RCP to gradient.
 
virtual Teuchos::RCP< const NOX::Abstract::VectorgetNewtonPtr () const =0
 Return RCP to Newton direction.
 
virtual void logLastLinearSolveStats (NOX::SolverStats &stats) const
 Adds statistics from last linear solve to the SovlerStats object.
 
virtual NOX::Abstract::Group::ReturnType getNormLastLinearSolveResidual (double &residual) const
 Return the norm of the last linear solve residual as the result of either a call to computeNewton() or applyJacobianInverse().
 
virtual Teuchos::RCP< NOX::Abstract::Groupclone (NOX::CopyType type=NOX::DeepCopy) const =0
 Create a new Group of the same derived type as this one by cloning this one, and return a ref count pointer to the new group.
 

Additional Inherited Members

- Public Types inherited from NOX::Abstract::Group
enum  ReturnType {
  Ok , NotDefined , BadDependency , NotConverged ,
  Failed
}
 The computation of, say, the Newton direction in computeNewton() may fail in many different ways, so we have included a variety of return codes to describe the failures. Of course, we also have a code for success. More...
 

Detailed Description

Interface to underlying groups for turning point calculations using the minimally augmented formulation.

This abstract class provides the required interface for underlying groups to locate turning points using the minimally augmented turning point formulation (see LOCA::TurningPoint::MinimallyAugmented::ExtendedGroup for a description of the governing equations).

This class is derived from the LOCA::TurningPoint::MooreSpence::AbstractGroup and declares several pure virtual methods compute various derivatives of $ w^TJn$ for a given $ w$ and $ n$. Default implementations for the derivatives using finite differencing are implemented in the LOCA::TurningPoint::MinimallyAugmented::FiniteDifferenceGroup.

Constructor & Destructor Documentation

◆ ~AbstractGroup()

virtual LOCA::TurningPoint::MinimallyAugmented::AbstractGroup::~AbstractGroup ( )
inlinevirtual

Member Function Documentation

◆ computeDwtJDp()

virtual NOX::Abstract::Group::ReturnType LOCA::TurningPoint::MinimallyAugmented::AbstractGroup::computeDwtJDp ( const std::vector< int > & paramIDs,
const NOX::Abstract::Vector & w,
NOX::Abstract::MultiVector & result,
bool isValid )
pure virtual

Computes the derivative $\partial w^TJ/\partial p$.

Implemented in LOCA::TurningPoint::MinimallyAugmented::FiniteDifferenceGroup.

◆ computeDwtJnDp()

virtual NOX::Abstract::Group::ReturnType LOCA::TurningPoint::MinimallyAugmented::AbstractGroup::computeDwtJnDp ( const std::vector< int > & paramIDs,
const NOX::Abstract::Vector & w,
const NOX::Abstract::Vector & nullVector,
NOX::Abstract::MultiVector::DenseMatrix & result,
bool isValid )
pure virtual

Computes the derivative $\partial w^TJn/\partial p$.

Implemented in LOCA::TurningPoint::MinimallyAugmented::FiniteDifferenceGroup.

◆ computeDwtJnDx()

virtual NOX::Abstract::Group::ReturnType LOCA::TurningPoint::MinimallyAugmented::AbstractGroup::computeDwtJnDx ( const NOX::Abstract::Vector & w,
const NOX::Abstract::Vector & nullVector,
NOX::Abstract::Vector & result )
pure virtual

Computes the derivative $\frac{\partial w^TJn}{\partial x}$.

Implemented in LOCA::TurningPoint::MinimallyAugmented::FiniteDifferenceGroup.


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