NOX Development
Loading...
Searching...
No Matches
Public Member Functions | List of all members
LOCA::Hopf::MinimallyAugmented::Constraint Class Reference

Implementation of LOCA::MultiContinuation::ConstraintInterfaceMVDX for computing Hopf bifurcations for the minimally augmented Hopf formulation. More...

#include <LOCA_Hopf_MinimallyAugmented_Constraint.H>

Inheritance diagram for LOCA::Hopf::MinimallyAugmented::Constraint:
Inheritance graph
[legend]
Collaboration diagram for LOCA::Hopf::MinimallyAugmented::Constraint:
Collaboration graph
[legend]

Public Member Functions

 Constraint (const Teuchos::RCP< LOCA::GlobalData > &global_data, const Teuchos::RCP< LOCA::Parameter::SublistParser > &topParams, const Teuchos::RCP< Teuchos::ParameterList > &hpfParams, const Teuchos::RCP< LOCA::Hopf::MinimallyAugmented::AbstractGroup > &g, bool is_symmetric, const NOX::Abstract::Vector &a_real, const NOX::Abstract::Vector &a_imag, const NOX::Abstract::Vector *b_real, const NOX::Abstract::Vector *b_imag, int bif_param, double freq)
 Constructor.
 
 Constraint (const Constraint &source, NOX::CopyType type=NOX::DeepCopy)
 Copy constructor.
 
virtual ~Constraint ()
 Destructor.
 
virtual void setGroup (const Teuchos::RCP< LOCA::Hopf::MinimallyAugmented::AbstractGroup > &g)
 Set the group pointer.
 
virtual void setFrequency (double freq)
 Set Hopf frequency.
 
virtual Teuchos::RCP< const NOX::Abstract::VectorgetLeftNullVecReal () const
 Returns real component of left null vector w.
 
virtual Teuchos::RCP< const NOX::Abstract::VectorgetLeftNullVecImag () const
 Returns imaginary component of left null vector w.
 
virtual Teuchos::RCP< const NOX::Abstract::VectorgetRightNullVecReal () const
 Returns real component of right null vector v.
 
virtual Teuchos::RCP< const NOX::Abstract::VectorgetRightNullVecImag () const
 Returns imaginary component of right null vector v.
 
virtual double getSigmaReal () const
 Returns real component of sigma.
 
virtual double getSigmaImag () const
 Returns imaginary component of sigma.
 
- Public Member Functions inherited from LOCA::MultiContinuation::ConstraintInterfaceMVDX
 ConstraintInterfaceMVDX ()
 Constructor.
 
virtual ~ConstraintInterfaceMVDX ()
 Destructor.
 
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.
 
- Public Member Functions inherited from LOCA::MultiContinuation::ConstraintInterface
 ConstraintInterface ()
 Constructor.
 
virtual ~ConstraintInterface ()
 Destructor.
 
virtual void preProcessContinuationStep (LOCA::Abstract::Iterator::StepStatus)
 Perform any preprocessing before a continuation step starts.
 

Implementation of LOCA::MultiContinuation::ConstraintInterface

virtual methods

Teuchos::RCP< LOCA::GlobalDataglobalData
 Pointer LOCA global data object.
 
Teuchos::RCP< LOCA::Parameter::SublistParserparsedParams
 Parsed top-level parameters.
 
Teuchos::RCP< Teuchos::ParameterList > hopfParams
 Bifurcation parameter list.
 
Teuchos::RCP< LOCA::Hopf::MinimallyAugmented::AbstractGroupgrpPtr
 Pointer to base group that defines $ F$.
 
Teuchos::RCP< NOX::Abstract::MultiVectora_vector
 Vector for $ a$.
 
Teuchos::RCP< NOX::Abstract::MultiVectorb_vector
 Vector for $ b$.
 
Teuchos::RCP< NOX::Abstract::MultiVectorw_vector
 Stores left null vector.
 
