LOCA::Pitchfork::MooreSpence::ExtendedGroup Class Reference

A group representing the Moore-Spence pitchfork equations. More...

#include <LOCA_Pitchfork_MooreSpence_ExtendedGroup.H>

Inheritance diagram for LOCA::Pitchfork::MooreSpence::ExtendedGroup:

Inheritance graph
[legend]
Collaboration diagram for LOCA::Pitchfork::MooreSpence::ExtendedGroup:

Collaboration graph
[legend]

List of all members.

Public Member Functions

 ExtendedGroup (const Teuchos::RCP< LOCA::GlobalData > &global_data, const Teuchos::RCP< LOCA::Parameter::SublistParser > &topParams, const Teuchos::RCP< Teuchos::ParameterList > &pfParams, const Teuchos::RCP< LOCA::Pitchfork::MooreSpence::AbstractGroup > &g)
 Constructor with initial data passed through parameter lists.
 ExtendedGroup (const ExtendedGroup &source, NOX::CopyType type=NOX::DeepCopy)
 Copy constructor.
virtual ~ExtendedGroup ()
 Destructor.
Implementation of NOX::Abstract::Group virtual methods
virtual NOX::Abstract::Groupoperator= (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, x, to y.
virtual void computeX (const NOX::Abstract::Group &g, const NOX::Abstract::Vector &d, double step)
 Compute this.x = grp.x + step * d.
virtual
NOX::Abstract::Group::ReturnType 
computeF ()
 Compute the pitchfork equation residual $G$.
virtual
NOX::Abstract::Group::ReturnType 
computeJacobian ()
 Compute the blocks of the Jacobian derivative of $G$.
virtual
NOX::Abstract::Group::ReturnType 
computeGradient ()
 Gradient computation is not defined for this group.
virtual
NOX::Abstract::Group::ReturnType 
computeNewton (Teuchos::ParameterList &params)
 Compute Newton direction using applyJacobianInverse().
virtual
NOX::Abstract::Group::ReturnType 
applyJacobian (const NOX::Abstract::Vector &input, NOX::Abstract::Vector &result) const
 Computes the extended Jacobian vector product.
virtual
NOX::Abstract::Group::ReturnType 
applyJacobianTranspose (const NOX::Abstract::Vector &input, NOX::Abstract::Vector &result) const
 Jacobian transpose product is not defined by this group.
virtual
NOX::Abstract::Group::ReturnType 
applyJacobianInverse (Teuchos::ParameterList &params, const NOX::Abstract::Vector &input, NOX::Abstract::Vector &result) const
 Applies the inverse of the extended Jacobian matrix using the bordering algorithm.
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 &params, const NOX::Abstract::MultiVector &input, NOX::Abstract::MultiVector &result) const
 Applies Jacobian inverse for extended system.
virtual bool isF () const
 Return true if the extended residual $G$ 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 $z$.
virtual const
NOX::Abstract::Vector
getF () const
 Return extended equation residual $G(z)$.
virtual double getNormF () const
 Return 2-norm of $G(z)$.
virtual const
NOX::Abstract::Vector
getGradient () const
 Vector returned is not valid.
virtual const
NOX::Abstract::Vector
getNewton () const
 Return extended Newton direction.
virtual double getNormNewtonSolveResidual () const
 Return the norm of the 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::AbstractGroup

virtual methods

Teuchos::RCP< LOCA::GlobalDataglobalData
 Pointer LOCA global data object.
Teuchos::RCP
< LOCA::Parameter::SublistParser
parsedParams
 Parsed top-level parameters.
Teuchos::RCP
< Teuchos::ParameterList > 
pitchforkParams
 Bifurcation parameter list.
Teuchos::RCP
< LOCA::Pitchfork::MooreSpence::AbstractGroup
grpPtr
 Pointer to base group that defines $F$.
LOCA::Pitchfork::MooreSpence::ExtendedMultiVector xMultiVec
 Stores the extended solution vector and J^-1 df/dp.
