| 
    Rythmos - Transient Integration for Differential Equations
    Version of the Day
    
   | 
 
#include <Rythmos_ImplicitRKStepper_decl.hpp>

Public Types | |
| typedef ScalarTraits< Scalar > ::magnitudeType  | ScalarMag | 
  Public Types inherited from Rythmos::InterpolationBufferBase< Scalar > | |
| typedef Teuchos::ScalarTraits < Scalar >::magnitudeType  | ScalarMag | 
Public Member Functions | |
| void | setDirk (bool isDirk) | 
  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... | |
| virtual void | setStepControlData (const StepperBase &stepper) | 
| Set step control data from another stepper.  More... | |
  Public Member Functions inherited from Rythmos::InterpolationBufferBase< Scalar > | |
| 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.  More... | |
  Public Member Functions inherited from Rythmos::RKButcherTableauAcceptingStepperBase< Scalar > | |
| virtual void | setRKButcherTableau (const Teuchos::RCP< const RKButcherTableauBase< Scalar > > &rkbt)=0 | 
  Public Member Functions inherited from Rythmos::StepControlStrategyAcceptingStepperBase< Scalar > | |
| virtual void | setStepControlStrategy (const Teuchos::RCP< StepControlStrategyBase< Scalar > > &stepControlStrategy)=0 | 
Public Attributes | |
| bool | isEmbeddedRK_ = false | 
Related Functions | |
(Note that these are not member functions.)  | |
| template<class Scalar > | |
| RCP< ImplicitRKStepper< Scalar > > | implicitRKStepper () | 
| Nonmember constructor.  More... | |
| template<class Scalar > | |
| RCP< ImplicitRKStepper< Scalar > > | implicitRKStepper () | 
| Nonmember constructor.  More... | |
  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... | |
