NOX
Development
|
Concrete class that provides concrete implementations of the derivative computation methods of the LOCA::TurningPoint::MooreSpence::AbstractGroup using first-order finite differencing. More...
#include <LOCA_TurningPoint_MooreSpence_FiniteDifferenceGroup.H>
Public Member Functions | |
FiniteDifferenceGroup () | |
Constructor. | |
FiniteDifferenceGroup (const FiniteDifferenceGroup &source, NOX::CopyType type=NOX::DeepCopy) | |
Copy constructor. | |
virtual | ~FiniteDifferenceGroup () |
Destructor. | |
virtual NOX::Abstract::Group::ReturnType | computeDJnDpMulti (const std::vector< int > ¶mIDs, const NOX::Abstract::Vector &nullVector, NOX::Abstract::MultiVector &result, bool isValid) |
Computes the derivative . More... | |
virtual NOX::Abstract::Group::ReturnType | computeDJnDxaMulti (const NOX::Abstract::Vector &nullVector, const NOX::Abstract::MultiVector &aVector, NOX::Abstract::MultiVector &result) |
Computes the directional derivative for the given direction . More... | |
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) |
Computes the directional derivative for the given direction . More... | |
virtual NOX::Abstract::Group::ReturnType | computeDwtJnDxMulti (const NOX::Abstract::MultiVector &w, const NOX::Abstract::Vector &nullVector, NOX::Abstract::MultiVector &result) |
Computes the derivative . More... | |
Public Member Functions inherited from LOCA::TurningPoint::MooreSpence::AbstractGroup | |
AbstractGroup () | |
Default constructor. | |
virtual | ~AbstractGroup () |
Destructor. | |
Public Member Functions inherited from LOCA::MultiContinuation::AbstractGroup | |
AbstractGroup () | |
Default constructor. | |
virtual void | setParamsMulti (const std::vector< int > ¶mIDs, 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::ParameterVector & | getParams () 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 void | preProcessContinuationStep (LOCA::Abstract::Iterator::StepStatus stepStatus) |
Perform any preprocessing before a continuation step starts. More... | |
virtual void | postProcessContinuationStep (LOCA::Abstract::Iterator::StepStatus stepStatus) |
Perform any postprocessing after a continuation step finishes. More... | |
virtual void | projectToDraw (const NOX::Abstract::Vector &x, double *px) const |
Projects solution to a few scalars for multiparameter continuation. More... | |
virtual int | projectToDrawDimension () const |
Returns the dimension of the project to draw array. More... | |
virtual double | computeScaledDotProduct (const NOX::Abstract::Vector &a, const NOX::Abstract::Vector &b) const |
Compute a scaled dot product. More... | |
virtual void | printSolution (const double) const |
Function to print out solution and parameter after successful step. More... | |
virtual void | printSolution (const NOX::Abstract::Vector &, const double) const |
Function to print out a vector and parameter after successful step. More... | |
virtual void | scaleVector (NOX::Abstract::Vector &x) const |
Scales a vector using scaling vector. More... | |
Public Member Functions inherited from NOX::Abstract::Group | |
Group () | |
Constructor. More... | |
virtual | ~Group () |
Destructor. | |
virtual void | setX (const NOX::Abstract::Vector &y)=0 |
Set the solution vector x to y. More... | |
virtual void | computeX (const NOX::Abstract::Group &grp, const NOX::Abstract::Vector &d, double step)=0 |
Compute x = grp.x + step * d. More... | |
virtual NOX::Abstract::Group::ReturnType | computeF ()=0 |
Compute and store F(x). More... | |
virtual NOX::Abstract::Group::ReturnType | computeJacobian () |
Compute and store Jacobian. More... | |
virtual NOX::Abstract::Group::ReturnType | computeGradient () |
Compute and store gradient. More... | |
virtual NOX::Abstract::Group::ReturnType | computeNewton (Teuchos::ParameterList ¶ms) |
Compute the Newton direction, using parameters for the linear solve. More... | |
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. More... | |
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. More... | |
virtual NOX::Abstract::Group::ReturnType | applyJacobianInverse (Teuchos::ParameterList ¶ms, 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. More... | |
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. More... | |
virtual NOX::Abstract::Group::ReturnType | applyJacobianMultiVector (const NOX::Abstract::MultiVector &input, NOX::Abstract::MultiVector &result) const |
applyJacobian for multiple right-hand sides More... | |
virtual NOX::Abstract::Group::ReturnType | applyJacobianTransposeMultiVector (const NOX::Abstract::MultiVector &input, NOX::Abstract::MultiVector &result) const |
applyJacobianTranspose for multiple right-hand sides More... | |
virtual NOX::Abstract::Group::ReturnType | applyJacobianInverseMultiVector (Teuchos::ParameterList ¶ms, const NOX::Abstract::MultiVector &input, NOX::Abstract::MultiVector &result) const |
applyJacobianInverse for multiple right-hand sides More... | |
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 More... | |
virtual bool | isF () const =0 |
Return true if F is valid. | |
virtual bool | isJacobian () const |
Return true if the Jacobian is valid. More... | |
virtual bool | isGradient () const |
Return true if the gradient is valid. More... | |
virtual bool | isNewton () const |
Return true if the Newton direction is valid. More... | |
virtual const NOX::Abstract::Vector & | getX () const =0 |
Return solution vector. | |
virtual const NOX::Abstract::Vector & | getScaledX () const |
virtual const NOX::Abstract::Vector & | getF () const =0 |
Return F(x) | |
virtual double | getNormF () const =0 |
Return 2-norm of F(x). More... | |
virtual const NOX::Abstract::Vector & | getGradient () const =0 |
Return gradient. | |
virtual const NOX::Abstract::Vector & | getNewton () const =0 |
Return Newton direction. | |
virtual Teuchos::RCP< const NOX::Abstract::Vector > | getXPtr () const =0 |
Return RCP to solution vector. | |
virtual Teuchos::RCP< const NOX::Abstract::Vector > | getFPtr () const =0 |
Return RCP to F(x) | |
virtual Teuchos::RCP< const NOX::Abstract::Vector > | getGradientPtr () const =0 |
Return RCP to gradient. | |
virtual Teuchos::RCP< const NOX::Abstract::Vector > | getNewtonPtr () 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(). More... | |
virtual Teuchos::RCP < NOX::Abstract::Group > | clone (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. More... | |
Public Member Functions inherited from LOCA::MultiContinuation::FiniteDifferenceGroup | |
FiniteDifferenceGroup () | |
Constructor. | |
FiniteDifferenceGroup (const FiniteDifferenceGroup &source, NOX::CopyType type=NOX::DeepCopy) | |
Copy constructor. | |
virtual void | copy (const NOX::Abstract::Group &source) |
Copy. | |
virtual NOX::Abstract::Group & | operator= (const NOX::Abstract::Group &source) |
Assignment. | |
virtual void | setDerivUtils (const Teuchos::RCP< LOCA::DerivUtils > &deriv) |
Set the LOCA::DerivUtils object. | |
virtual NOX::Abstract::Group::ReturnType | computeDfDpMulti (const std::vector< int > ¶mIDs, NOX::Abstract::MultiVector &dfdp, bool isValidF) |
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... | |
Protected Attributes inherited from LOCA::MultiContinuation::FiniteDifferenceGroup | |
Teuchos::RCP< DerivUtils > | derivPtr |
Pointer to current DerivUtils derivative computation object. | |
Concrete class that provides concrete implementations of the derivative computation methods of the LOCA::TurningPoint::MooreSpence::AbstractGroup using first-order finite differencing.
The finite-differencing calculations are actually implemented by the LOCA::DerivUtils class, and a custom DerivUtils object can be passed through the constructor of this class. However, in the future the calculations encapsulated in the DerivUtils class may be incorporated directly into this class and other finite-differencing child classes.
|
virtual |
Computes the derivative .
The calculation is implemented by calling the corresponding LOCA::DerivUtils::computeDJnDp() method of the passed LOCA::DerivUtils object.
Implements LOCA::TurningPoint::MooreSpence::AbstractGroup.
References LOCA::MultiContinuation::FiniteDifferenceGroup::derivPtr.
|
virtual |
Computes the directional derivative for the given direction .
The calculation is implemented by calling the corresponding LOCA::DerivUtils::computeDJnDxa() method of the passed LOCA::DerivUtils object.
Implements LOCA::TurningPoint::MooreSpence::AbstractGroup.
References LOCA::MultiContinuation::FiniteDifferenceGroup::derivPtr.
|
virtual |
Computes the directional derivative for the given direction .
The calculation is implemented by calling the corresponding LOCA::DerivUtils::computeDJnDxa() method of the passed LOCA::DerivUtils object.
Implements LOCA::TurningPoint::MooreSpence::AbstractGroup.
References LOCA::MultiContinuation::FiniteDifferenceGroup::derivPtr.
|
virtual |
Computes the derivative .
The calculation is implemented by calling the corresponding LOCA::DerivUtils::computeDwtJnDx() method of the passed LOCA::DerivUtils object.
Implements LOCA::TurningPoint::MooreSpence::AbstractGroup.
References LOCA::MultiContinuation::FiniteDifferenceGroup::derivPtr.