LOCA::Pitchfork::MooreSpence::ExtendedMultiVector fMultiVec
 Stores the extended residual vector and df/dp.
LOCA::Pitchfork::MooreSpence::ExtendedMultiVector newtonMultiVec
 Stores the extended Newton vector.
Teuchos::RCP
< NOX::Abstract::MultiVector
asymMultiVec
 Stores the asymmetric vector.
Teuchos::RCP
< NOX::Abstract::MultiVector
lengthMultiVec
 Stores the length normalization vector.
Teuchos::RCP
< LOCA::Pitchfork::MooreSpence::ExtendedVector
xVec
 Stores view of first column of xMultiVec.
Teuchos::RCP
< LOCA::Pitchfork::MooreSpence::ExtendedVector
fVec
 Stores view of first column of fMultiVec.
Teuchos::RCP
< LOCA::Pitchfork::MooreSpence::ExtendedMultiVector
ffMultiVec
 Stores view of first column of fMultiVec as a multivec.
Teuchos::RCP
< LOCA::Pitchfork::MooreSpence::ExtendedMultiVector
dfdpMultiVec
 Stores view of df/dp columns of fMultiVec.
Teuchos::RCP
< LOCA::Pitchfork::MooreSpence::ExtendedVector
newtonVec
 Stores view of first column of newtonMultiVec.
Teuchos::RCP
< NOX::Abstract::Vector
asymVec
 Stores view of first column of asymMultiVec.
Teuchos::RCP
< NOX::Abstract::Vector
lengthVec
 Stores view of first column of lengthMultiVec.
Teuchos::RCP
< LOCA::Pitchfork::MooreSpence::SolverStrategy
solverStrategy
 Stores bordering strategy.
vector< int > index_f
 Stores indices for getting f part of fMultiVec.
vector< int > index_dfdp
 Stores indices for getting df/dp part of fMultiVec.
vector< int > bifParamID
 Stores the bifurcation parameter index.
bool isValidF
 Is residual vector valid.
bool isValidJacobian
 Is Jacobian matrix valid.
bool isValidNewton
 Is Newton vector valid.
virtual void copy (const NOX::Abstract::Group &source)
 Assignment operator.
virtual void setParamsMulti (const vector< int > &paramIDs, const NOX::Abstract::MultiVector::DenseMatrix &vals)
 Set parameters indexed by (integer) paramIDs.
virtual void setParams (const ParameterVector &p)
 Set the parameter vector in the group to p.
virtual void setParam (int paramID, double val)
 Set parameter indexed by paramID.
virtual void setParam (string paramID, double val)
 Set parameter indexed by paramID.
virtual const ParameterVectorgetParams () const
 Return a const reference to the paramter vector 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
NOX::Abstract::Group::ReturnType 
computeDfDpMulti (const vector< int > &paramIDs, NOX::Abstract::MultiVector &dfdp, bool isValidF)
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 void printSolution (const double conParam) const
 Function to print out extended solution and continuation parameter after successful continuation step.
virtual void printSolution (const NOX::Abstract::Vector &x_, const double conParam) const
 Function to print out extended solution and continuation parameter after successful continuation step.
double getBifParam () const
 Get bifurcation parameter.
double lTransNorm (const NOX::Abstract::Vector &n) const
 Defines null vector normalization $l^Tn$ equation.
void lTransNorm (const NOX::Abstract::MultiVector &n, NOX::Abstract::MultiVector::DenseMatrix &result) const
 null vector normalization for multivectors
void setBifParam (double param)
 Set bifurcation parameter.
void setupViews ()
 Sets up multivector views.
void init (bool perturbSoln=false, double perturbSize=0.0)
 Initializes group.
ExtendedGroupoperator= (const ExtendedGroup &)
 Prohibit generation and use of operator=().


Detailed Description

A group representing the Moore-Spence pitchfork equations.