Constructors, intializers, Misc. | |
| ImplicitRKStepper () | |
| void | set_W_factory (const RCP< Thyra::LinearOpWithSolveFactoryBase< Scalar > > &irk_W_factory) | 
| RCP< const  Thyra::LinearOpWithSolveFactoryBase < Scalar > >  | get_W_factory () const | 
Overridden from RKButcherTableauAcceptingStepperBase | |
| void | setRKButcherTableau (const RCP< const RKButcherTableauBase< Scalar > > &rkButcherTableau) | 
| RCP< const  RKButcherTableauBase< Scalar > >  | getRKButcherTableau () const | 
Overridden from SolverAcceptingStepperBase | |
| void | setSolver (const RCP< Thyra::NonlinearSolverBase< Scalar > > &solver) | 
| RCP < Thyra::NonlinearSolverBase < Scalar > >  | getNonconstSolver () | 
| RCP< const  Thyra::NonlinearSolverBase < Scalar > >  | getSolver () const | 
Overridden from StepperBase | |
| bool | isImplicit () const | 
| Returns true.  More... | |
| bool | supportsCloning () const | 
| Returns true.  More... | |
| RCP< StepperBase< Scalar > > | cloneStepperAlgorithm () const | 
| 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 StepControlStrategyAcceptingStepperBase | |
| void | setStepControlStrategy (const RCP< StepControlStrategyBase< Scalar > > &stepControlStrategy) | 
| RCP< StepControlStrategyBase < Scalar > >  | getNonconstStepControlStrategy () | 
| RCP< const  StepControlStrategyBase < Scalar > >  | getStepControlStrategy () 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< ParameterList > const ¶mList) | 
| RCP< ParameterList > | getNonconstParameterList () | 
| RCP< ParameterList > | unsetParameterList () | 
| RCP< const ParameterList > | getValidParameters () const | 
Overridden from Teuchos::Describable | |
| void | describe (FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const | 
Definition at line 50 of file Rythmos_ImplicitRKStepper_decl.hpp.
| typedef ScalarTraits<Scalar>::magnitudeType Rythmos::ImplicitRKStepper< Scalar >::ScalarMag | 
Definition at line 58 of file Rythmos_ImplicitRKStepper_decl.hpp.
| Rythmos::ImplicitRKStepper< Scalar >::ImplicitRKStepper | ( | ) | 
Definition at line 91 of file Rythmos_ImplicitRKStepper_def.hpp.
| RCP< const Thyra::LinearOpWithSolveFactoryBase< Scalar > > Rythmos::ImplicitRKStepper< Scalar >::get_W_factory | ( | ) | const | 
Definition at line 129 of file Rythmos_ImplicitRKStepper_def.hpp.
| void Rythmos::ImplicitRKStepper< Scalar >::setRKButcherTableau | ( | const RCP< const RKButcherTableauBase< Scalar > > & | rkButcherTableau | ) | 
Definition at line 871 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::RKButcherTableauAcceptingStepperBase< Scalar >.
Definition at line 891 of file Rythmos_ImplicitRKStepper_def.hpp.
| void Rythmos::ImplicitRKStepper< Scalar >::setDirk | ( | bool | isDirk | ) | 
Definition at line 897 of file Rythmos_ImplicitRKStepper_def.hpp.
| void Rythmos::ImplicitRKStepper< Scalar >::setSolver | ( | const RCP< Thyra::NonlinearSolverBase< Scalar > > & | solver | ) | 
Definition at line 138 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::SolverAcceptingStepperBase< Scalar >.
Definition at line 149 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::SolverAcceptingStepperBase< Scalar >.
Definition at line 157 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Returns true.
Reimplemented from Rythmos::StepperBase< Scalar >.
Definition at line 167 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Returns true.
Reimplemented from Rythmos::StepperBase< Scalar >.
Definition at line 173 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Reimplemented from Rythmos::StepperBase< Scalar >.
Definition at line 181 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::StepperBase< Scalar >.
Definition at line 233 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::StepperBase< Scalar >.
Definition at line 244 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::StepperBase< Scalar >.
Definition at line 254 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::StepperBase< Scalar >.
Definition at line 262 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::StepperBase< Scalar >.
Definition at line 269 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::StepperBase< Scalar >.
Definition at line 330 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::StepperBase< Scalar >.
Definition at line 337 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::StepperBase< Scalar >.
Definition at line 617 of file Rythmos_ImplicitRKStepper_def.hpp.
| void Rythmos::ImplicitRKStepper< Scalar >::setStepControlStrategy | ( | const RCP< StepControlStrategyBase< Scalar > > & | stepControlStrategy | ) | 
Definition at line 226 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::StepControlStrategyAcceptingStepperBase< Scalar >.
Definition at line 214 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::StepControlStrategyAcceptingStepperBase< Scalar >.
Definition at line 220 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::InterpolationBufferBase< Scalar >.
Definition at line 649 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::InterpolationBufferBase< Scalar >.
Definition at line 656 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::InterpolationBufferBase< Scalar >.
Definition at line 667 of file Rythmos_ImplicitRKStepper_def.hpp.
| void Rythmos::ImplicitRKStepper< Scalar >::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 | 
Definition at line 674 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::InterpolationBufferBase< Scalar >.
Definition at line 697 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::InterpolationBufferBase< Scalar >.
Definition at line 712 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  virtual | 
Implements Rythmos::InterpolationBufferBase< Scalar >.
Definition at line 719 of file Rythmos_ImplicitRKStepper_def.hpp.
| void Rythmos::ImplicitRKStepper< Scalar >::setParameterList | ( | RCP< ParameterList > const & | paramList | ) | 
Definition at line 729 of file Rythmos_ImplicitRKStepper_def.hpp.
| RCP< ParameterList > Rythmos::ImplicitRKStepper< Scalar >::getNonconstParameterList | ( | ) | 
Definition at line 742 of file Rythmos_ImplicitRKStepper_def.hpp.
| RCP< ParameterList > Rythmos::ImplicitRKStepper< Scalar >::unsetParameterList | ( | ) | 
Definition at line 750 of file Rythmos_ImplicitRKStepper_def.hpp.
| RCP< const ParameterList > Rythmos::ImplicitRKStepper< Scalar >::getValidParameters | ( | ) | const | 
Definition at line 761 of file Rythmos_ImplicitRKStepper_def.hpp.
| void Rythmos::ImplicitRKStepper< Scalar >::describe | ( | FancyOStream & | out, | 
| const Teuchos::EVerbosityLevel | verbLevel | ||
| ) | const | 
Definition at line 780 of file Rythmos_ImplicitRKStepper_def.hpp.
      
  | 
  related | 
Nonmember constructor.
      
  | 
  related | 
Nonmember constructor.
Definition at line 58 of file Rythmos_ImplicitRKStepper_def.hpp.
| bool Rythmos::ImplicitRKStepper< Scalar >::isEmbeddedRK_ = false | 
Definition at line 233 of file Rythmos_ImplicitRKStepper_decl.hpp.
 1.8.5