Teuchos::RCP< NOX::Abstract::MultiVectorv_vector
 Stores right null vector.
 
Teuchos::RCP< NOX::Abstract::MultiVectorCv_vector
 Stores C*v.
 
Teuchos::RCP< NOX::Abstract::MultiVectorsigma_x
 Stores sigma_x.
 
NOX::Abstract::MultiVector::DenseMatrix constraints
 Constraint values.
 
Teuchos::RCP< LOCA::BorderedSolver::AbstractStrategyborderedSolver
 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.
 
double omega
 Stores Hopf frequency.
 
bool updateVectorsEveryContinuationStep
 Flag indicating whether to update $ a$ and $ b$ every continuation step.
 
bool updateVectorsEveryIteration
 Flag indicating whether to update $ a$ and $ b$ every nonlinear iteration.
 
virtual void copy (const LOCA::MultiContinuation::ConstraintInterface &source)
 Copy.
 
virtual Teuchos::RCP< LOCA::MultiContinuation::ConstraintInterfaceclone (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 > &paramIDs, 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 > &paramIDs, 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::DenseMatrixgetConstraints () const
 Return constraint residuals.
 
virtual const NOX::Abstract::MultiVectorgetDX () 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 NOX::Abstract::Group::ReturnType computeDOmega (NOX::Abstract::MultiVector::DenseMatrix &domega)
 Compute derivative of sigma w.r.t. frequency omega.
 

Detailed Description

Implementation of LOCA::MultiContinuation::ConstraintInterfaceMVDX for computing Hopf bifurcations for the minimally augmented Hopf formulation.

This class implements the turning point constraint equation $\sigma(x,p,\omega) = 0$ for the minimally augmented Hopf formulation where $\sigma$ is defined via

\[
    \begin{bmatrix}
      J+i\omega M & a \\
      b^H         & 0
    \end{bmatrix}
    \begin{bmatrix}
      v \\
      \sigma_1
    \end{bmatrix} =
    \begin{bmatrix}
      0 \\
      n
    \end{bmatrix},
\]

\[
    \begin{bmatrix}
      J^T-i\omega M^T & b \\
      a^H             & 0
    \end{bmatrix}
    \begin{bmatrix}
      w \\
      \sigma_2
    \end{bmatrix} =
    \begin{bmatrix}
      0 \\
      n
    \end{bmatrix},
\]

\[
    \sigma = w^H J+i\omega M v/n
\]

for any vectors $ a$ and $ b$ in $\mathbb{C}^n$. Using these relationships, it is easy to show

\[
    \begin{split}
       \sigma_x &= (w^H(J+i\omega M)v)_x/n = w^H(J+i\omega M)_x v/n \\
       \sigma_p &= (w^H(J+i\omega M)v)_p/n = w^H(J+i\omega M)_p v/n
    \end{split}
\]

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

Member Function Documentation

◆ clone()

Teuchos::RCP< LOCA::MultiContinuation::ConstraintInterface > LOCA::Hopf::MinimallyAugmented::Constraint::clone ( NOX::CopyType type = NOX::DeepCopy) const
virtual

Cloning function.

Implements LOCA::MultiContinuation::ConstraintInterface.

◆ computeConstraints()

NOX::Abstract::Group::ReturnType LOCA::Hopf::MinimallyAugmented::Constraint::computeConstraints ( )
virtual

Compute continuation constraint equations.

Implements LOCA::MultiContinuation::ConstraintInterface.

References NOX::Abstract::Group::Ok, and NOX::Utils::OuterIteration.

◆ computeDP()

NOX::Abstract::Group::ReturnType LOCA::Hopf::MinimallyAugmented::Constraint::computeDP ( const std::vector< int > & paramIDs,
NOX::Abstract::MultiVector::DenseMatrix & dgdp,
bool isValidG )
virtual

Compute derivative of constraints w.r.t. supplied parameters.

The first column of dgdp should be filled with the constraint residuals $ g$ if isValidG is false. If isValidG is true, then the dgdp contains $ g$ on input.

Implements LOCA::MultiContinuation::ConstraintInterface.

References NOX::Abstract::Group::Ok.

◆ computeDX()

NOX::Abstract::Group::ReturnType LOCA::Hopf::MinimallyAugmented::Constraint::computeDX ( )
virtual

Compute derivative of constraints w.r.t. solution vector x.

Implements LOCA::MultiContinuation::ConstraintInterface.

References NOX::Abstract::Group::Ok.

◆ copy()

void LOCA::Hopf::MinimallyAugmented::Constraint::copy ( const LOCA::MultiContinuation::ConstraintInterface & source)
virtual

◆ getConstraints()

const NOX::Abstract::MultiVector::DenseMatrix & LOCA::Hopf::MinimallyAugmented::Constraint::getConstraints ( ) const
virtual

Return constraint residuals.

Implements LOCA::MultiContinuation::ConstraintInterface.

◆ getDX()

const NOX::Abstract::MultiVector * LOCA::Hopf::MinimallyAugmented::Constraint::getDX ( ) const
virtual

Return solution component of constraint derivatives.

Implements LOCA::MultiContinuation::ConstraintInterfaceMVDX.

◆ isConstraints()

bool LOCA::Hopf::MinimallyAugmented::Constraint::isConstraints ( ) const
virtual

Return true if constraint residuals are valid.

Implements LOCA::MultiContinuation::ConstraintInterface.

◆ isDX()

bool LOCA::Hopf::MinimallyAugmented::Constraint::isDX ( ) const
virtual

Return true if derivatives of constraints w.r.t. x are valid.

Implements LOCA::MultiContinuation::ConstraintInterface.

◆ isDXZero()

bool LOCA::Hopf::MinimallyAugmented::Constraint::isDXZero ( ) const
virtual

Return true if solution component of constraint derivatives is zero.

Implements LOCA::MultiContinuation::ConstraintInterface.

◆ numConstraints()

int LOCA::Hopf::MinimallyAugmented::Constraint::numConstraints ( ) const
virtual

Return number of constraints.

Implements LOCA::MultiContinuation::ConstraintInterface.

◆ postProcessContinuationStep()

void LOCA::Hopf::MinimallyAugmented::Constraint::postProcessContinuationStep ( LOCA::Abstract::Iterator::StepStatus stepStatus)
virtual

Perform any postprocessing after a continuation step finishes.

The stepStatus argument indicates whether the step was successful. Here we update the $ a$ and $ b$ vectors to $ w$ and $ v$ respectively if requested.

Reimplemented from LOCA::MultiContinuation::ConstraintInterface.

References NOX::Abstract::MultiVector::norm(), NOX::Utils::StepperDetails, and LOCA::Abstract::Iterator::Successful.

◆ setGroup()

void LOCA::Hopf::MinimallyAugmented::Constraint::setGroup ( const Teuchos::RCP< LOCA::Hopf::MinimallyAugmented::AbstractGroup > & g)
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.

◆ setParam()

void LOCA::Hopf::MinimallyAugmented::Constraint::setParam ( int paramID,
double val )
virtual

Sets parameter indexed by paramID.

Implements LOCA::MultiContinuation::ConstraintInterface.

◆ setParams()

void LOCA::Hopf::MinimallyAugmented::Constraint::setParams ( const std::vector< int > & paramIDs,
const NOX::Abstract::MultiVector::DenseMatrix & vals )
virtual

Sets parameters indexed by paramIDs.

Implements LOCA::MultiContinuation::ConstraintInterface.

◆ setX()

void LOCA::Hopf::MinimallyAugmented::Constraint::setX ( const NOX::Abstract::Vector & y)
virtual

Set the solution vector to y.

Implements LOCA::MultiContinuation::ConstraintInterface.


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