Rythmos - Transient Integration for Differential Equations
Version of the Day
|
#include <Rythmos_ImplicitBDFStepper_decl.hpp>
Public Types | |
typedef Teuchos::ScalarTraits < Scalar >::magnitudeType | ScalarMag |
Public Types inherited from Rythmos::InterpolationBufferBase< Scalar > | |
typedef Teuchos::ScalarTraits < Scalar >::magnitudeType | ScalarMag |
Public Member Functions | |
const Thyra::SolveStatus < Scalar > & | getNonlinearSolveStatus () const |
Returns the Thyra::SolveStatus object from the last nonlinear solve. More... | |
Public Member Functions inherited from Rythmos::SolverAcceptingStepperBase< Scalar > | |
virtual void | setSolver (const Teuchos::RCP< Thyra::NonlinearSolverBase< Scalar > > &solver)=0 |
Public Member Functions inherited from Rythmos::StepperBase< Scalar > | |
virtual bool | acceptsModel () const |
Return if this stepper accepts a model. More... | |
virtual bool | modelIsConst () const |
Return of the model is only const or can be returned as a non-const object. More... | |
Public Member Functions inherited from Rythmos::StepControlStrategyAcceptingStepperBase< Scalar > | |
virtual void | setStepControlStrategy (const Teuchos::RCP< StepControlStrategyBase< Scalar > > &stepControlStrategy)=0 |
ImplicitBDFStepper () | |
Constructors, intializers, Misc. More... | |
ImplicitBDFStepper (const RCP< Thyra::ModelEvaluator< Scalar > > &model, const RCP< Thyra::NonlinearSolverBase< Scalar > > &solver) | |
ImplicitBDFStepper (const RCP< Thyra::ModelEvaluator< Scalar > > &model, const RCP< Thyra::NonlinearSolverBase< Scalar > > &solver, const RCP< Teuchos::ParameterList > ¶meterList) | |
RCP< const Thyra::VectorBase < Scalar > > | get_solution () const |
RCP< const Thyra::VectorBase < Scalar > > | get_residual () const |
const Thyra::VectorBase< Scalar > & | getxHistory (int index) const |
void | setStepControlData (const StepperBase< Scalar > &stepper) |
Overridden from StepControlStrategyAcceptingStepperBase | |
void | setStepControlStrategy (const RCP< StepControlStrategyBase< Scalar > > &stepControlStrategy) |
RCP< StepControlStrategyBase < Scalar > > | getNonconstStepControlStrategy () |
RCP< const StepControlStrategyBase < Scalar > > | getStepControlStrategy () const |
Overridden from SolverAcceptingStepperBase | |
void | setSolver (const RCP< Thyra::NonlinearSolverBase< Scalar > > &solver) |
RCP < Thyra::NonlinearSolverBase < Scalar > > | getNonconstSolver () |
RCP< const Thyra::NonlinearSolverBase < Scalar > > | getSolver () const |
bool | isImplicit () const |
Overridden from StepperBase. More... | |
bool | supportsCloning () const |
Returns true. More... | |
RCP< StepperBase< Scalar > > | cloneStepperAlgorithm () const |
Creates copies of all internal data (including the parameter list) except the model which is assumed to stateless. More... | |
void | setModel (const RCP< const Thyra::ModelEvaluator< Scalar > > &model) |
void | setNonconstModel (const RCP< Thyra::ModelEvaluator< Scalar > > &model) |
RCP< const Thyra::ModelEvaluator< Scalar > > | getModel () const |
RCP< Thyra::ModelEvaluator < Scalar > > | getNonconstModel () |
void | setInitialCondition (const Thyra::ModelEvaluatorBase::InArgs< Scalar > &initialCondition) |
Thyra::ModelEvaluatorBase::InArgs < Scalar > | getInitialCondition () const |
Scalar | takeStep (Scalar dt, StepSizeType flag) |
const StepStatus< Scalar > | getStepStatus () const |
Overridden from InterpolationBufferBase | |
RCP< const Thyra::VectorSpaceBase< Scalar > > | get_x_space () const |
void | addPoints (const Array< Scalar > &time_vec, const Array< RCP< const Thyra::VectorBase< Scalar > > > &x_vec, const Array< RCP< const Thyra::VectorBase< Scalar > > > &xdot_vec) |
TimeRange< Scalar > | getTimeRange () const |
void | getPoints (const Array< Scalar > &time_vec, Array< RCP< const Thyra::VectorBase< Scalar > > > *x_vec, Array< RCP< const Thyra::VectorBase< Scalar > > > *xdot_vec, Array< ScalarMag > *accuracy_vec) const |
void | getNodes (Array< Scalar > *time_vec) const |
void | removeNodes (Array< Scalar > &time_vec) |
int | getOrder () const |
Overridden from Teuchos::ParameterListAcceptor | |
void | setParameterList (RCP< Teuchos::ParameterList > const ¶mList) |
RCP< Teuchos::ParameterList > | getNonconstParameterList () |
RCP< Teuchos::ParameterList > | unsetParameterList () |
RCP< const Teuchos::ParameterList > | getValidParameters () const |
Overridden from Teuchos::Describable | |
std::string | description () const |
void | describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const |
Additional Inherited Members | |
Related Functions inherited from Rythmos::StepperBase< Scalar > | |
template<class Scalar > | |
bool | isInitialized (const StepperBase< Scalar > &stepper) |
template<class Scalar > | |
bool | isInitialized (const StepperBase< Scalar > &stepper) |
Related Functions inherited from Rythmos::InterpolationBufferBase< Scalar > | |
template<class Scalar > | |
RCP< const Thyra::VectorBase < Scalar > > | get_x (const InterpolationBufferBase< Scalar > &interpBuffer, const Scalar &t) |
Get a single point x(t) from an interpolation buffer. More... | |
template<class Scalar > | |
RCP< const Thyra::VectorBase < Scalar > > | get_xdot (const InterpolationBufferBase< Scalar > &interpBuffer, const Scalar &t) |
Get a single point xdot(t) from an interpolation buffer. More... | |
template<class Scalar > | |
void | get_x_and_x_dot (const InterpolationBufferBase< Scalar > &interpBuffer, const Scalar t, const Ptr< RCP< const Thyra::VectorBase< Scalar > > > &x, const Ptr< RCP< const Thyra::VectorBase< Scalar > > > &x_dot) |
Nonmember helper function to get x and x_dot at t. More... | |
template<class Scalar > | |
void | assertTimePointsAreSorted (const Array< Scalar > &time_vec) |
Assert that a time point vector is sorted. More... | |
template<class Scalar > | |
void | assertNoTimePointsBeforeCurrentTimeRange (const InterpolationBufferBase< Scalar > &interpBuffer, const Array< Scalar > &time_vec, const int &startingTimePointIndex=0) |
Assert that none of the time points fall before the current time range for an interpolation buffer object. More... | |
template<class Scalar > | |
void | assertNoTimePointsInsideCurrentTimeRange (const InterpolationBufferBase< Scalar > &interpBuffer, const Array< Scalar > &time_vec) |
Assert that none of the time points fall inside the current time range for an interpolation buffer object. More... | |
template<class TimeType > | |
void | selectPointsInTimeRange (const Array< TimeType > &points_in, const TimeRange< TimeType > &range, const Ptr< Array< TimeType > > &points_out) |
Select points from an Array that sit in a TimeRange. More... | |
template<class TimeType > | |
void | removePointsInTimeRange (Array< TimeType > *points_in, const TimeRange< TimeType > &range) |
Remove points from an Array that sit in a TimeRange. More... | |
template<class Scalar > | |
bool | getCurrentPoints (const InterpolationBufferBase< Scalar > &interpBuffer, const Array< Scalar > &time_vec, Array< RCP< const Thyra::VectorBase< Scalar > > > *x_vec, Array< RCP< const Thyra::VectorBase< Scalar > > > *xdot_vec, int *nextTimePointIndex) |
Get time points in the current range of an interpolation buffer object. More... | |
Definition at line 52 of file Rythmos_ImplicitBDFStepper_decl.hpp.
typedef Teuchos::ScalarTraits<Scalar>::magnitudeType Rythmos::ImplicitBDFStepper< Scalar >::ScalarMag |
Definition at line 59 of file Rythmos_ImplicitBDFStepper_decl.hpp.
Rythmos::ImplicitBDFStepper< Scalar >::ImplicitBDFStepper | ( | ) |
Constructors, intializers, Misc.
Definition at line 78 of file Rythmos_ImplicitBDFStepper_def.hpp.
Rythmos::ImplicitBDFStepper< Scalar >::ImplicitBDFStepper | ( | const RCP< Thyra::ModelEvaluator< Scalar > > & | model, |
const RCP< Thyra::NonlinearSolverBase< Scalar > > & | solver | ||
) |
Definition at line 104 of file Rythmos_ImplicitBDFStepper_def.hpp.
Rythmos::ImplicitBDFStepper< Scalar >::ImplicitBDFStepper | ( | const RCP< Thyra::ModelEvaluator< Scalar > > & | model, |
const RCP< Thyra::NonlinearSolverBase< Scalar > > & | solver, | ||
const RCP< Teuchos::ParameterList > & | parameterList | ||
) |
Definition at line 87 of file Rythmos_ImplicitBDFStepper_def.hpp.
RCP<const Thyra::VectorBase<Scalar> > Rythmos::ImplicitBDFStepper< Scalar >::get_solution | ( | ) | const |
RCP<const Thyra::VectorBase<Scalar> > Rythmos::ImplicitBDFStepper< Scalar >::get_residual | ( | ) | const |
const Thyra::VectorBase< Scalar > & Rythmos::ImplicitBDFStepper< Scalar >::getxHistory | ( | int | index | ) | const |
Definition at line 119 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Reimplemented from Rythmos::StepperBase< Scalar >.
Definition at line 1163 of file Rythmos_ImplicitBDFStepper_def.hpp.
void Rythmos::ImplicitBDFStepper< Scalar >::setStepControlStrategy | ( | const RCP< StepControlStrategyBase< Scalar > > & | stepControlStrategy | ) |
Definition at line 129 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::StepControlStrategyAcceptingStepperBase< Scalar >.
Definition at line 136 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::StepControlStrategyAcceptingStepperBase< Scalar >.
Definition at line 142 of file Rythmos_ImplicitBDFStepper_def.hpp.
void Rythmos::ImplicitBDFStepper< Scalar >::setSolver | ( | const RCP< Thyra::NonlinearSolverBase< Scalar > > & | solver | ) |
Definition at line 152 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::SolverAcceptingStepperBase< Scalar >.
Definition at line 161 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::SolverAcceptingStepperBase< Scalar >.
Definition at line 169 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Overridden from StepperBase.
Returns true.
Reimplemented from Rythmos::StepperBase< Scalar >.
Definition at line 179 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Returns true.
Reimplemented from Rythmos::StepperBase< Scalar >.
Definition at line 185 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Creates copies of all internal data (including the parameter list) except the model which is assumed to stateless.
If a shallow copy of the model is not appropirate for some reason, then the client can simply reset the model using returnVal->setModel()
.
Reimplemented from Rythmos::StepperBase< Scalar >.
Definition at line 193 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::StepperBase< Scalar >.
Definition at line 228 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::StepperBase< Scalar >.
Definition at line 239 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::StepperBase< Scalar >.
Definition at line 249 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::StepperBase< Scalar >.
Definition at line 257 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::StepperBase< Scalar >.
Definition at line 264 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::StepperBase< Scalar >.
Definition at line 295 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::StepperBase< Scalar >.
Definition at line 302 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::StepperBase< Scalar >.
Definition at line 480 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::InterpolationBufferBase< Scalar >.
Definition at line 524 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::InterpolationBufferBase< Scalar >.
Definition at line 532 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::InterpolationBufferBase< Scalar >.
Definition at line 544 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::InterpolationBufferBase< Scalar >.
Definition at line 555 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::InterpolationBufferBase< Scalar >.
Definition at line 631 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::InterpolationBufferBase< Scalar >.
Definition at line 646 of file Rythmos_ImplicitBDFStepper_def.hpp.
|
virtual |
Implements Rythmos::InterpolationBufferBase< Scalar >.
Definition at line 654 of file Rythmos_ImplicitBDFStepper_def.hpp.
void Rythmos::ImplicitBDFStepper< Scalar >::setParameterList | ( | RCP< Teuchos::ParameterList > const & | paramList | ) |
Definition at line 667 of file Rythmos_ImplicitBDFStepper_def.hpp.
RCP< Teuchos::ParameterList > Rythmos::ImplicitBDFStepper< Scalar >::getNonconstParameterList | ( | ) |
Definition at line 679 of file Rythmos_ImplicitBDFStepper_def.hpp.
RCP< Teuchos::ParameterList > Rythmos::ImplicitBDFStepper< Scalar >::unsetParameterList | ( | ) |
Definition at line 687 of file Rythmos_ImplicitBDFStepper_def.hpp.
RCP< const Teuchos::ParameterList > Rythmos::ImplicitBDFStepper< Scalar >::getValidParameters | ( | ) | const |
Definition at line 697 of file Rythmos_ImplicitBDFStepper_def.hpp.
std::string Rythmos::ImplicitBDFStepper< Scalar >::description | ( | ) | const |
Definition at line 725 of file Rythmos_ImplicitBDFStepper_def.hpp.
void Rythmos::ImplicitBDFStepper< Scalar >::describe | ( | Teuchos::FancyOStream & | out, |
const Teuchos::EVerbosityLevel | verbLevel | ||
) | const |
Definition at line 740 of file Rythmos_ImplicitBDFStepper_def.hpp.
const Thyra::SolveStatus< Scalar > & Rythmos::ImplicitBDFStepper< Scalar >::getNonlinearSolveStatus | ( | ) | const |
Returns the Thyra::SolveStatus object from the last nonlinear solve.
Definition at line 1173 of file Rythmos_ImplicitBDFStepper_def.hpp.