Allows to export a tailored implicit Runge-Kutta integrator for fast model predictive control. More...
#include <irk_export.hpp>
Public Member Functions | |
virtual returnValue | getCode (ExportStatementBlock &code) |
virtual returnValue | getDataDeclarations (ExportStatementBlock &declarations, ExportStruct dataStruct=ACADO_ANY) const |
virtual returnValue | getFunctionDeclarations (ExportStatementBlock &declarations) const |
ImplicitRungeKuttaExport (UserInteraction *_userInteraction=0, const std::string &_commonHeaderName="") | |
ImplicitRungeKuttaExport (const ImplicitRungeKuttaExport &arg) | |
ImplicitRungeKuttaExport & | operator= (const ImplicitRungeKuttaExport &arg) |
virtual returnValue | setDifferentialEquation (const Expression &rhs) |
returnValue | setEigenvalues (const DMatrix &_eig) |
returnValue | setModel (const std::string &_rhs, const std::string &_diffs_rhs) |
returnValue | setSimplifiedTransformations (const DMatrix &_transf1, const DMatrix &_transf2) |
returnValue | setSimplifiedTransformations (const DMatrix &_transf1, const DMatrix &_transf2, const DMatrix &_transf1_T, const DMatrix &_transf2_T) |
returnValue | setSingleTransformations (const double _tau, const DVector &_low_tria, const DMatrix &_transf1, const DMatrix &_transf2) |
returnValue | setSingleTransformations (const double _tau, const DVector &_low_tria, const DMatrix &_transf1, const DMatrix &_transf2, const DMatrix &_transf1_T, const DMatrix &_transf2_T) |
virtual returnValue | setup () |
virtual returnValue | setupOutput (const std::vector< Grid > outputGrids_, const std::vector< Expression > rhs) |
virtual returnValue | setupOutput (const std::vector< Grid > outputGrids_, const std::vector< std::string > _outputNames, const std::vector< std::string > _diffs_outputNames, const std::vector< uint > _dims_output) |
virtual returnValue | setupOutput (const std::vector< Grid > outputGrids_, const std::vector< std::string > _outputNames, const std::vector< std::string > _diffs_outputNames, const std::vector< uint > _dims_output, const std::vector< DMatrix > _outputDependencies) |
virtual | ~ImplicitRungeKuttaExport () |
Public Member Functions inherited from RungeKuttaExport | |
BooleanType | checkSymmetry (const DVector &_cc) |
uint | getNumStages () |
returnValue | initializeButcherTableau (const DMatrix &_AA, const DVector &_bb, const DVector &_cc) |
RungeKuttaExport & | operator= (const RungeKuttaExport &arg) |
RungeKuttaExport (UserInteraction *_userInteraction=0, const std::string &_commonHeaderName="") | |
RungeKuttaExport (const RungeKuttaExport &arg) | |
returnValue | setNARXmodel (const uint delay, const DMatrix &parms) |
virtual | ~RungeKuttaExport () |
Public Member Functions inherited from IntegratorExport | |
virtual bool | equidistantControlGrid () const |
uint | getDimOUTPUT (uint index) const |
virtual returnValue | getGrid (Grid &grid_) const |
const std::string | getNameDiffsOUTPUT (uint index) const |
const std::string | getNameDiffsRHS () const |
virtual const std::string | getNameFullRHS () const |
const std::string | getNameOUTPUT (uint index) const |
const std::string | getNameOutputDiffs () const |
const std::string | getNameOutputRHS () const |
const std::string | getNameRHS () const |
virtual returnValue | getNumSteps (DVector &_numSteps) const |
virtual returnValue | getOutputExpressions (std::vector< Expression > &outputExpressions_) const |
virtual returnValue | getOutputGrids (std::vector< Grid > &outputGrids_) const |
IntegratorExport (UserInteraction *_userInteraction=0, const std::string &_commonHeaderName="") | |
IntegratorExport (const IntegratorExport &arg) | |
IntegratorExport & | operator= (const IntegratorExport &arg) |
virtual returnValue | propagateImplicitSystem (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &_index3, const ExportIndex &tmp_index) |
virtual returnValue | propagateInputSystem (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &index3, const ExportIndex &tmp_index) |
virtual returnValue | propagateOutputSystem (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &index3, const ExportIndex &tmp_index) |
virtual returnValue | setGrid (const Grid &_grid) |
virtual returnValue | setLinearInput (const DMatrix &M1, const DMatrix &A1, const DMatrix &B1) |
virtual returnValue | setLinearOutput (const DMatrix &M3, const DMatrix &A3, const Expression &rhs) |
virtual returnValue | setLinearOutput (const DMatrix &M3, const DMatrix &A3, const std::string &_rhs3, const std::string &_diffs_rhs3) |
virtual returnValue | setModelData (const ModelData &data) |
virtual returnValue | setNonlinearFeedback (const DMatrix &C, const Expression &feedb) |
virtual returnValue | updateImplicitSystem (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &tmp_index) |
virtual returnValue | updateInputSystem (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &tmp_index) |
virtual returnValue | updateOutputSystem (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &tmp_index) |
virtual | ~IntegratorExport () |
Public Member Functions inherited from ExportAlgorithm | |
ExportAlgorithm (UserInteraction *_userInteraction=0, const std::string &_commonHeaderName=std::string()) | |
uint | getN () const |
uint | getNDX () const |
uint | getNOD () const |
uint | getNP () const |
uint | getNU () const |
uint | getNX () const |
uint | getNXA () const |
uint | getNY () const |
uint | getNYN () const |
returnValue | setDimensions (uint _NX=0, uint _NU=0, uint _NP=0, uint _NI=0, uint _NOD=0) |
returnValue | setDimensions (uint _NX, uint _NDX, uint _NXA, uint _NU, uint _NP, uint _NI, uint _NOD) |
void | setNY (uint NY_) |
void | setNYN (uint NYN_) |
virtual | ~ExportAlgorithm () |
Public Member Functions inherited from AlgorithmicBase | |
int | addLogRecord (LogRecord &_record) |
returnValue | addOption (OptionsName name, int value) |
returnValue | addOption (OptionsName name, double value) |
returnValue | addOption (uint idx, OptionsName name, int value) |
returnValue | addOption (uint idx, OptionsName name, double value) |
returnValue | addOptionsList () |
AlgorithmicBase () | |
AlgorithmicBase (UserInteraction *_userInteraction) | |
AlgorithmicBase (const AlgorithmicBase &rhs) | |
returnValue | get (OptionsName name, int &value) const |
returnValue | get (OptionsName name, double &value) const |
returnValue | get (OptionsName name, std::string &value) const |
returnValue | get (uint idx, OptionsName name, int &value) const |
returnValue | get (uint idx, OptionsName name, double &value) const |
returnValue | getAll (LogName _name, MatrixVariablesGrid &values) const |
returnValue | getFirst (LogName _name, DMatrix &firstValue) const |
returnValue | getFirst (LogName _name, VariablesGrid &firstValue) const |
returnValue | getLast (LogName _name, DMatrix &lastValue) const |
returnValue | getLast (LogName _name, VariablesGrid &lastValue) const |
Options | getOptions (uint idx) const |
BooleanType | haveOptionsChanged () const |
BooleanType | haveOptionsChanged (uint idx) const |
AlgorithmicBase & | operator= (const AlgorithmicBase &rhs) |
returnValue | plot (PlotFrequency _frequency=PLOT_IN_ANY_CASE) |
returnValue | printLogRecord (std::ostream &_stream, int idx, LogPrintMode _mode=PRINT_ITEM_BY_ITEM) const |
returnValue | replot (PlotFrequency _frequency=PLOT_IN_ANY_CASE) |
returnValue | set (OptionsName name, int value) |
returnValue | set (OptionsName name, double value) |
returnValue | set (OptionsName name, const std::string &value) |
returnValue | set (uint idx, OptionsName name, int value) |
returnValue | set (uint idx, OptionsName name, double value) |
returnValue | setAll (LogName _name, const MatrixVariablesGrid &values) |
returnValue | setLast (LogName _name, int lastValue, double time=-INFTY) |
returnValue | setLast (LogName _name, double lastValue, double time=-INFTY) |
returnValue | setLast (LogName _name, const DVector &lastValue, double time=-INFTY) |
returnValue | setLast (LogName _name, const DMatrix &lastValue, double time=-INFTY) |
returnValue | setLast (LogName _name, const VariablesGrid &lastValue, double time=-INFTY) |
returnValue | setOptions (const Options &arg) |
returnValue | setOptions (uint idx, const Options &arg) |
virtual | ~AlgorithmicBase () |
Allows to export a tailored implicit Runge-Kutta integrator for fast model predictive control.
The class ImplicitRungeKuttaExport allows to export a tailored implicit Runge-Kutta integrator for fast model predictive control.
Definition at line 55 of file irk_export.hpp.
BEGIN_NAMESPACE_ACADO ImplicitRungeKuttaExport::ImplicitRungeKuttaExport | ( | UserInteraction * | _userInteraction = 0 , |
const std::string & | _commonHeaderName = "" |
||
) |
Default constructor.
@param[in] _userInteraction Pointer to corresponding user interface. @param[in] _commonHeaderName Name of common header file to be included.
Definition at line 44 of file irk_export.cpp.
ImplicitRungeKuttaExport::ImplicitRungeKuttaExport | ( | const ImplicitRungeKuttaExport & | arg | ) |
Copy constructor (deep copy).
@param[in] arg Right-hand side object.
Definition at line 67 of file irk_export.cpp.
|
virtual |
Destructor.
Definition at line 91 of file irk_export.cpp.
|
protected |
Recursive function that helps with the computation of the coefficients of polynomials that are used to evaluate the continuous output (see initializeCoefficients), by computing the correct combinations of elements of the vector cc from the Butcher table.
[in] | cVec | The vector with all the elements of the vector cc from the Butcher table, of which combinations are computed in a recursive way. |
[in] | index | An index of the vector cVec which denotes the relevant part for this invocation. |
[in] | numEls | The number of elements in the combination. |
Definition at line 923 of file irk_export.cpp.
|
protectedvirtual |
Copies all class members from given object.
@param[in] arg Right-hand side object. \return SUCCESSFUL_RETURN
Definition at line 1581 of file irk_export.cpp.
Divide the total number of measurements over the different integration steps.
@param[in] index The index of the continuous output for which the division of measurements is returned. \return The division of measurements over the integration steps, corresponding the given continuous output.
Definition at line 1064 of file irk_export.cpp.
|
protected |
Returns the coefficients of the derived polynomial, representing the derivative of the continuous output with respect to time.
@param[in] time The point in the interval (0,1] for which the coefficients are returned. \return Coefficients of the polynomial, corresponding the given grid point
Definition at line 1025 of file irk_export.cpp.
|
protected |
Exports the evaluation of the coefficients of the derived polynomial, representing the derivative of the continuous output with respect to time.
@param[in] block The block to which the code will be exported. @param[in] variable The variable containing the coefficients of the polynomial. @param[in] grid The variable containing the grid point for the specific output. \return SUCCESSFUL_RETURN
Definition at line 1044 of file irk_export.cpp.
Returns the coefficients of the derived polynomial for the complete grid of the output, corresponding a certain index.
@param[in] index The index of the continuous output for which the coefficients are returned. \return Coefficients of the derived polynomial, corresponding the given continuous output
Definition at line 1005 of file irk_export.cpp.
|
protectedvirtual |
Exports the evaluation of the matrix of the linear system.
@param[in] block The block to which the code will be exported. @param[in] index1 The loop index of the outer loop. @param[in] index2 The loop index of the inner loop. @param[in] tmp_index A temporary index to be used. @param[in] Ah The matrix A of the IRK method, multiplied by the step size h. @param[in] evaluateB True if the right-hand side of the linear system should also be evaluated, false otherwise. \return SUCCESSFUL_RETURN
Definition at line 747 of file irk_export.cpp.
|
protected |
Returns the coefficients of the polynomial, representing the continuous output of the integrator.
@param[in] time The point in the interval (0,1] for which the coefficients are returned. \return Coefficients of the polynomial, corresponding the given grid point
Definition at line 965 of file irk_export.cpp.
|
protected |
Exports the evaluation of the coefficients of the polynomial, representing the continuous output of the integrator.
@param[in] block The block to which the code will be exported. @param[in] variable The variable containing the coefficients of the polynomial. @param[in] grid The variable containing the grid point for the specific output. @param[in] h The integration step size. \return SUCCESSFUL_RETURN
Definition at line 981 of file irk_export.cpp.
Returns the coefficients of the polynomial for the complete grid of the output, corresponding a certain index.
@param[in] index The index of the continuous output for which the coefficients are returned. \return Coefficients of the polynomial, corresponding the given continuous output
Definition at line 945 of file irk_export.cpp.
|
protectedvirtual |
Exports the evaluation of the right-hand side of the linear system at a specific stage.
@param[in] block The block to which the code will be exported. @param[in] index The loop index, defining the stage. \return SUCCESSFUL_RETURN
Reimplemented in ForwardLiftedIRKExport.
Definition at line 728 of file irk_export.cpp.
|
protectedvirtual |
Exports the evaluation of the states at a specific stage.
@param[in] block The block to which the code will be exported. @param[in] Ah The matrix A of the IRK method, multiplied by the step size h. @param[in] index The loop index, defining the stage. \return SUCCESSFUL_RETURN
Reimplemented in ForwardLiftedIRKExport.
Definition at line 677 of file irk_export.cpp.
|
protected |
Exports the evaluation of the states at a specific stage.
@param[in] block The block to which the code will be exported. @param[in] Ah The matrix A of the IRK method, multiplied by the step size h. @param[in] index The loop index, defining the stage. \return SUCCESSFUL_RETURN
Definition at line 705 of file irk_export.cpp.
|
protectedvirtual |
Forms a constant linear system matrix for the collocation equations, given a constant jacobian and mass matrix.
@param[in] jacobian given constant Jacobian matrix @param[in] mass given constant mass matrix \return SUCCESSFUL_RETURN
Reimplemented in DiagonallyImplicitRKExport.
Definition at line 549 of file irk_export.cpp.
|
protected |
Exports the necessary code for the computation of the continuous output.
@param[in] block The block to which the code will be exported. @param[in] tmp_meas The number of measurements in the current integration step (in case of an online grid). @param[in] rk_tPrev The time point, defining the beginning of the current integration step (in case of an online grid). @param[in] time_tmp A variable used for time transformations (in case of an online grid). \return SUCCESSFUL_RETURN
Definition at line 791 of file irk_export.cpp.
|
protectedvirtual |
Returns the largest global export variable.
\return SUCCESSFUL_RETURN
Implements IntegratorExport.
Reimplemented in ForwardLiftedIRKExport, ForwardIRKExport, SymmetricIRKExport, ForwardBackwardLiftedIRKExport, FeedbackLiftedIRKExport, AdjointLiftedIRKExport, and SymmetricLiftedIRKExport.
Definition at line 171 of file irk_export.cpp.
|
virtual |
Exports source code of the auto-generated integrator into the given directory.
@param[in] code Code block containing the auto-generated integrator. \return SUCCESSFUL_RETURN
Implements RungeKuttaExport.
Reimplemented in AdjointLiftedIRKExport, FeedbackLiftedIRKExport, ForwardBackwardLiftedIRKExport, ForwardLiftedIRKExport, SymmetricLiftedIRKExport, SymmetricIRKExport, and ForwardIRKExport.
Definition at line 257 of file irk_export.cpp.
|
virtual |
Adds all data declarations of the auto-generated integrator to given list of declarations.
@param[in] declarations List of declarations. \return SUCCESSFUL_RETURN
Implements RungeKuttaExport.
Reimplemented in AdjointLiftedIRKExport, FeedbackLiftedIRKExport, ForwardBackwardLiftedIRKExport, ForwardLiftedIRKExport, SymmetricLiftedIRKExport, SymmetricIRKExport, and ForwardIRKExport.
Definition at line 200 of file irk_export.cpp.
|
virtual |
Adds all function (forward) declarations of the auto-generated integrator to given list of declarations.
@param[in] declarations List of declarations. \return SUCCESSFUL_RETURN
Implements RungeKuttaExport.
Reimplemented in AdjointLiftedIRKExport, FeedbackLiftedIRKExport, ForwardBackwardLiftedIRKExport, ForwardLiftedIRKExport, SymmetricLiftedIRKExport, SymmetricIRKExport, and ForwardIRKExport.
Definition at line 244 of file irk_export.cpp.
|
protected |
Returns the performed number of Newton iterations.
\return The performed number of Newton iterations.
Definition at line 1654 of file irk_export.cpp.
|
protected |
Returns the performed number of Newton iterations for the initialization of the first step.
\return The performed number of Newton iterations for the initialization of the first step.
Definition at line 1660 of file irk_export.cpp.
|
protected |
Initializes the matrix coeffs, containing coefficients of polynomials that are used to evaluate the continuous output (see evaluatePolynomial).
Definition at line 883 of file irk_export.cpp.
|
protected |
Initializes the matrix DD, which is used to extrapolate the variables of the IRK method to the next step.
\return SUCCESSFUL_RETURN
Definition at line 864 of file irk_export.cpp.
ImplicitRungeKuttaExport & ImplicitRungeKuttaExport::operator= | ( | const ImplicitRungeKuttaExport & | arg | ) |
Assignment operator (deep copy).
@param[in] arg Right-hand side object.
Definition at line 101 of file irk_export.cpp.
|
protectedvirtual |
Precompute as much as possible for the linear input system and export the resulting definitions.
@param[in] code The block to which the code will be exported. \return SUCCESSFUL_RETURN
Reimplemented in ForwardIRKExport, FeedbackLiftedIRKExport, ForwardLiftedIRKExport, and DiagonallyImplicitRKExport.
Definition at line 521 of file irk_export.cpp.
|
protected |
Prepares the structures to evaluate the continuous output and exports the resulting definitions.
@param[in] code The block to which the code will be exported. \return SUCCESSFUL_RETURN
Definition at line 1544 of file irk_export.cpp.
|
protectedvirtual |
Precompute as much as possible for the linear output system and export the resulting definitions.
@param[in] code The block to which the code will be exported. \return SUCCESSFUL_RETURN
Reimplemented in DiagonallyImplicitRKExport, ForwardIRKExport, and ForwardLiftedIRKExport.
Definition at line 535 of file irk_export.cpp.
|
virtual |
Assigns Differential Equation to be used by the integrator.
@param[in] rhs Right-hand side expression. \return SUCCESSFUL_RETURN
Implements RungeKuttaExport.
Reimplemented in AdjointLiftedIRKExport, ForwardBackwardLiftedIRKExport, ForwardLiftedIRKExport, SymmetricLiftedIRKExport, and SymmetricIRKExport.
Definition at line 112 of file irk_export.cpp.
returnValue ImplicitRungeKuttaExport::setEigenvalues | ( | const DMatrix & | _eig | ) |
This routine sets the eigenvalues of the inverse of the AA matrix.
Definition at line 1306 of file irk_export.cpp.
|
virtual |
Assigns the model to be used by the integrator.
@param[in] _rhs Name of the function, evaluating the right-hand side. @param[in] _diffs_rhs Name of the function, evaluating the derivatives of the right-hand side. \return SUCCESSFUL_RETURN
Reimplemented from IntegratorExport.
Definition at line 159 of file irk_export.cpp.
returnValue ImplicitRungeKuttaExport::setSimplifiedTransformations | ( | const DMatrix & | _transf1, |
const DMatrix & | _transf2 | ||
) |
This routine sets the transformation matrices, defined by the inverse of the AA matrix.
Definition at line 1323 of file irk_export.cpp.
returnValue ImplicitRungeKuttaExport::setSimplifiedTransformations | ( | const DMatrix & | _transf1, |
const DMatrix & | _transf2, | ||
const DMatrix & | _transf1_T, | ||
const DMatrix & | _transf2_T | ||
) |
Definition at line 1313 of file irk_export.cpp.
returnValue ImplicitRungeKuttaExport::setSingleTransformations | ( | const double | _tau, |
const DVector & | _low_tria, | ||
const DMatrix & | _transf1, | ||
const DMatrix & | _transf2 | ||
) |
This routine sets the transformation matrices, defined by the inverse of the AA matrix.
Definition at line 1331 of file irk_export.cpp.
returnValue ImplicitRungeKuttaExport::setSingleTransformations | ( | const double | _tau, |
const DVector & | _low_tria, | ||
const DMatrix & | _transf1, | ||
const DMatrix & | _transf2, | ||
const DMatrix & | _transf1_T, | ||
const DMatrix & | _transf2_T | ||
) |
Definition at line 1341 of file irk_export.cpp.
|
virtual |
Initializes export of a tailored integrator.
\return SUCCESSFUL_RETURN
Implements RungeKuttaExport.
Reimplemented in DiagonallyImplicitRKExport, ForwardIRKExport, AdjointLiftedIRKExport, FeedbackLiftedIRKExport, ForwardBackwardLiftedIRKExport, ForwardLiftedIRKExport, SymmetricLiftedIRKExport, and SymmetricIRKExport.
Definition at line 1078 of file irk_export.cpp.
|
virtual |
Sets up the output with the grids for the different output functions.
outputGrids_ | The vector containing a grid for each output function. |
rhs | The expressions corresponding the output functions. |
Implements RungeKuttaExport.
Definition at line 1353 of file irk_export.cpp.
|
virtual |
Sets up the output with the grids for the different output functions.
outputGrids_ | The vector containing a grid for each output function. |
_outputNames | The names of the output functions. |
_diffs_outputNames | The names of the functions, evaluating the derivatives of the outputs. |
_dims_output | The dimensions of the output functions. |
Implements IntegratorExport.
Definition at line 1447 of file irk_export.cpp.
|
virtual |
Sets up the output with the grids for the different output functions.
outputGrids_ | The vector containing a grid for each output function. |
_outputNames | The names of the output functions. |
_diffs_outputNames | The names of the functions, evaluating the derivatives of the outputs. |
_dims_output | The dimensions of the output functions. |
_outputDependencies | A separate dependency matrix for each output. |
Implements IntegratorExport.
Definition at line 1527 of file irk_export.cpp.
|
protectedvirtual |
Exports the code needed to solve the system of collocation equations for the nonlinear, fully implicit system.
@param[in] block The block to which the code will be exported. @param[in] Ah The variable containing the internal coefficients of the RK method, multiplied with the step size. @param[in] det The variable that holds the determinant of the matrix in the linear system. \return SUCCESSFUL_RETURN
Reimplemented in ForwardLiftedIRKExport.
Definition at line 603 of file irk_export.cpp.
|
protectedvirtual |
Exports the code needed to solve the system of collocation equations for the linear input system.
@param[in] block The block to which the code will be exported. @param[in] A1 A constant matrix defining the equations of the linear input system. @param[in] B1 A constant matrix defining the equations of the linear input system. @param[in] Ah The variable containing the internal coefficients of the RK method, multiplied with the step size. \return SUCCESSFUL_RETURN
Reimplemented in FeedbackLiftedIRKExport, and DiagonallyImplicitRKExport.
Definition at line 576 of file irk_export.cpp.
|
protectedvirtual |
Exports the code needed to solve the system of collocation equations for the linear output system.
@param[in] block The block to which the code will be exported. @param[in] Ah The variable containing the internal coefficients of the RK method, multiplied with the step size. @param[in] A3 A constant matrix defining the equations of the linear output system. \return SUCCESSFUL_RETURN
Reimplemented in DiagonallyImplicitRKExport.
Definition at line 653 of file irk_export.cpp.
|
protected |
This matrix contains coefficients of polynomials that are used to evaluate the continuous output (see evaluatePolynomial).
Definition at line 533 of file irk_export.hpp.
|
protected |
This boolean is true when continuous output needs to be provided.
Definition at line 520 of file irk_export.hpp.
|
protected |
This matrix is used for the initialization of the variables for the next integration step.
Definition at line 532 of file irk_export.hpp.
|
protected |
Definition at line 572 of file irk_export.hpp.
|
protected |
Definition at line 574 of file irk_export.hpp.
|
protected |
This vector contains an ExportVariable for the grid of each continuous output.
Definition at line 549 of file irk_export.hpp.
|
protected |
Definition at line 566 of file irk_export.hpp.
|
protected |
Definition at line 581 of file irk_export.hpp.
|
protected |
Definition at line 525 of file irk_export.hpp.
|
protected |
Definition at line 535 of file irk_export.hpp.
|
protected |
This is the performed number of Newton iterations.
Definition at line 522 of file irk_export.hpp.
|
protected |
This is the performed number of Newton iterations for the initialization of the first step.
Definition at line 523 of file irk_export.hpp.
|
protected |
Indices containing the number of measurements that are already computed.
Definition at line 556 of file irk_export.hpp.
|
protected |
Variables containing the number of measurements per integration interval.
Definition at line 555 of file irk_export.hpp.
|
protected |
Definition at line 537 of file irk_export.hpp.
|
protected |
Definition at line 536 of file irk_export.hpp.
|
protected |
Definition at line 526 of file irk_export.hpp.
|
protected |
Definition at line 528 of file irk_export.hpp.
|
protected |
Variables containing the coefficients for the derived polynomial.
Definition at line 554 of file irk_export.hpp.
|
protected |
Local variable that is used for the evaluations of the continuous output.
Definition at line 545 of file irk_export.hpp.
|
protected |
Variables containing the coefficients for the polynomial.
Definition at line 553 of file irk_export.hpp.
|
protected |
This boolean is true when the IFTR method is used instead of the IFT method.
Definition at line 519 of file irk_export.hpp.
|
protected |
Variable containing the matrix of the linear system.
Definition at line 561 of file irk_export.hpp.
|
protected |
Variable containing auxiliary values for the exported linear solver.
Definition at line 563 of file irk_export.hpp.
|
protected |
Variable containing the right-hand side of the linear system.
Definition at line 562 of file irk_export.hpp.
|
protected |
Definition at line 571 of file irk_export.hpp.
|
protected |
Variable containing intermediate results of evaluations of the derivatives of an output function.
Definition at line 542 of file irk_export.hpp.
|
protected |
Definition at line 569 of file irk_export.hpp.
|
protected |
Definition at line 559 of file irk_export.hpp.
|
protected |
Definition at line 568 of file irk_export.hpp.
|
protected |
Definition at line 558 of file irk_export.hpp.
|
protected |
Definition at line 567 of file irk_export.hpp.
|
protected |
Variable that is used for the evaluations of the continuous output.
Definition at line 544 of file irk_export.hpp.
|
protected |
Variable that is used for the evaluations of the continuous output.
Definition at line 543 of file irk_export.hpp.
|
protected |
Variables containing the evaluations of the continuous output from the integrator.
Definition at line 552 of file irk_export.hpp.
|
protected |
Variable containing intermediate results of evaluations of the right-hand side expression of an output function.
Definition at line 541 of file irk_export.hpp.
|
protected |
Variable containing intermediate results of evaluations of the right-hand side expression.
Definition at line 564 of file irk_export.hpp.
|
protected |
Definition at line 575 of file irk_export.hpp.
|
protected |
Definition at line 577 of file irk_export.hpp.
|
protected |
Definition at line 576 of file irk_export.hpp.
|
protected |
Definition at line 578 of file irk_export.hpp.
|
protected |
Definition at line 582 of file irk_export.hpp.
|
protected |
Definition at line 585 of file irk_export.hpp.
|
protected |
Definition at line 583 of file irk_export.hpp.
|
protected |
Definition at line 586 of file irk_export.hpp.
|
protected |
This is the exported linear solver that is used by the implicit Runge-Kutta method.
Definition at line 530 of file irk_export.hpp.
|
protected |
Variable defining the different integration step sizes in case of a non equidistant grid.
Definition at line 547 of file irk_export.hpp.
|
protected |
Definition at line 580 of file irk_export.hpp.
|
protected |
This vector contains the total number of measurements per output (per shooting or integration interval, depending on grid type).
Definition at line 550 of file irk_export.hpp.