NOX
Development
|
Used by LOCA::Epetra::Group to provide a link to the external code for computing the shifted matrix. More...
#include <LOCA_Epetra_Interface_TimeDependent.H>
Public Member Functions | |
TimeDependent () | |
Constructor. | |
virtual | ~TimeDependent () |
Destructor. | |
virtual bool | computeShiftedMatrix (double alpha, double beta, const Epetra_Vector &x, Epetra_Operator &A)=0 |
Call user routine for computing the shifted matrix where is the Jacobian matrix and is the mass matrix. | |
virtual void | setXdot (const Epetra_Vector &, const double) |
Routine used in XYZT to set x_dot and time in the interface. More... | |
Public Member Functions inherited from LOCA::Epetra::Interface::Required | |
Required () | |
Constructor. | |
virtual | ~Required () |
Destructor. | |
virtual void | setParameters (const ParameterVector &p)=0 |
Set parameters in the user's application. More... | |
virtual void | printSolution (const Epetra_Vector &, double) |
Call user's own print routine for vector-parameter pair. | |
virtual void | dataForPrintSolution (const int, const int, const int) |
Provides data to application for output files. More... | |
virtual void | setMultiPointParameter (const int) |
Set multipoint parameter in the user's application. More... | |
virtual void | preProcessContinuationStep (LOCA::Abstract::Iterator::StepStatus, LOCA::Epetra::Group &) |
Perform any preprocessing before a continuation step starts. More... | |
virtual void | postProcessContinuationStep (LOCA::Abstract::Iterator::StepStatus, LOCA::Epetra::Group &) |
Perform any postprocessing after a continuation step finishes. More... | |
virtual void | projectToDraw (const NOX::Epetra::Vector &x, double *px) const |
Projects solution to a few scalars for multiparameter continuation. More... | |
virtual int | projectToDrawDimension () const |
Returns the dimension of the projection to draw array. | |
Public Member Functions inherited from NOX::Epetra::Interface::Required | |
Required () | |
Constructor. | |
virtual bool | computeF (const Epetra_Vector &x, Epetra_Vector &F, const FillType fillFlag)=0 |
Compute the function, F, given the specified input vector x. Returns true if computation was successful. | |
Additional Inherited Members | |
Public Types inherited from NOX::Epetra::Interface::Required | |
enum | FillType { Residual, Jac, Prec, FD_Res, MF_Res, MF_Jac, User } |
Type of fill that a computeF() method is used for. More... | |
Used by LOCA::Epetra::Group to provide a link to the external code for computing the shifted matrix.
This interface is derived from the NOX::Epetra::Interface::Jacobian and additionally provides a method for computing the shifted matrix . This is needed for linear stability analysis and Hopf tracking.
|
inlinevirtual |
Routine used in XYZT to set x_dot and time in the interface.
The computeF() routine for XYZT problems needs to be a function of x_dot, but th NOX/LOCA computeF() does not take x_dot as an argument. This is used to set x_dot in the application interface so the subsequent call to computeF has the correct x_dot value. The timeStep argument is sent so the use can set the global time, for cases when computeF, computeJacobian, computeMassMatrix fills are functions of time (nonautonomous systems).
Reimplemented in LOCA::Epetra::ModelEvaluatorInterface, and LOCAInterface.