Rythmos - Transient Integration for Differential Equations Version of the Day
|
#include <Rythmos_ExplicitRKStepper_decl.hpp>
Public Member Functions | |
ExplicitRKStepper () | |
![]() | |
virtual void | setRKButcherTableau (const Teuchos::RCP< const RKButcherTableauBase< Scalar > > &rkbt)=0 |
virtual RCP< const RKButcherTableauBase< Scalar > > | getRKButcherTableau () const =0 |
![]() | |
virtual bool | supportsCloning () const |
Return if this stepper supports cloning or not. | |
virtual RCP< StepperBase< Scalar > > | cloneStepperAlgorithm () const |
Clone the stepper object if supported. | |
virtual bool | isImplicit () const |
Return if this stepper is an implicit stepper. | |
virtual bool | acceptsModel () const |
Return if this stepper accepts a model. | |
virtual void | setModel (const RCP< const Thyra::ModelEvaluator< Scalar > > &model)=0 |
Specify the model problem to integrate. | |
virtual void | setNonconstModel (const RCP< Thyra::ModelEvaluator< Scalar > > &model)=0 |
Accept a nonconst model. | |
virtual bool | modelIsConst () const |
Return of the model is only const or can be returned as a non-const object. | |
virtual RCP< const Thyra::ModelEvaluator< Scalar > > | getModel () const =0 |
Get the model. | |
virtual RCP< Thyra::ModelEvaluator< Scalar > > | getNonconstModel ()=0 |
Get the model nonconst. | |
virtual void | setInitialCondition (const Thyra::ModelEvaluatorBase::InArgs< Scalar > &initialCondition)=0 |
Specify initial condition and re-initialize. | |
virtual Thyra::ModelEvaluatorBase::InArgs< Scalar > | getInitialCondition () const =0 |
Get the currently set initial condtion. | |
virtual Scalar | takeStep (Scalar dt, StepSizeType stepType)=0 |
Take a step. | |
virtual const StepStatus< Scalar > | getStepStatus () const =0 |
Get current stepper status after a step has been taken. | |
virtual void | setStepControlData (const StepperBase &stepper) |
Set step control data from another stepper. | |
![]() | |
virtual RCP< const Thyra::VectorSpaceBase< Scalar > > | get_x_space () const =0 |
Return the space for x and x_dot . | |
virtual 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)=0 |
Add points to the buffer. | |
virtual TimeRange< Scalar > | getTimeRange () const =0 |
Return the range of time values where interpolation calls can be performed. | |
virtual 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 =0 |
Get values from the buffer at different time points. | |
virtual void | getNodes (Array< Scalar > *time_vec) const =0 |
Get interpolation nodes. | |
virtual void | removeNodes (Array< Scalar > &time_vec)=0 |
Remove nodes from the interpolation buffer. | |
virtual int | getOrder () const =0 |
Get order of interpolation. | |
![]() | |
virtual void | setStepControlStrategy (const Teuchos::RCP< StepControlStrategyBase< Scalar > > &stepControlStrategy)=0 |
virtual Teuchos::RCP< StepControlStrategyBase< Scalar > > | getNonconstStepControlStrategy ()=0 |
virtual Teuchos::RCP< const StepControlStrategyBase< Scalar > > | getStepControlStrategy () const =0 |
Overridden from StepControlStrategyAcceptingStepperBase | |
void | setStepControlStrategy (const RCP< StepControlStrategyBase< Scalar > > &stepControlStrategy) |
RCP< StepControlStrategyBase< Scalar > > | getNonconstStepControlStrategy () |
RCP< const StepControlStrategyBase< Scalar > > | getStepControlStrategy () const |
Overridden from StepperBase | |
bool | supportsCloning () const |
RCP< StepperBase< Scalar > > | cloneStepperAlgorithm () const |
Overridden from RKButcherTableauAcceptingStepperBase | |
void | setRKButcherTableau (const RCP< const RKButcherTableauBase< Scalar > > &rkbt) |
RCP< const RKButcherTableauBase< Scalar > > | getRKButcherTableau () const |
Teuchos::RCP< const Thyra::VectorSpaceBase< Scalar > > | get_x_space () const |
void | setModel (const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &model) |
void | setNonconstModel (const Teuchos::RCP< Thyra::ModelEvaluator< Scalar > > &model) |
Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > | getModel () const |
RCP< Thyra::ModelEvaluator< Scalar > > | getNonconstModel () |
~ExplicitRKStepper () | |
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 |
void | describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const |
void | addPoints (const Array< Scalar > &time_vec, const Array< Teuchos::RCP< const Thyra::VectorBase< Scalar > > > &x_vec, const Array< Teuchos::RCP< const Thyra::VectorBase< Scalar > > > &xdot_vec) |
void | getPoints (const Array< Scalar > &time_vec, Array< RCP< const VectorBase< Scalar > > > *x_vec, Array< RCP< const VectorBase< Scalar > > > *xdot_vec, Array< ScalarMag > *accuracy_vec) const |
Get values from buffer. | |
TimeRange< Scalar > | getTimeRange () const |
void | getNodes (Array< Scalar > *time_vec) const |
Get interpolation nodes. | |
void | removeNodes (Array< Scalar > &time_vec) |
Remove interpolation nodes. | |
int | getOrder () const |
Get order of interpolation. | |
void | setParameterList (Teuchos::RCP< Teuchos::ParameterList > const ¶mList) |
Redefined from Teuchos::ParameterListAcceptor. | |
Teuchos::RCP< Teuchos::ParameterList > | getNonconstParameterList () |
Teuchos::RCP< Teuchos::ParameterList > | unsetParameterList () |
RCP< const Teuchos::ParameterList > | getValidParameters () const |
Additional Inherited Members | |
![]() | |
typedef Teuchos::ScalarTraits< Scalar >::magnitudeType | ScalarMag |
![]() | |
template<class Scalar > | |
bool | isInitialized (const StepperBase< Scalar > &stepper) |
template<class Scalar > | |
bool | isInitialized (const StepperBase< Scalar > &stepper) |
![]() | |
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. | |
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. | |
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. | |
template<class Scalar > | |
void | assertTimePointsAreSorted (const Array< Scalar > &time_vec) |
Assert that a time point vector is sorted. | |
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. | |
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. | |
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. | |
template<class TimeType > | |
void | removePointsInTimeRange (Array< TimeType > *points_in, const TimeRange< TimeType > &range) |
Remove points from an Array that sit in a TimeRange. | |
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. | |
Definition at line 44 of file Rythmos_ExplicitRKStepper_decl.hpp.
Rythmos::ExplicitRKStepper< Scalar >::ExplicitRKStepper |
Definition at line 84 of file Rythmos_ExplicitRKStepper_def.hpp.
Rythmos::ExplicitRKStepper< Scalar >::~ExplicitRKStepper |
Definition at line 168 of file Rythmos_ExplicitRKStepper_def.hpp.
|
virtual |
Reimplemented from Rythmos::StepperBase< Scalar >.
Definition at line 627 of file Rythmos_ExplicitRKStepper_def.hpp.
|
virtual |
Reimplemented from Rythmos::StepperBase< Scalar >.
Definition at line 633 of file Rythmos_ExplicitRKStepper_def.hpp.
void Rythmos::ExplicitRKStepper< Scalar >::setRKButcherTableau | ( | const RCP< const RKButcherTableauBase< Scalar > > & | rkbt | ) |
Definition at line 113 of file Rythmos_ExplicitRKStepper_def.hpp.
|
virtual |
Implements Rythmos::RKButcherTableauAcceptingStepperBase< Scalar >.
Definition at line 135 of file Rythmos_ExplicitRKStepper_def.hpp.
|
virtual |
Implements Rythmos::InterpolationBufferBase< Scalar >.
Definition at line 173 of file Rythmos_ExplicitRKStepper_def.hpp.
void Rythmos::ExplicitRKStepper< Scalar >::setModel | ( | const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > & | model | ) |
Definition at line 548 of file Rythmos_ExplicitRKStepper_def.hpp.
void Rythmos::ExplicitRKStepper< Scalar >::setNonconstModel | ( | const Teuchos::RCP< Thyra::ModelEvaluator< Scalar > > & | model | ) |
Definition at line 558 of file Rythmos_ExplicitRKStepper_def.hpp.
|
virtual |
Implements Rythmos::StepperBase< Scalar >.
Definition at line 566 of file Rythmos_ExplicitRKStepper_def.hpp.
|
virtual |
Implements Rythmos::StepperBase< Scalar >.
Definition at line 574 of file Rythmos_ExplicitRKStepper_def.hpp.
|
virtual |
Implements Rythmos::StepperBase< Scalar >.
Definition at line 581 of file Rythmos_ExplicitRKStepper_def.hpp.
|
virtual |
Implements Rythmos::StepperBase< Scalar >.
Definition at line 621 of file Rythmos_ExplicitRKStepper_def.hpp.
|
virtual |
Implements Rythmos::StepperBase< Scalar >.
Definition at line 180 of file Rythmos_ExplicitRKStepper_def.hpp.
|
virtual |
Implements Rythmos::StepperBase< Scalar >.
Definition at line 388 of file Rythmos_ExplicitRKStepper_def.hpp.
void Rythmos::ExplicitRKStepper< Scalar >::describe | ( | Teuchos::FancyOStream & | out, |
const Teuchos::EVerbosityLevel | verbLevel | ||
) | const |
Definition at line 411 of file Rythmos_ExplicitRKStepper_def.hpp.
void Rythmos::ExplicitRKStepper< Scalar >::addPoints | ( | const Array< Scalar > & | time_vec, |
const Array< Teuchos::RCP< const Thyra::VectorBase< Scalar > > > & | x_vec, | ||
const Array< Teuchos::RCP< const Thyra::VectorBase< Scalar > > > & | xdot_vec | ||
) |
Redefined from InterpolationBufferBase Add points to buffer
Definition at line 444 of file Rythmos_ExplicitRKStepper_def.hpp.
void Rythmos::ExplicitRKStepper< Scalar >::getPoints | ( | const Array< Scalar > & | time_vec, |
Array< RCP< const VectorBase< Scalar > > > * | x_vec, | ||
Array< RCP< const VectorBase< Scalar > > > * | xdot_vec, | ||
Array< ScalarMag > * | accuracy_vec | ||
) | const |
Get values from buffer.
Definition at line 464 of file Rythmos_ExplicitRKStepper_def.hpp.
|
virtual |
Implements Rythmos::InterpolationBufferBase< Scalar >.
Definition at line 454 of file Rythmos_ExplicitRKStepper_def.hpp.
|
virtual |
Get interpolation nodes.
Implements Rythmos::InterpolationBufferBase< Scalar >.
Definition at line 485 of file Rythmos_ExplicitRKStepper_def.hpp.
|
virtual |
Remove interpolation nodes.
Implements Rythmos::InterpolationBufferBase< Scalar >.
Definition at line 499 of file Rythmos_ExplicitRKStepper_def.hpp.
|
virtual |
Get order of interpolation.
Implements Rythmos::InterpolationBufferBase< Scalar >.
Definition at line 505 of file Rythmos_ExplicitRKStepper_def.hpp.
void Rythmos::ExplicitRKStepper< Scalar >::setParameterList | ( | Teuchos::RCP< Teuchos::ParameterList > const & | paramList | ) |
Redefined from Teuchos::ParameterListAcceptor.
Definition at line 511 of file Rythmos_ExplicitRKStepper_def.hpp.
Teuchos::RCP< Teuchos::ParameterList > Rythmos::ExplicitRKStepper< Scalar >::getNonconstParameterList |
Definition at line 520 of file Rythmos_ExplicitRKStepper_def.hpp.
Teuchos::RCP< Teuchos::ParameterList > Rythmos::ExplicitRKStepper< Scalar >::unsetParameterList |
Definition at line 526 of file Rythmos_ExplicitRKStepper_def.hpp.
RCP< const Teuchos::ParameterList > Rythmos::ExplicitRKStepper< Scalar >::getValidParameters |
Definition at line 535 of file Rythmos_ExplicitRKStepper_def.hpp.
void Rythmos::ExplicitRKStepper< Scalar >::setStepControlStrategy | ( | const RCP< StepControlStrategyBase< Scalar > > & | stepControlStrategy | ) |
Definition at line 670 of file Rythmos_ExplicitRKStepper_def.hpp.
|
virtual |
Implements Rythmos::StepControlStrategyAcceptingStepperBase< Scalar >.
Definition at line 658 of file Rythmos_ExplicitRKStepper_def.hpp.
|
virtual |
Implements Rythmos::StepControlStrategyAcceptingStepperBase< Scalar >.
Definition at line 664 of file Rythmos_ExplicitRKStepper_def.hpp.