The LOCA::Pitchfork::MooreSpence::ExtendedGroup is a concrete implementation of the NOX::Abstract::Group, LOCA::MultiContinuation::AbstractGroup and LOCA::Extended::MultiAbstractGroup that defines the following extended set of equations that are regular at a generic pitchfork bifurcation:

\[ G(z) = \left[ \begin{array}{c} F(x,p)+\sigma\psi \\ Jn \\ \langle x, \psi\rangle \\ l^Tn-1 \end{array} \right] = 0 \]

where $z = [x, n, \sigma, p]\in\Re^{2n+2}$, $x$ is the solution vector, $n$ is the null vector, $\psi$ is the antisymmetric vector, $\sigma$ is the slack variables representing the asymmetry in the problem, $l$ is the length normalization vector and $J$ is the Jacobian of F.

The group stores an underlying group of type LOCA::Pitchfork::MooreSpence AbstractGroup to represent the equations $F(x,p) = 0$ and to manipulate the underlying Jacobian $J$. Note that the entire extended Jacobian $D_z G$ is not stored in memory, rather a block-elimination algorithm (bordering algorithm) is used to compute linear solves of the extended Jacobian (see LOCA::Pitchfork::MooreSpence::SolverFactory for more details).

This class implements all of the NOX::Abstract::Group, LOCA::MultiContinuation::AbstractGroup, and LOCA::Extended::MultiAbstractGroup methods for this extended set of equations and therefore is a complete group which can be passed to most NOX solvers to locate a single pitchfork point or to the LOCA::Stepper to compute a family of pitchforks in a second parameter.

However, Jacobian-tranpose operations and gradient calculations cannot be implemented efficiently and therefore gradient-base nonlinear solvers such as steepest descent and Trust region methods cannot be used to solve the extended pitchfork equations.

The class is intialized via the pfParams parameter list argument to the constructor. The parameters this class recognizes are:

Definition at line 140 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.


Constructor & Destructor Documentation

LOCA::Pitchfork::MooreSpence::ExtendedGroup::ExtendedGroup ( const Teuchos::RCP< LOCA::GlobalData > &  global_data,
const Teuchos::RCP< LOCA::Parameter::SublistParser > &  topParams,
const Teuchos::RCP< Teuchos::ParameterList > &  pfParams,
const Teuchos::RCP< LOCA::Pitchfork::MooreSpence::AbstractGroup > &  g 
)

LOCA::Pitchfork::MooreSpence::ExtendedGroup::ExtendedGroup ( const ExtendedGroup source,
NOX::CopyType  type = NOX::DeepCopy 
)

LOCA::Pitchfork::MooreSpence::ExtendedGroup::~ExtendedGroup (  )  [virtual]

Destructor.

Definition at line 191 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.


Member Function Documentation

NOX::Abstract::Group & LOCA::Pitchfork::MooreSpence::ExtendedGroup::operator= ( const NOX::Abstract::Group source  )  [virtual]

Assignment operator.

Implements NOX::Abstract::Group.

Definition at line 196 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References copy().

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

Cloning function.

Implements NOX::Abstract::Group.

Definition at line 204 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

void LOCA::Pitchfork::MooreSpence::ExtendedGroup::setX ( const NOX::Abstract::Vector y  )  [virtual]

void LOCA::Pitchfork::MooreSpence::ExtendedGroup::computeX ( const NOX::Abstract::Group g,
const NOX::Abstract::Vector d,
double  step 
) [virtual]

NOX::Abstract::Group::ReturnType LOCA::Pitchfork::MooreSpence::ExtendedGroup::computeF (  )  [virtual]

Compute the pitchfork equation residual $G$.

This method fills the extended residual

\[ G(z) = \left[ \begin{array}{c} F(x,p)+\sigma\psi \\ Jn \\ \langle x, \psi\rangle \\ l^Tn-1 \end{array} \right] = 0 \]

The solution component residual $F(x,p)$ and the null-vector residual $Jn$ are calculated via the computeF and applyJacobian methods of the underlying group. The symmetry residual, $\langle x, \psi\rangle$ is computed via the innerProduct() method of the underlying group.

