NOX Development
|
Base class for all continuation groups. More...
#include <LOCA_MultiContinuation_ExtendedGroup.H>
Public Member Functions | |
ExtendedGroup (const ExtendedGroup &source, NOX::CopyType type=NOX::DeepCopy) | |
Copy constructor. | |
virtual | ~ExtendedGroup () |
Destructor. | |
Implementation of NOX::Abstract::Group virtual methods | |
virtual NOX::Abstract::Group & | operator= (const NOX::Abstract::Group &source) |
Assignment operator. | |
virtual Teuchos::RCP< NOX::Abstract::Group > | clone (NOX::CopyType type=NOX::DeepCopy) const |
Cloning function. | |
virtual void | setX (const NOX::Abstract::Vector &y) |
Set the solution vector to y. | |
virtual void | computeX (const NOX::Abstract::Group &g, const NOX::Abstract::Vector &d, double step) |
Compute and return solution vector, x, where this.x = grp.x + step * d. | |
virtual NOX::Abstract::Group::ReturnType | computeF () |
Compute extended continuation equations. | |
virtual NOX::Abstract::Group::ReturnType | computeJacobian () |
Compute extended continuation jacobian. | |
virtual NOX::Abstract::Group::ReturnType | computeGradient () |
Gradient is not defined for this system. | |
virtual NOX::Abstract::Group::ReturnType | computeNewton (Teuchos::ParameterList ¶ms) |
Compute Newton direction for extended continuation system. | |
virtual NOX::Abstract::Group::ReturnType | applyJacobian (const NOX::Abstract::Vector &input, NOX::Abstract::Vector &result) const |
Applies Jacobian for extended system. | |
virtual NOX::Abstract::Group::ReturnType | applyJacobianTranspose (const NOX::Abstract::Vector &input, NOX::Abstract::Vector &result) const |
Jacobian transpose not defined for this system. | |
virtual NOX::Abstract::Group::ReturnType | applyJacobianInverse (Teuchos::ParameterList ¶ms, const NOX::Abstract::Vector &input, NOX::Abstract::Vector &result) const |
Applies Jacobian inverse for extended system. | |
virtual NOX::Abstract::Group::ReturnType | applyJacobianMultiVector (const NOX::Abstract::MultiVector &input, NOX::Abstract::MultiVector &result) const |
Applies Jacobian for extended system. | |
virtual NOX::Abstract::Group::ReturnType | applyJacobianTransposeMultiVector (const NOX::Abstract::MultiVector &input, NOX::Abstract::MultiVector &result) const |
Jacobian transpose not defined for this system. | |
virtual NOX::Abstract::Group::ReturnType | applyJacobianInverseMultiVector (Teuchos::ParameterList ¶ms, const NOX::Abstract::MultiVector &input, NOX::Abstract::MultiVector &result) const |
Applies Jacobian inverse for extended system. | |
virtual bool | isF () const |
Return true if extended residual is valid. | |
virtual bool | isJacobian () const |
Return true if the extended Jacobian is valid. | |
virtual bool | isGradient () const |
Always returns false. | |
virtual bool | isNewton () const |
Return true if the extended Newton direction is valid. | |
virtual const NOX::Abstract::Vector & | getX () const |
Return extended solution vector. | |
virtual const NOX::Abstract::Vector & | getF () const |
Return extended residual. | |
virtual double | getNormF () const |
Return 2-norm of extended residual. | |
virtual const NOX::Abstract::Vector & | getGradient () const |
Gradient is never valid. | |
virtual const NOX::Abstract::Vector & | getNewton () const |
Return extended Newton direction. | |
virtual Teuchos::RCP< const NOX::Abstract::Vector > | getXPtr () const |
Return extended solution vector. | |
virtual Teuchos::RCP< const NOX::Abstract::Vector > | getFPtr () const |
Return extended residual. | |
virtual Teuchos::RCP< const NOX::Abstract::Vector > | getGradientPtr () const |
Gradient is never valid. | |
virtual Teuchos::RCP< const NOX::Abstract::Vector > | getNewtonPtr () const |
Return extended Newton direction. | |
virtual double | getNormNewtonSolveResidual () const |
Returns 2-norm of extended Newton solve residual. | |
Implementation of LOCA::Extended::MultiAbstractGroup | |
virtual methods | |
virtual Teuchos::RCP< const LOCA::MultiContinuation::AbstractGroup > | getUnderlyingGroup () const |
Return underlying group. | |
virtual Teuchos::RCP< LOCA::MultiContinuation::AbstractGroup > | getUnderlyingGroup () |
Return underlying group. | |
Implementation of LOCA::MultiContinuation::AbstractStrategy | |
virtual methods | |
virtual void | copy (const NOX::Abstract::Group &source) |
Assignment operator. | |
virtual int | getNumParams () const |
Returns number of parameters. | |
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 NOX::Abstract::Group::ReturnType | computePredictor () |
Compute predictor directions. | |
virtual bool | isPredictor () const |
Is Predictor valid. | |
virtual void | scaleTangent () |
Scales tangent to predictor. | |
virtual void | setPredictorTangentDirection (const LOCA::MultiContinuation::ExtendedVector &v, int i) |
Sets tangent to predictor. | |
virtual const LOCA::MultiContinuation::ExtendedMultiVector & | getPredictorTangent () const |
Returns tangent to predictor. | |
virtual const LOCA::MultiContinuation::ExtendedMultiVector & | getScaledPredictorTangent () const |
Returns scaled tangent to predictor. | |
virtual void | setPrevX (const NOX::Abstract::Vector &y) |
Set the previous solution vector y. | |
virtual const LOCA::MultiContinuation::ExtendedVector & | getPrevX () const |
Gets the previous solution vector. | |
virtual void | setStepSize (double deltaS, int i=0) |
Set step size for continuation constraint equation i. | |
virtual double | getStepSize (int i=0) const |
Get step size for continuation constraint equation i. | |
virtual void | setContinuationParameter (double val, int i=0) |
Sets the value for continuation parameter i. | |
virtual double | getContinuationParameter (int i=0) const |
Returns the value for continuation parameter i. | |
virtual int | getContinuationParameterID (int i=0) const |
Get the continuation parameter id for parameter i. | |
virtual const std::vector< int > & | getContinuationParameterIDs () const |
Get the continuation parameter ids. | |
virtual std::string | getContinuationParameterName (int i=0) const |
Get the continuation parameter id for parameter i. | |
virtual double | getStepSizeScaleFactor (int i=0) const |
Returns step size scale factor for constraint equation i. | |
virtual void | printSolution () const |
Prints the group. | |
virtual double | computeScaledDotProduct (const NOX::Abstract::Vector &x, const NOX::Abstract::Vector &y) const |
Computes a scaled dot product between two continuation vectors. | |
virtual int | projectToDrawDimension () const |
Returns dimension of project to draw array. | |
virtual void | projectToDraw (const LOCA::MultiContinuation::ExtendedVector &x, double *px) const |
Fills the project to draw array. | |
![]() | |
AbstractStrategy () | |
Constructor. | |
virtual | ~AbstractStrategy () |
Destructor. | |
virtual void | copy (const NOX::Abstract::Group &source)=0 |
Copy. | |
virtual int | getNumParams () const =0 |
Returns number of parameters. | |
virtual void | preProcessContinuationStep (LOCA::Abstract::Iterator::StepStatus stepStatus)=0 |
Perform any preprocessing before a continuation step starts. | |
virtual void | postProcessContinuationStep (LOCA::Abstract::Iterator::StepStatus stepStatus)=0 |
Perform any postprocessing after a continuation step finishes. | |
virtual NOX::Abstract::Group::ReturnType | computePredictor ()=0 |
Compute predictor directions. | |
virtual bool | isPredictor () const =0 |
Is Predictor valid. | |
virtual void | scaleTangent ()=0 |
Scales tangent to predictor. | |
virtual void | setPredictorTangentDirection (const LOCA::MultiContinuation::ExtendedVector &v, int i)=0 |
Sets tangent to predictor. | |
virtual const LOCA::MultiContinuation::ExtendedMultiVector & | getPredictorTangent () const =0 |
Returns tangent to predictor. | |
virtual const LOCA::MultiContinuation::ExtendedMultiVector & | getScaledPredictorTangent () const =0 |
Returns scaled tangent to predictor. | |
virtual void | setPrevX (const NOX::Abstract::Vector &y)=0 |
Set the previous solution vector y. | |
virtual const LOCA::MultiContinuation::ExtendedVector & | getPrevX () const =0 |
Gets the previous solution vector. | |
virtual void | setStepSize (double deltaS, int i=0)=0 |
Set step size for continuation constraint equation i. | |
virtual double | getStepSize (int i=0) const =0 |
Get step size for continuation constraint equation i. | |
virtual void | setContinuationParameter (double val, int i=0)=0 |
Sets the value for continuation parameter i. | |
virtual double | getContinuationParameter (int i=0) const =0 |
Returns the value for continuation parameter i. | |
virtual int | getContinuationParameterID (int i=0) const =0 |
Get the continuation parameter id for parameter i. | |
virtual const std::vector< int > & | getContinuationParameterIDs () const =0 |
Get the continuation parameter ids. | |
virtual std::string | getContinuationParameterName (int i=0) const =0 |
Get the continuation parameter id for parameter i. | |
virtual double | getStepSizeScaleFactor (int i=0) const =0 |
Returns step size scale factor for constraint equation i. | |
virtual void | printSolution () const =0 |
Prints the group. | |
virtual double | computeScaledDotProduct (const NOX::Abstract::Vector &x, const NOX::Abstract::Vector &y) const =0 |
Computes a scaled dot product between two continuation vectors. | |
virtual int | projectToDrawDimension () const =0 |
Returns dimension of project to draw array. | |
virtual void | projectToDraw (const LOCA::MultiContinuation::ExtendedVector &x, double *px) const =0 |
Fills the project to draw array. | |
![]() | |
MultiAbstractGroup () | |
Default constructor. | |
virtual | ~MultiAbstractGroup () |
Destructor. | |
virtual Teuchos::RCP< const LOCA::MultiContinuation::AbstractGroup > | getBaseLevelUnderlyingGroup () const |
Return base-level underlying group. | |
virtual Teuchos::RCP< LOCA::MultiContinuation::AbstractGroup > | getBaseLevelUnderlyingGroup () |
Return base-level underlying group. | |
![]() | |
Group () | |
Constructor. | |
virtual | ~Group () |
Destructor. | |
virtual NOX::Abstract::Group & | operator= (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 ¶ms) |
Compute the Newton direction, using parameters for the linear solve. | |
virtual NOX::Abstract::Group::ReturnType | applyRightPreconditioning (bool useTranspose, Teuchos::ParameterList ¶ms, const NOX::Abstract::Vector &input, NOX::Abstract::Vector &result) const |
Apply right preconditiong to the given input vector. | |
virtual NOX::Abstract::Group::ReturnType | applyRightPreconditioningMultiVector (bool useTranspose, Teuchos::ParameterList ¶ms, const NOX::Abstract::MultiVector &input, NOX::Abstract::MultiVector &result) const |
applyRightPreconditioning for multiple right-hand sides | |
virtual const NOX::Abstract::Vector & | getScaledX () const |
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(). | |
![]() | |
AbstractGroup () | |
Constructor. | |
virtual | ~AbstractGroup () |
Destructor. | |
Implementation of | |
LOCA::BorderedSystem::AbstractGroup virtual methods | |
Teuchos::RCP< LOCA::GlobalData > | globalData |
Pointer LOCA global data object. | |
Teuchos::RCP< LOCA::Parameter::SublistParser > | parsedParams |
Parsed top-level parameters. | |
Teuchos::RCP< Teuchos::ParameterList > | continuationParams |
Continuation parameter list. | |
Teuchos::RCP< LOCA::MultiContinuation::AbstractGroup > | grpPtr |
Pointer to underlying group. | |
Teuchos::RCP< LOCA::MultiPredictor::AbstractStrategy > | predictor |
Pointer to predictor object. | |
Teuchos::RCP< LOCA::MultiContinuation::ConstrainedGroup > | conGroup |
Pointer to constrained group implementation. | |
int | numParams |
Number of parameters. | |
LOCA::MultiContinuation::ExtendedMultiVector | tangentMultiVec |
Stores the tangent to the predictor. | |
LOCA::MultiContinuation::ExtendedMultiVector | scaledTangentMultiVec |
Stores the scaled tangent to the predictor. | |
LOCA::MultiContinuation::ExtendedVector | prevXVec |
Stores the previous extended solution vector. | |
std::vector< int > | conParamIDs |
integer id of continuation parameters | |
std::vector< double > | stepSize |
continuation step size | |
std::vector< double > | stepSizeScaleFactor |
step size scale factors | |
bool | isValidPredictor |
Is Predictor vector valid. | |
bool | baseOnSecant |
Flag indicating whether to base predictor direction on secant. | |
virtual int | getBorderedWidth () const |
Return the total width of the bordered rows/columns. | |
virtual Teuchos::RCP< const NOX::Abstract::Group > | getUnborderedGroup () const |
Get bottom-level unbordered group. | |
virtual bool | isCombinedAZero () const |
Indicates whether combined A block is zero. | |
virtual bool | isCombinedBZero () const |
Indicates whether combined B block is zero. | |
virtual bool | isCombinedCZero () const |
Indicates whether combined C block is zero. | |
virtual void | extractSolutionComponent (const NOX::Abstract::MultiVector &v, NOX::Abstract::MultiVector &v_x) const |
virtual void | extractParameterComponent (bool use_transpose, const NOX::Abstract::MultiVector &v, NOX::Abstract::MultiVector::DenseMatrix &v_p) const |
virtual void | loadNestedComponents (const NOX::Abstract::MultiVector &v_x, const NOX::Abstract::MultiVector::DenseMatrix &v_p, NOX::Abstract::MultiVector &v) const |
virtual void | fillA (NOX::Abstract::MultiVector &A) const |
Fill the combined A block as described above. | |
virtual void | fillB (NOX::Abstract::MultiVector &B) const |
Fill the combined B block as described above. | |
virtual void | fillC (NOX::Abstract::MultiVector::DenseMatrix &C) const |
Fill the combined C block as described above. | |
ExtendedGroup (const Teuchos::RCP< LOCA::GlobalData > &global_data, const Teuchos::RCP< LOCA::Parameter::SublistParser > &topParams, const Teuchos::RCP< Teuchos::ParameterList > &continuationParams, const Teuchos::RCP< LOCA::MultiContinuation::AbstractGroup > &grp, const Teuchos::RCP< LOCA::MultiPredictor::AbstractStrategy > &pred, const std::vector< int > ¶mIDs) | |
Constructor used by derived classes. | |
virtual void | setConstraints (const Teuchos::RCP< LOCA::MultiContinuation::ConstraintInterface > &constraints, bool skip_dfdp) |
Set constraint object. | |
Additional Inherited Members | |
![]() | |
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... | |
Base class for all continuation groups.
Continuation is defined as computing some curve
for
Mathematically, this computation amounts to repeatedly computing solutions to a constrained nonlinear system. This class provides a common implementation for all continuation groups in terms of the LOCA::MultiContinuation::ConstrainedGroup using a supplied group to represent
Note that this class has no public constructor other than the copy constructor since it is intended to only provide an implemenation of much of the continuation work. Each derived class that implements a specific continuation strategy should provide its own public constructor.
|
virtual |
Applies Jacobian for extended system.
Reimplemented from NOX::Abstract::Group.
|
virtual |
Applies Jacobian inverse for extended system.
Reimplemented from NOX::Abstract::Group.
|
virtual |
Applies Jacobian inverse for extended system.
Reimplemented from NOX::Abstract::Group.
|
virtual |
Applies Jacobian for extended system.
Reimplemented from NOX::Abstract::Group.
|
virtual |
Jacobian transpose not defined for this system.
Reimplemented from NOX::Abstract::Group.
|
virtual |
Jacobian transpose not defined for this system.
Reimplemented from NOX::Abstract::Group.
|
virtual |
Cloning function.
Implements NOX::Abstract::Group.
Reimplemented in LOCA::MultiContinuation::ArcLengthGroup, and LOCA::MultiContinuation::NaturalGroup.
|
virtual |
Compute extended continuation equations.
Implements NOX::Abstract::Group.
|
virtual |
Gradient is not defined for this system.
Reimplemented from NOX::Abstract::Group.
|
virtual |
Compute extended continuation jacobian.
Reimplemented from NOX::Abstract::Group.
|
virtual |
Compute Newton direction for extended continuation system.
Reimplemented from NOX::Abstract::Group.
|
virtual |
Compute predictor directions.
Implements LOCA::MultiContinuation::AbstractStrategy.
References NOX::Abstract::Group::Ok.
|
virtual |
Computes a scaled dot product between two continuation vectors.
Implements LOCA::MultiContinuation::AbstractStrategy.
Reimplemented in LOCA::MultiContinuation::ArcLengthGroup.
References LOCA::Extended::Vector::getScalar(), and LOCA::MultiContinuation::ExtendedVector::getXVec().
Referenced by LOCA::MultiPredictor::AbstractStrategy::setPredictorOrientation().
|
virtual |
Compute and return solution vector, x, where this.x = grp.x + step * d.
Implements NOX::Abstract::Group.
References computeX(), and conGroup.
Referenced by computeX().
|
virtual |
Assignment operator.
Implements LOCA::MultiContinuation::AbstractStrategy.
Reimplemented in LOCA::MultiContinuation::ArcLengthGroup, and LOCA::MultiContinuation::NaturalGroup.
References baseOnSecant, conGroup, conParamIDs, continuationParams, globalData, isValidPredictor, numParams, parsedParams, predictor, prevXVec, scaledTangentMultiVec, stepSize, stepSizeScaleFactor, and tangentMultiVec.
Referenced by LOCA::MultiContinuation::ArcLengthGroup::copy(), and LOCA::MultiContinuation::NaturalGroup::copy().
|
virtual |
Given the vector v
, extract the parameter components of all of the nested subvectors in v
down to the solution component for the unbordered group.
Implements LOCA::BorderedSystem::AbstractGroup.
|
virtual |
Given the vector v
, extract the underlying solution component corresponding to the unbordered group.
Implements LOCA::BorderedSystem::AbstractGroup.
|
virtual |
Fill the combined A block as described above.
Implements LOCA::BorderedSystem::AbstractGroup.
|
virtual |
Fill the combined B block as described above.
Implements LOCA::BorderedSystem::AbstractGroup.
|
virtual |
Fill the combined C block as described above.
Implements LOCA::BorderedSystem::AbstractGroup.
|
virtual |
Return the total width of the bordered rows/columns.
Implements LOCA::BorderedSystem::AbstractGroup.
|
virtual |
Returns the value for continuation parameter i.
Implements LOCA::MultiContinuation::AbstractStrategy.
|
virtual |
Get the continuation parameter id for parameter i.
Implements LOCA::MultiContinuation::AbstractStrategy.
|
virtual |
Get the continuation parameter ids.
Implements LOCA::MultiContinuation::AbstractStrategy.
Referenced by LOCA::MultiPredictor::Tangent::compute().
|
virtual |
Get the continuation parameter id for parameter i.
Implements LOCA::MultiContinuation::AbstractStrategy.
References LOCA::ParameterVector::getLabel().
|
virtual |
Return extended residual.
Implements NOX::Abstract::Group.
|
virtual |
Return extended residual.
Implements NOX::Abstract::Group.
|
virtual |
Gradient is never valid.
Implements NOX::Abstract::Group.
|
virtual |
Gradient is never valid.
Implements NOX::Abstract::Group.
|
virtual |
Return extended Newton direction.
Implements NOX::Abstract::Group.
|
virtual |
Return extended Newton direction.
Implements NOX::Abstract::Group.
|
virtual |
Return 2-norm of extended residual.
Implements NOX::Abstract::Group.
|
virtual |
Returns number of parameters.
Implements LOCA::MultiContinuation::AbstractStrategy.
|
virtual |
Returns tangent to predictor.
Implements LOCA::MultiContinuation::AbstractStrategy.
|
virtual |
Gets the previous solution vector.
Implements LOCA::MultiContinuation::AbstractStrategy.
|
virtual |
Returns scaled tangent to predictor.
Implements LOCA::MultiContinuation::AbstractStrategy.
|
virtual |
Get step size for continuation constraint equation i.
Implements LOCA::MultiContinuation::AbstractStrategy.
|
virtual |
Returns step size scale factor for constraint equation i.
Implements LOCA::MultiContinuation::AbstractStrategy.
|
virtual |
Get bottom-level unbordered group.
Implements LOCA::BorderedSystem::AbstractGroup.
|
virtual |
Return underlying group.
Implements LOCA::Extended::MultiAbstractGroup.
|
virtual |
Return underlying group.
Implements LOCA::Extended::MultiAbstractGroup.
Referenced by LOCA::Epetra::AdaptiveStepper::adapt(), LOCA::AdaptiveStepper::adapt(), LOCA::MultiPredictor::Tangent::compute(), LOCA::MultiStepper::run(), LOCA::Epetra::AdaptiveStepper::start(), LOCA::AdaptiveStepper::start(), and LOCA::Stepper::start().
|
virtual |
Return extended solution vector.
Implements NOX::Abstract::Group.
|
virtual |
Return extended solution vector.
Implements NOX::Abstract::Group.
|
virtual |
Indicates whether combined A block is zero.
Implements LOCA::BorderedSystem::AbstractGroup.
|
virtual |
Indicates whether combined B block is zero.
Implements LOCA::BorderedSystem::AbstractGroup.
|
virtual |
Indicates whether combined C block is zero.
Implements LOCA::BorderedSystem::AbstractGroup.
|
virtual |
Return true
if extended residual is valid.
Implements NOX::Abstract::Group.
|
virtual |
Always returns false.
Reimplemented from NOX::Abstract::Group.
|
virtual |
Return true
if the extended Jacobian is valid.
Reimplemented from NOX::Abstract::Group.
|
virtual |
Return true
if the extended Newton direction is valid.
Reimplemented from NOX::Abstract::Group.
|
virtual |
Is Predictor valid.
Implements LOCA::MultiContinuation::AbstractStrategy.
|
virtual |
Given the solution component v_x
and combined parameter components v_p
, distribute these components through the nested sub-vectors in v
.
Implements LOCA::BorderedSystem::AbstractGroup.
|
virtual |
Assignment operator.
Implements NOX::Abstract::Group.
Reimplemented in LOCA::MultiContinuation::ArcLengthGroup, and LOCA::MultiContinuation::NaturalGroup.
|
virtual |
Perform any postprocessing after a continuation step finishes.
The stepStatus
argument indicates whether the step was successful.
Implements LOCA::MultiContinuation::AbstractStrategy.
References LOCA::Abstract::Iterator::Successful.
|
virtual |
Perform any preprocessing before a continuation step starts.
The stepStatus
argument indicates whether the previous step was successful.
Implements LOCA::MultiContinuation::AbstractStrategy.
|
virtual |
Prints the group.
Implements LOCA::MultiContinuation::AbstractStrategy.
|
virtual |
Fills the project to draw array.
Implements LOCA::MultiContinuation::AbstractStrategy.
References LOCA::Extended::Vector::getScalar(), and LOCA::MultiContinuation::ExtendedVector::getXVec().
|
virtual |
Returns dimension of project to draw array.
Implements LOCA::MultiContinuation::AbstractStrategy.
|
virtual |
Scales tangent to predictor.
Implements LOCA::MultiContinuation::AbstractStrategy.
Reimplemented in LOCA::MultiContinuation::ArcLengthGroup.
References LOCA::MultiContinuation::ExtendedVector::getXVec().
|
protectedvirtual |
Set constraint object.
This allows the constraint object to be set after the group is constructed using the above constructor.
Referenced by LOCA::MultiContinuation::ArcLengthGroup::ArcLengthGroup(), and LOCA::MultiContinuation::NaturalGroup::NaturalGroup().
|
virtual |
Sets the value for continuation parameter i.
Implements LOCA::MultiContinuation::AbstractStrategy.
|
virtual |
Sets tangent to predictor.
This is required by MF which takes the tangent space, orthogonalizes it, and then sets it back in the group.
Implements LOCA::MultiContinuation::AbstractStrategy.
|
virtual |
Set the previous solution vector y.
Implements LOCA::MultiContinuation::AbstractStrategy.
|
virtual |
Set step size for continuation constraint equation i.
Implements LOCA::MultiContinuation::AbstractStrategy.
|
virtual |
Set the solution vector to y.
Implements NOX::Abstract::Group.