NOX Development
|
Implementation of LOCA::MultiContinuation::ConstraintInterfaceMVDX for computing turning points for the minimally augmented turning point formulation. More...
#include <LOCA_TurningPoint_MinimallyAugmented_Constraint.H>
Public Member Functions | |
Constraint (const Teuchos::RCP< LOCA::GlobalData > &global_data, const Teuchos::RCP< LOCA::Parameter::SublistParser > &topParams, const Teuchos::RCP< Teuchos::ParameterList > &tpParams, const Teuchos::RCP< LOCA::TurningPoint::MinimallyAugmented::AbstractGroup > &g, int bif_param) | |
Constructor. | |
Constraint (const Constraint &source, NOX::CopyType type=NOX::DeepCopy) | |
Copy constructor. | |
virtual | ~Constraint () |
Destructor. | |
virtual void | setGroup (const Teuchos::RCP< LOCA::TurningPoint::MinimallyAugmented::AbstractGroup > &g) |
Set the group pointer. | |
virtual Teuchos::RCP< const NOX::Abstract::Vector > | getLeftNullVec () const |
Returns left null vector w. | |
virtual Teuchos::RCP< const NOX::Abstract::Vector > | getRightNullVec () const |
Returns right null vector v. | |
virtual Teuchos::RCP< const NOX::Abstract::Vector > | getAVec () const |
Returns a vector. | |
virtual Teuchos::RCP< const NOX::Abstract::Vector > | getBVec () const |
Returns b vector. | |
virtual double | getSigma () const |
Returns sigma. | |
![]() | |
ConstraintInterfaceMVDX () | |
Constructor. | |
virtual | ~ConstraintInterfaceMVDX () |
Destructor. | |
virtual const NOX::Abstract::MultiVector * | getDX () const =0 |
Return solution component of constraint derivatives. | |
virtual NOX::Abstract::Group::ReturnType | multiplyDX (double alpha, const NOX::Abstract::MultiVector &input_x, NOX::Abstract::MultiVector::DenseMatrix &result_p) const |
Compute result_p = alpha * dg/dx * input_x. | |
virtual NOX::Abstract::Group::ReturnType | addDX (Teuchos::ETransp transb, double alpha, const NOX::Abstract::MultiVector::DenseMatrix &b, double beta, NOX::Abstract::MultiVector &result_x) const |
Compute result_x = alpha * dg/dx^T * op(b) + beta * result_x. | |
![]() | |
ConstraintInterface () | |
Constructor. | |
virtual | ~ConstraintInterface () |
Destructor. | |
virtual void | copy (const ConstraintInterface &source)=0 |
Copy. | |
virtual Teuchos::RCP< LOCA::MultiContinuation::ConstraintInterface > | clone (NOX::CopyType type=NOX::DeepCopy) const =0 |
Cloning function. | |
virtual int | numConstraints () const =0 |
Return number of constraints. | |
virtual void | setX (const NOX::Abstract::Vector &x)=0 |
Set the solution vector to x. | |
virtual void | setParam (int paramID, double val)=0 |
Sets parameter indexed by paramID. | |
virtual void | setParams (const std::vector< int > ¶mIDs, const NOX::Abstract::MultiVector::DenseMatrix &vals)=0 |
Sets parameters indexed by paramIDs. | |
virtual NOX::Abstract::Group::ReturnType | computeConstraints ()=0 |
Compute constraint residuals. | |
virtual NOX::Abstract::Group::ReturnType | computeDX ()=0 |
Compute derivative of constraints w.r.t. solution vector x. | |
virtual NOX::Abstract::Group::ReturnType | computeDP (const std::vector< int > ¶mIDs, NOX::Abstract::MultiVector::DenseMatrix &dgdp, bool isValidG)=0 |
Compute derivative of constraints w.r.t. supplied parameters. | |
virtual bool | isConstraints () const =0 |
Return true if constraint residuals are valid. | |
virtual bool | isDX () const =0 |
Return true if derivative of constraint w.r.t. x is valid. | |
virtual const NOX::Abstract::MultiVector::DenseMatrix & | getConstraints () const =0 |
Return constraint residuals. | |
virtual NOX::Abstract::Group::ReturnType | multiplyDX (double alpha, const NOX::Abstract::MultiVector &input_x, NOX::Abstract::MultiVector::DenseMatrix &result_p) const =0 |
Compute result_p = alpha * dg/dx * input_x. | |
virtual NOX::Abstract::Group::ReturnType | addDX (Teuchos::ETransp transb, double alpha, const NOX::Abstract::MultiVector::DenseMatrix &b, double beta, NOX::Abstract::MultiVector &result_x) const =0 |
Compute result_x = alpha * dg/dx^T * op(b) + beta * result_x. | |
virtual bool | isDXZero () const =0 |
Return true if solution component of constraint derivatives is zero. | |
virtual void | preProcessContinuationStep (LOCA::Abstract::Iterator::StepStatus) |
Perform any preprocessing before a continuation step starts. | |
virtual void | postProcessContinuationStep (LOCA::Abstract::Iterator::StepStatus) |
Perform any postprocessing after a continuation step finishes. | |
Implementation of LOCA::MultiContinuation::ConstraintInterface | |
virtual methods | |
enum | NullVectorScaling { NVS_None , NVS_OrderOne , NVS_OrderN } |
Enumerated type determining type of scaling. More... | |
Teuchos::RCP< LOCA::GlobalData > | globalData |
Pointer LOCA global data object. | |
Teuchos::RCP< LOCA::Parameter::SublistParser > | parsedParams |
Parsed top-level parameters. | |
Teuchos::RCP< Teuchos::ParameterList > | turningPointParams |
Bifurcation parameter list. | |
Teuchos::RCP< LOCA::TurningPoint::MinimallyAugmented::AbstractGroup > | grpPtr |
Pointer to base group that defines ![]() | |
Teuchos::RCP< NOX::Abstract::MultiVector > | a_vector |
Vector for ![]() | |
Teuchos::RCP< NOX::Abstract::MultiVector > | b_vector |
Vector for ![]() | |
Teuchos::RCP< NOX::Abstract::MultiVector > | w_vector |
Stores left null vector. | |
Teuchos::RCP< NOX::Abstract::MultiVector > | v_vector |
Stores right null vector. | |
Teuchos::RCP< NOX::Abstract::MultiVector > | Jv_vector |
Stores J*v. | |
Teuchos::RCP< NOX::Abstract::MultiVector > | Jtw_vector |
Stores J^T*w. | |
Teuchos::RCP< NOX::Abstract::MultiVector > | sigma_x |
Stores sigma_x. | |
NOX::Abstract::MultiVector::DenseMatrix | constraints |
Constraint values. | |
Teuchos::RCP< LOCA::BorderedSolver::AbstractStrategy > | borderedSolver |
Stores bordered solver strategy. | |
double | dn |
Stores vector length as a double. | |
double | sigma_scale |
Stores scale factor on sigma. | |
bool | isSymmetric |
Flag indicating whether Jacobian is symmetric. | |
bool | isValidConstraints |
Flag indicating whether constraints are valid. | |
bool | isValidDX |
Flag indicating whether sigma_x is valid. | |
std::vector< int > | bifParamID |
Stores the bifurcation parameter index. | |
bool | updateVectorsEveryContinuationStep |
Flag indicating whether to update ![]() ![]() | |
bool | updateVectorsEveryIteration |
Flag indicating whether to update ![]() ![]() | |
NullVectorScaling | nullVecScaling |
Null vector scaling method. | |
bool | multiplyMass |
Multiply null vectors by mass matrix. | |
Teuchos::RCP< LOCA::TimeDependent::AbstractGroup > | tdGrp |
Time dependent group interface for multiplying by mass matrix. | |
Teuchos::RCP< NOX::Abstract::Vector > | tmp_mass |
Temporary vector for mulplying null vectors by mass matrix. | |
virtual void | copy (const LOCA::MultiContinuation::ConstraintInterface &source) |
Copy. | |
virtual Teuchos::RCP< LOCA::MultiContinuation::ConstraintInterface > | clone (NOX::CopyType type=NOX::DeepCopy) const |
Cloning function. | |
virtual int | numConstraints () const |
Return number of constraints. | |
virtual void | setX (const NOX::Abstract::Vector &y) |
Set the solution vector to y. | |
virtual void | setParam (int paramID, double val) |
Sets parameter indexed by paramID. | |
virtual void | setParams (const std::vector< int > ¶mIDs, const NOX::Abstract::MultiVector::DenseMatrix &vals) |
Sets parameters indexed by paramIDs. | |
virtual NOX::Abstract::Group::ReturnType | computeConstraints () |
Compute continuation constraint equations. | |
virtual NOX::Abstract::Group::ReturnType | computeDX () |
Compute derivative of constraints w.r.t. solution vector x. | |
virtual NOX::Abstract::Group::ReturnType | computeDP (const std::vector< int > ¶mIDs, NOX::Abstract::MultiVector::DenseMatrix &dgdp, bool isValidG) |
Compute derivative of constraints w.r.t. supplied parameters. | |
virtual bool | isConstraints () const |
Return true if constraint residuals are valid. | |
virtual bool | isDX () const |
Return true if derivatives of constraints w.r.t. x are valid. | |
virtual const NOX::Abstract::MultiVector::DenseMatrix & | getConstraints () const |
Return constraint residuals. | |
virtual const NOX::Abstract::MultiVector * | getDX () const |
Return solution component of constraint derivatives. | |
virtual bool | isDXZero () const |
Return true if solution component of constraint derivatives is zero. | |
virtual void | postProcessContinuationStep (LOCA::Abstract::Iterator::StepStatus stepStatus) |
Perform any postprocessing after a continuation step finishes. | |
virtual void | scaleNullVectors (NOX::Abstract::Vector &a, NOX::Abstract::Vector &b) |
Scale a & b vectors. | |
virtual void | getInitialVectors (NOX::Abstract::Vector &a, NOX::Abstract::Vector &b) |
Get initial a & b vectors. | |
Implementation of LOCA::MultiContinuation::ConstraintInterfaceMVDX for computing turning points for the minimally augmented turning point formulation.
This class implements the turning point constraint equation
for any vectors
The class is intialized via the tpParams
parameter list argument to the constructor. The parameters this class recognizes are:
|
virtual |
Destructor.
Reimplemented in LOCA::Pitchfork::MinimallyAugmented::Constraint.
|
virtual |
Cloning function.
Implements LOCA::MultiContinuation::ConstraintInterface.
Reimplemented in LOCA::Pitchfork::MinimallyAugmented::Constraint, and LOCA::TurningPoint::MinimallyAugmented::ModifiedConstraint.
|
virtual |
Compute continuation constraint equations.
Implements LOCA::MultiContinuation::ConstraintInterface.
Reimplemented in LOCA::Pitchfork::MinimallyAugmented::Constraint, and LOCA::TurningPoint::MinimallyAugmented::ModifiedConstraint.
References NOX::Abstract::Group::Ok, and NOX::Utils::OuterIteration.
Referenced by LOCA::Pitchfork::MinimallyAugmented::Constraint::computeConstraints().
|
virtual |
Compute derivative of constraints w.r.t. supplied parameters.
The first column of dgdp
should be filled with the constraint residuals isValidG
is false
. If isValidG
is true
, then the dgdp
contains
Implements LOCA::MultiContinuation::ConstraintInterface.
Reimplemented in LOCA::Pitchfork::MinimallyAugmented::Constraint.
References NOX::Abstract::Group::Ok.
Referenced by LOCA::Pitchfork::MinimallyAugmented::Constraint::computeDP().
|
virtual |
Compute derivative of constraints w.r.t. solution vector x.
Implements LOCA::MultiContinuation::ConstraintInterface.
Reimplemented in LOCA::Pitchfork::MinimallyAugmented::Constraint.
References NOX::Abstract::Group::Ok.
Referenced by LOCA::Pitchfork::MinimallyAugmented::Constraint::computeDX().
|
virtual |
Copy.
Implements LOCA::MultiContinuation::ConstraintInterface.
Reimplemented in LOCA::Pitchfork::MinimallyAugmented::Constraint, and LOCA::TurningPoint::MinimallyAugmented::ModifiedConstraint.
References a_vector, b_vector, bifParamID, constraints, dn, globalData, isSymmetric, isValidConstraints, isValidDX, Jtw_vector, Jv_vector, multiplyMass, nullVecScaling, parsedParams, sigma_scale, sigma_x, turningPointParams, updateVectorsEveryContinuationStep, updateVectorsEveryIteration, v_vector, and w_vector.
Referenced by LOCA::Pitchfork::MinimallyAugmented::Constraint::copy(), and LOCA::TurningPoint::MinimallyAugmented::ModifiedConstraint::copy().
|
virtual |
Return constraint residuals.
Implements LOCA::MultiContinuation::ConstraintInterface.
Reimplemented in LOCA::Pitchfork::MinimallyAugmented::Constraint.
|
virtual |
Return solution component of constraint derivatives.
Implements LOCA::MultiContinuation::ConstraintInterfaceMVDX.
Reimplemented in LOCA::Pitchfork::MinimallyAugmented::Constraint.
|
virtual |
Return true
if constraint residuals are valid.
Implements LOCA::MultiContinuation::ConstraintInterface.
|
virtual |
Return true
if derivatives of constraints w.r.t. x are valid.
Implements LOCA::MultiContinuation::ConstraintInterface.
|
virtual |
Return true
if solution component of constraint derivatives is zero.
Implements LOCA::MultiContinuation::ConstraintInterface.
|
virtual |
Return number of constraints.
Implements LOCA::MultiContinuation::ConstraintInterface.
Reimplemented in LOCA::Pitchfork::MinimallyAugmented::Constraint.
|
virtual |
Perform any postprocessing after a continuation step finishes.
The stepStatus
argument indicates whether the step was successful. Here we update the
Reimplemented from LOCA::MultiContinuation::ConstraintInterface.
Reimplemented in LOCA::TurningPoint::MinimallyAugmented::ModifiedConstraint.
References NOX::Utils::StepperDetails, and LOCA::Abstract::Iterator::Successful.
Referenced by LOCA::TurningPoint::MinimallyAugmented::ModifiedConstraint::postProcessContinuationStep().
|
virtual |
Set the group pointer.
This method should be called when ever the constrained group is copied, since we don't explicitly copy the underlying group here.
Referenced by LOCA::Pitchfork::MinimallyAugmented::Constraint::setGroup().
|
virtual |
Sets parameter indexed by paramID.
Implements LOCA::MultiContinuation::ConstraintInterface.
|
virtual |
Sets parameters indexed by paramIDs.
Implements LOCA::MultiContinuation::ConstraintInterface.
|
virtual |
Set the solution vector to y.
Implements LOCA::MultiContinuation::ConstraintInterface.