Implements NOX::Abstract::Group.

Definition at line 247 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References asymVec, fVec, globalData, grpPtr, isValidF, lTransNorm(), NOX::Abstract::Group::Ok, and xVec.

Referenced by computeNewton().

NOX::Abstract::Group::ReturnType LOCA::Pitchfork::MooreSpence::ExtendedGroup::computeJacobian (  )  [virtual]

Compute the blocks of the Jacobian derivative of $G$.

This method computes the $J$, $\partial F/\partial p$, and $\partial Jn/\partial p$ blocks of the extended Jacobian:

\[ D_z G(z) = \begin{bmatrix} J & 0 & \psi & \frac{\partial F}{\partial p} \\ \frac{\partial Jn}{\partial x} & J & 0 & \frac{\partial Jn}{\partial p} \\ \psi^T & 0 & 0 & 0 \\ 0 & l^T & 0 & 0 \end{bmatrix} \]

by calling the computeJacobian, computeDfDp, and computeDJnDp methods of the underlying group. The second derivative matrix $\partial Jn/\partial x$ is not calculated since only its action on vectors is needed for linear solves using the bordering algorithms.

Reimplemented from NOX::Abstract::Group.

Definition at line 297 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References asymMultiVec, asymVec, bifParamID, fMultiVec, fVec, LOCA::Pitchfork::MooreSpence::ExtendedMultiVector::getColumn(), LOCA::Pitchfork::MooreSpence::ExtendedMultiVector::getNullMultiVec(), LOCA::Pitchfork::MooreSpence::ExtendedMultiVector::getXMultiVec(), globalData, grpPtr, isValidF, isValidJacobian, NOX::Abstract::Group::Ok, solverStrategy, and xVec.

Referenced by computeNewton().

NOX::Abstract::Group::ReturnType LOCA::Pitchfork::MooreSpence::ExtendedGroup::computeGradient (  )  [virtual]

Gradient computation is not defined for this group.

Reimplemented from NOX::Abstract::Group.

Definition at line 353 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References NOX::Abstract::Group::NotDefined.

NOX::Abstract::Group::ReturnType LOCA::Pitchfork::MooreSpence::ExtendedGroup::computeNewton ( Teuchos::ParameterList &  params  )  [virtual]

NOX::Abstract::Group::ReturnType LOCA::Pitchfork::MooreSpence::ExtendedGroup::applyJacobian ( const NOX::Abstract::Vector input,
NOX::Abstract::Vector result 
) const [virtual]

Computes the extended Jacobian vector product.

This method computes the extended Jacobian vector product

\[ \begin{bmatrix} J & 0 & \psi & \frac{\partial F}{\partial p} \\ \frac{\partial Jn}{\partial x} & J & 0 & \frac{\partial Jn}{\partial p} \\ \psi^T & 0 & 0 & 0 \\ 0 & l^T & 0 & 0 \end{bmatrix} \begin{bmatrix} a \\ b \\ c \\ d \end{bmatrix} = \begin{bmatrix} Ja + \psi c + \frac{\partial F}{\partial p}d \\ \frac{\partial Jn}{\partial x}a + Jb + \frac{\partial Jn}{\partial p}d \\ \langle a, \psi\rangle \\ l^T b \end{bmatrix} \]

using the applyJacobian, computeDJnDxa, and innerProdut methods of the underlying group where $a$, $b$, $c$, $d$ are the solution, null-vector, slack, and paramter components of the given vector input. Vectors input and result must be of type LOCA::Pitchfork::MooreSpence::ExtendedVector, otherwise an error is thrown.

Reimplemented from NOX::Abstract::Group.

Definition at line 405 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References applyJacobianMultiVector(), NOX::Abstract::Vector::createMultiVector(), and NOX::DeepCopy.

Referenced by getNormNewtonSolveResidual().

NOX::Abstract::Group::ReturnType LOCA::Pitchfork::MooreSpence::ExtendedGroup::applyJacobianTranspose ( const NOX::Abstract::Vector input,
NOX::Abstract::Vector result 
) const [virtual]

Jacobian transpose product is not defined by this group.

Reimplemented from NOX::Abstract::Group.

Definition at line 426 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References applyJacobianTransposeMultiVector(), NOX::Abstract::Vector::createMultiVector(), and NOX::DeepCopy.

NOX::Abstract::Group::ReturnType LOCA::Pitchfork::MooreSpence::ExtendedGroup::applyJacobianInverse ( Teuchos::ParameterList &  params,
const NOX::Abstract::Vector input,
NOX::Abstract::Vector result 
) const [virtual]

Applies the inverse of the extended Jacobian matrix using the bordering algorithm.

This method is a special case of applyJacobianInverseMultiVector() for a single right-hand-side.

Reimplemented from NOX::Abstract::Group.

Definition at line 447 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References applyJacobianInverseMultiVector(), NOX::Abstract::Vector::createMultiVector(), and NOX::DeepCopy.

NOX::Abstract::Group::ReturnType LOCA::Pitchfork::MooreSpence::ExtendedGroup::applyJacobianMultiVector ( const NOX::Abstract::MultiVector input,
NOX::Abstract::MultiVector result 
) const [virtual]

NOX::Abstract::Group::ReturnType LOCA::Pitchfork::MooreSpence::ExtendedGroup::applyJacobianTransposeMultiVector ( const NOX::Abstract::MultiVector input,
NOX::Abstract::MultiVector result 
) const [virtual]

Jacobian transpose not defined for this system.

Reimplemented from NOX::Abstract::Group.

Definition at line 567 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References globalData, and NOX::Abstract::Group::NotDefined.

Referenced by applyJacobianTranspose().

NOX::Abstract::Group::ReturnType LOCA::Pitchfork::MooreSpence::ExtendedGroup::applyJacobianInverseMultiVector ( Teuchos::ParameterList &  params,
const NOX::Abstract::MultiVector input,
NOX::Abstract::MultiVector result 
) const [virtual]

Applies Jacobian inverse for extended system.

Uses a LOCA::Pitchfork::MooreSpence::SolverStrategy instantiated by the LOCA::Pitchfork::MooreSpence::SolverFactory to implement the solve.

Reimplemented from NOX::Abstract::Group.

Definition at line 579 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References solverStrategy.

Referenced by applyJacobianInverse().

bool LOCA::Pitchfork::MooreSpence::ExtendedGroup::isF (  )  const [virtual]

Return true if the extended residual $G$ is valid.

Implements NOX::Abstract::Group.

Definition at line 596 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References isValidF.

Referenced by computeNewton().

bool LOCA::Pitchfork::MooreSpence::ExtendedGroup::isJacobian (  )  const [virtual]

Return true if the extended Jacobian is valid.

Reimplemented from NOX::Abstract::Group.

Definition at line 602 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References isValidJacobian.

Referenced by applyJacobianMultiVector(), and computeNewton().

bool LOCA::Pitchfork::MooreSpence::ExtendedGroup::isGradient (  )  const [virtual]

Always returns false.

Reimplemented from NOX::Abstract::Group.

Definition at line 608 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

bool LOCA::Pitchfork::MooreSpence::ExtendedGroup::isNewton (  )  const [virtual]

Return true if the extended Newton direction is valid.

Reimplemented from NOX::Abstract::Group.

Definition at line 614 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References isValidNewton.

const NOX::Abstract::Vector & LOCA::Pitchfork::MooreSpence::ExtendedGroup::getX (  )  const [virtual]

Return extended solution vector $z$.

Implements NOX::Abstract::Group.

Definition at line 620 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References xVec.

Referenced by computeX().

const NOX::Abstract::Vector & LOCA::Pitchfork::MooreSpence::ExtendedGroup::getF (  )  const [virtual]

Return extended equation residual $G(z)$.

Implements NOX::Abstract::Group.

Definition at line 626 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References fVec.

double LOCA::Pitchfork::MooreSpence::ExtendedGroup::getNormF (  )  const [virtual]

Return 2-norm of $G(z)$.

Implements NOX::Abstract::Group.

Definition at line 632 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References fVec.

const NOX::Abstract::Vector & LOCA::Pitchfork::MooreSpence::ExtendedGroup::getGradient (  )  const [virtual]

Vector returned is not valid.

Implements NOX::Abstract::Group.

Definition at line 638 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References getNewton(), and globalData.

const NOX::Abstract::Vector & LOCA::Pitchfork::MooreSpence::ExtendedGroup::getNewton (  )  const [virtual]

Return extended Newton direction.

Implements NOX::Abstract::Group.

Definition at line 647 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References newtonVec.

Referenced by getGradient().

double LOCA::Pitchfork::MooreSpence::ExtendedGroup::getNormNewtonSolveResidual (  )  const [virtual]

Return the norm of the Newton solve residual.

Definition at line 653 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References applyJacobian(), fVec, globalData, newtonVec, LOCA::Extended::Vector::norm(), and LOCA::Extended::Vector::update().

Teuchos::RCP< const LOCA::MultiContinuation::AbstractGroup > LOCA::Pitchfork::MooreSpence::ExtendedGroup::getUnderlyingGroup (  )  const [virtual]

Return underlying group.

Implements LOCA::Extended::MultiAbstractGroup.

Definition at line 668 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References grpPtr.

Teuchos::RCP< LOCA::MultiContinuation::AbstractGroup > LOCA::Pitchfork::MooreSpence::ExtendedGroup::getUnderlyingGroup (  )  [virtual]

Return underlying group.

Implements LOCA::Extended::MultiAbstractGroup.

Definition at line 674 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References grpPtr.

void LOCA::Pitchfork::MooreSpence::ExtendedGroup::copy ( const NOX::Abstract::Group source  )  [virtual]

void LOCA::Pitchfork::MooreSpence::ExtendedGroup::setParamsMulti ( const vector< int > &  paramIDs,
const NOX::Abstract::MultiVector::DenseMatrix vals 
) [virtual]

Set parameters indexed by (integer) paramIDs.

Implements LOCA::MultiContinuation::AbstractGroup.

Definition at line 718 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References bifParamID, grpPtr, and setBifParam().

void LOCA::Pitchfork::MooreSpence::ExtendedGroup::setParams ( const ParameterVector p  )  [virtual]

Set the parameter vector in the group to p.

Implements LOCA::MultiContinuation::AbstractGroup.

Definition at line 730 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References bifParamID, grpPtr, isValidF, isValidJacobian, isValidNewton, and setBifParam().

void LOCA::Pitchfork::MooreSpence::ExtendedGroup::setParam ( int  paramID,
double  val 
) [virtual]

Set parameter indexed by paramID.

Implements LOCA::MultiContinuation::AbstractGroup.

Definition at line 742 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References bifParamID, grpPtr, and setBifParam().

void LOCA::Pitchfork::MooreSpence::ExtendedGroup::setParam ( string  paramID,
double  val 
) [virtual]

Set parameter indexed by paramID.

Implements LOCA::MultiContinuation::AbstractGroup.

Definition at line 752 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References bifParamID, LOCA::ParameterVector::getIndex(), grpPtr, and setBifParam().

const LOCA::ParameterVector & LOCA::Pitchfork::MooreSpence::ExtendedGroup::getParams (  )  const [virtual]

Return a const reference to the paramter vector owned by the group.

Implements LOCA::MultiContinuation::AbstractGroup.

Definition at line 763 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References grpPtr.

double LOCA::Pitchfork::MooreSpence::ExtendedGroup::getParam ( int  paramID  )  const [virtual]

Return copy of parameter indexed by paramID.

Implements LOCA::MultiContinuation::AbstractGroup.

Definition at line 769 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References grpPtr.

double LOCA::Pitchfork::MooreSpence::ExtendedGroup::getParam ( string  paramID  )  const [virtual]

Return copy of parameter indexed by paramID.

Implements LOCA::MultiContinuation::AbstractGroup.

Definition at line 775 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References grpPtr.

NOX::Abstract::Group::ReturnType LOCA::Pitchfork::MooreSpence::ExtendedGroup::computeDfDpMulti ( const vector< int > &  paramIDs,
NOX::Abstract::MultiVector dfdp,
bool  isValidF 
) [virtual]

void LOCA::Pitchfork::MooreSpence::ExtendedGroup::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.

Reimplemented from LOCA::MultiContinuation::AbstractGroup.

Definition at line 831 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References grpPtr.

void LOCA::Pitchfork::MooreSpence::ExtendedGroup::postProcessContinuationStep ( LOCA::Abstract::Iterator::StepStatus  stepStatus  )  [virtual]

Perform any postprocessing after a continuation step finishes.

The stepStatus argument indicates whether the step was successful.

Reimplemented from LOCA::MultiContinuation::AbstractGroup.

Definition at line 838 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References grpPtr.

void LOCA::Pitchfork::MooreSpence::ExtendedGroup::projectToDraw ( const NOX::Abstract::Vector x,
double *  px 
) const [virtual]

Projects solution to a few scalars for multiparameter continuation.

Reimplemented from LOCA::MultiContinuation::AbstractGroup.

Definition at line 845 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References LOCA::Pitchfork::MooreSpence::ExtendedVector::getBifParam(), LOCA::Pitchfork::MooreSpence::ExtendedVector::getXVec(), and grpPtr.

int LOCA::Pitchfork::MooreSpence::ExtendedGroup::projectToDrawDimension (  )  const [virtual]

Returns the dimension of the project to draw array.

Reimplemented from LOCA::MultiContinuation::AbstractGroup.

Definition at line 857 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References grpPtr.

void LOCA::Pitchfork::MooreSpence::ExtendedGroup::printSolution ( const double  conParam  )  const [virtual]

Function to print out extended solution and continuation parameter after successful continuation step.

This method prints the solution, null-vector, and parameter components of the extended solution vector using the printSolution method of the underlying group.

Reimplemented from LOCA::MultiContinuation::AbstractGroup.

Definition at line 863 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References getBifParam(), globalData, grpPtr, NOX::Utils::StepperDetails, and xVec.

void LOCA::Pitchfork::MooreSpence::ExtendedGroup::printSolution ( const NOX::Abstract::Vector x_,
const double  conParam 
) const [virtual]

Function to print out extended solution and continuation parameter after successful continuation step.

This method prints the solution, null-vector, and parameter components of the extended solution vector using the printSolution method of the underlying group.

Reimplemented from LOCA::MultiContinuation::AbstractGroup.

Definition at line 892 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References LOCA::Pitchfork::MooreSpence::ExtendedVector::getBifParam(), LOCA::Pitchfork::MooreSpence::ExtendedVector::getNullVec(), LOCA::Pitchfork::MooreSpence::ExtendedVector::getSlack(), LOCA::Pitchfork::MooreSpence::ExtendedVector::getXVec(), globalData, grpPtr, and NOX::Utils::StepperDetails.

double LOCA::Pitchfork::MooreSpence::ExtendedGroup::getBifParam (  )  const

Get bifurcation parameter.

Definition at line 925 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References bifParamID, and grpPtr.

Referenced by init(), and printSolution().

double LOCA::Pitchfork::MooreSpence::ExtendedGroup::lTransNorm ( const NOX::Abstract::Vector n  )  const

Defines null vector normalization $l^Tn$ equation.

Definition at line 931 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References lengthVec.

Referenced by applyJacobianMultiVector(), computeDfDpMulti(), computeF(), and init().

void LOCA::Pitchfork::MooreSpence::ExtendedGroup::lTransNorm ( const NOX::Abstract::MultiVector n,
NOX::Abstract::MultiVector::DenseMatrix result 
) const

null vector normalization for multivectors

Note: result should have 1 row and n.numVectors() columns.

Definition at line 938 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References lengthMultiVec, lengthVec, and NOX::Abstract::MultiVector::multiply().

void LOCA::Pitchfork::MooreSpence::ExtendedGroup::setBifParam ( double  param  )  [protected]

Set bifurcation parameter.

Definition at line 946 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.C.

References bifParamID, grpPtr, isValidF, isValidJacobian, isValidNewton, and xVec.

Referenced by computeX(), setParam(), setParams(), setParamsMulti(), and setX().

void LOCA::Pitchfork::MooreSpence::ExtendedGroup::setupViews (  )  [protected]

void LOCA::Pitchfork::MooreSpence::ExtendedGroup::init ( bool  perturbSoln = false,
double  perturbSize = 0.0 
) [protected]

ExtendedGroup& LOCA::Pitchfork::MooreSpence::ExtendedGroup::operator= ( const ExtendedGroup  )  [private]

Prohibit generation and use of operator=().


Member Data Documentation

Parsed top-level parameters.

Definition at line 487 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by copy(), and ExtendedGroup().

Teuchos::RCP<Teuchos::ParameterList> LOCA::Pitchfork::MooreSpence::ExtendedGroup::pitchforkParams [protected]

Bifurcation parameter list.

Definition at line 490 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by copy(), and ExtendedGroup().

Stores the extended solution vector and J^-1 df/dp.

Definition at line 496 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by copy(), ExtendedGroup(), and setupViews().

Stores the extended residual vector and df/dp.

Definition at line 499 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by computeJacobian(), copy(), and setupViews().

Stores the extended Newton vector.

Definition at line 502 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by computeNewton(), copy(), and setupViews().

Stores the asymmetric vector.

Definition at line 505 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by applyJacobianMultiVector(), computeJacobian(), copy(), ExtendedGroup(), and setupViews().

Stores the length normalization vector.

Definition at line 508 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by copy(), ExtendedGroup(), lTransNorm(), and setupViews().

Stores view of first column of fMultiVec.

Definition at line 514 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by applyJacobianMultiVector(), computeF(), computeJacobian(), getF(), getNormF(), getNormNewtonSolveResidual(), and setupViews().

Stores view of first column of fMultiVec as a multivec.

Definition at line 517 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by computeNewton(), and setupViews().

Stores view of df/dp columns of fMultiVec.

Definition at line 520 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by applyJacobianMultiVector(), and setupViews().

Stores view of first column of newtonMultiVec.

Definition at line 523 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by getNewton(), getNormNewtonSolveResidual(), and setupViews().

Stores view of first column of asymMultiVec.

Definition at line 526 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by computeDfDpMulti(), computeF(), computeJacobian(), init(), and setupViews().

Stores view of first column of lengthMultiVec.

Definition at line 529 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by lTransNorm(), and setupViews().

Stores indices for getting f part of fMultiVec.

Definition at line 535 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by copy(), and setupViews().

Stores indices for getting df/dp part of fMultiVec.

Definition at line 538 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by copy(), and setupViews().

Stores the bifurcation parameter index.

Definition at line 541 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by computeJacobian(), copy(), ExtendedGroup(), getBifParam(), setBifParam(), setParam(), setParams(), and setParamsMulti().

Is residual vector valid.

Definition at line 544 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by computeF(), computeJacobian(), computeX(), copy(), ExtendedGroup(), isF(), setBifParam(), setParams(), and setX().

Is Jacobian matrix valid.

Definition at line 547 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by computeJacobian(), computeX(), copy(), ExtendedGroup(), isJacobian(), setBifParam(), setParams(), and setX().

Is Newton vector valid.

Definition at line 550 of file LOCA_Pitchfork_MooreSpence_ExtendedGroup.H.

Referenced by computeNewton(), computeX(), copy(), ExtendedGroup(), isNewton(), setBifParam(), setParams(), and setX().


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

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