ACADO Toolkit  1.2.0beta
Toolkit for Automatic Control and Dynamic Optimization
Public Member Functions | Protected Member Functions | Protected Attributes

Allows to export a tailored diagonally implicit 5-stage Runge-Kutta method of order 5 for fast model predictive control. More...

#include <dirk5_export.hpp>

Inheritance diagram for DiagonallyIRK5Export:
Inheritance graph
[legend]

List of all members.

Public Member Functions

virtual returnValue solveInputSystem (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &index3, const ExportIndex &tmp_index, const ExportVariable &Ah)
 Exports the code needed to solve the system of collocation equations for the linear input system.
virtual returnValue prepareInputSystem (ExportStatementBlock &code)
 Precompute as much as possible for the linear input system and export the resulting definitions.
virtual returnValue solveOutputSystem (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &index3, const ExportIndex &tmp_index, const ExportVariable &Ah, BooleanType DERIVATIVES=BT_FALSE)
 Exports the code needed to solve the system of collocation equations for the linear output system.
virtual returnValue sensitivitiesOutputSystem (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &index3, const ExportIndex &index4, const ExportIndex &tmp_index1, const ExportIndex &tmp_index2, const ExportVariable &Ah, const ExportVariable &Bh, BooleanType STATES, uint number)
 Exports the code needed to compute the sensitivities of the states, defined by the linear output system.
virtual returnValue prepareOutputSystem (ExportStatementBlock &code)
 Precompute as much as possible for the linear output system and export the resulting definitions.
virtual Matrix formMatrix (const Matrix &mass, const Matrix &jacobian)
 Forms a constant linear system matrix for the collocation equations, given a constant jacobian and mass matrix.
virtual returnValue solveImplicitSystem (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &index3, const ExportIndex &tmp_index, const ExportVariable &Ah, const ExportVariable &C, const ExportVariable &det, BooleanType DERIVATIVES=BT_FALSE)
 Exports the code needed to solve the system of collocation equations for the nonlinear, fully implicit system.
virtual returnValue sensitivitiesImplicitSystem (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &index3, const ExportIndex &tmp_index1, const ExportIndex &tmp_index2, const ExportVariable &Ah, const ExportVariable &Bh, const ExportVariable &det, BooleanType STATES, uint number)
 Exports the code needed to compute the sensitivities of the states defined by the nonlinear, fully implicit system.
virtual returnValue evaluateMatrix (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &tmp_index, const ExportVariable &Ah, const ExportVariable &C, BooleanType evaluateB, BooleanType DERIVATIVES)
 Exports the evaluation of the matrix of the linear system.
virtual returnValue evaluateStatesImplicitSystem (ExportStatementBlock *block, const ExportVariable &Ah, const ExportVariable &C, const ExportIndex &stage, const ExportIndex &i, const ExportIndex &j)
 Exports the evaluation of the states at a specific stage.
virtual returnValue evaluateRhsImplicitSystem (ExportStatementBlock *block, const ExportIndex &stage)
 Exports the evaluation of the right-hand side of the linear system at a specific stage.
virtual returnValue setup ()
 Initializes export of a tailored integrator.
virtual returnValue getDataDeclarations (ExportStatementBlock &declarations, ExportStruct dataStruct=ACADO_ANY) const
 Adds all data declarations of the auto-generated integrator to given list of declarations.
virtual returnValue getFunctionDeclarations (ExportStatementBlock &declarations) const
 Adds all function (forward) declarations of the auto-generated integrator to given list of declarations.
virtual returnValue getCode (ExportStatementBlock &code)
 Exports source code of the auto-generated integrator into the given directory.
virtual returnValue setDifferentialEquation (const Expression &rhs)
 Assigns Differential Equation to be used by the integrator.
returnValue setModel (const String &_rhs, const String &_diffs_rhs)
 Assigns the model to be used by the integrator.
virtual returnValue setupOutput (const std::vector< Grid > outputGrids_, const std::vector< Expression > rhs)
 Sets up the output with the grids for the different output functions.
virtual returnValue setupOutput (const std::vector< Grid > outputGrids_, const std::vector< String > _outputNames, const std::vector< String > _diffs_outputNames, const std::vector< uint > _dims_output)
 Sets up the output with the grids for the different output functions.
virtual returnValue setupOutput (const std::vector< Grid > outputGrids_, const std::vector< String > _outputNames, const std::vector< String > _diffs_outputNames, const std::vector< uint > _dims_output, const std::vector< Matrix > _outputDependencies)
 Sets up the output with the grids for the different output functions.
returnValue initializeButcherTableau (const Matrix &_AA, const Vector &_bb, const Vector &_cc)
 This routine initializes the matrices AA, bb and cc which form the Butcher Tableau.
returnValue setNARXmodel (const uint delay, const Matrix &parms)
 Sets a polynomial NARX model to be used by the integrator.
uint getNumStages ()
 This routine returns the number of stages of the Runge-Kutta integrator that will be exported.
virtual returnValue setLinearInput (const Matrix &M1, const Matrix &A1, const Matrix &B1)
 
virtual returnValue setLinearOutput (const Matrix &M3, const Matrix &A3, const Expression &rhs)
 
virtual returnValue setLinearOutput (const Matrix &M3, const Matrix &A3, const String &_rhs3, const String &_diffs_rhs3)
 
virtual returnValue setModelData (const ModelData &data)
 Passes all the necessary model data to the integrator.
virtual returnValue updateInputSystem (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &tmp_index)
 Exports the code needed to update the sensitivities of the states, defined by the linear input system.
virtual returnValue propagateInputSystem (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &index3, const ExportIndex &tmp_index)
 Exports the code needed to propagate the sensitivities of the states, defined by the linear input system.
virtual returnValue updateImplicitSystem (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &tmp_index)
 Exports the code needed to update the sensitivities of the states defined by the nonlinear, fully implicit system.
virtual returnValue propagateImplicitSystem (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &index3, const ExportIndex &tmp_index)
 Exports the code needed to propagate the sensitivities of the states defined by the nonlinear, fully implicit system.
virtual returnValue updateOutputSystem (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &tmp_index)
 Exports the code needed to update the sensitivities of the states, defined by the linear output system.
virtual returnValue propagateOutputSystem (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &index3, const ExportIndex &tmp_index)
 Exports the code needed to propagate the sensitivities of the states, defined by the linear output system.
virtual returnValue setGrid (const Grid &_grid)
 Sets integration grid (this grid is expected to be non equidistant, otherwise use the other setGrid function).
virtual returnValue getGrid (Grid &grid_) const
 Returns the grid of the integrator.
virtual returnValue getNumSteps (Vector &_numSteps) const
 Returns the number of integration steps along the prediction horizon.
virtual returnValue getOutputExpressions (std::vector< Expression > &outputExpressions_) const
 Returns the output expressions.
virtual returnValue getOutputGrids (std::vector< Grid > &outputGrids_) const
 Returns the output grids.
virtual BooleanType equidistantControlGrid () const
 Returns whether the grid is equidistant.
const String getNameRHS () const
const String getNameDiffsRHS () const
virtual const String getNameFullRHS () const
const String getNameOutputRHS () const
const String getNameOutputDiffs () const
const String getNameOUTPUT (uint index) const
const String getNameDiffsOUTPUT (uint index) const
uint getDimOUTPUT (uint index) const
returnValue setDimensions (uint _NX=0, uint _NU=0, uint _NP=0, uint _NI=0)
 Sets the variables dimensions (ODE).
returnValue setDimensions (uint _NX, uint _NDX, uint _NXA, uint _NU, uint _NP, uint _NI)
 Sets the variables dimensions (DAE).
uint getNX () const
 Returns number of differential states.
uint getNXA () const
 Returns number of algebraic states.
uint getNDX () const
 Returns the number of differential states derivatives.
uint getNU () const
 Returns number of control inputs.
uint getNP () const
 Returns number of parameters.
uint getN () const
 Returns number of control intervals.
void setNY (uint NY_)
uint getNY () const
void setNYN (uint NYN_)
uint getNYN () const
FILE * openFile (const String &dirName, const String &fileName) const
 Opens given file and prepares it for exporting algorithm.
returnValue addOptionsList ()
 Adds an additional OptionsList to internal array.
returnValue set (OptionsName name, int value)
 Sets value of an existing option item of integer type to a given value.
returnValue set (OptionsName name, double value)
 Sets value of an existing option item of double type to a given value.
returnValue set (uint idx, OptionsName name, int value)
 Sets value of an existing option item of integer type within the option list of given index to a given value.
returnValue set (uint idx, OptionsName name, double value)
 Sets value of an existing option item of double type within the option list of given index to a given value.
returnValue setOptions (const Options &arg)
 Assigns a given Options object to this object.
returnValue setOptions (uint idx, const Options &arg)
 Assigns the option list with given index of a given Options object to option list with given index of this object.
Options getOptions (uint idx) const
 Returns an Options object containing exactly the option list with given index.
returnValue getAll (LogName _name, MatrixVariablesGrid &values) const
 Gets all numerical values at all time instants of the item with given name.
returnValue getFirst (LogName _name, Matrix &firstValue) const
 Gets numerical value at first time instant of the item with given name.
returnValue getFirst (LogName _name, VariablesGrid &firstValue) const
 Gets numerical value at first time instant of the item with given name (converts internally used Matrix into VariablesGrid).
returnValue getLast (LogName _name, Matrix &lastValue) const
 Gets numerical value at last time instant of the item with given name.
returnValue getLast (LogName _name, VariablesGrid &lastValue) const
 Gets numerical value at last time instant of the item with given name (converts internally used Matrix into VariablesGrid).
returnValue get (OptionsName name, int &value) const
 Returns value of an existing option item of integer type.
returnValue get (OptionsName name, double &value) const
 Returns value of an existing option item of double type.
returnValue get (uint idx, OptionsName name, int &value) const
 Returns value of an existing option item of integer type within the option list of given index.
returnValue get (uint idx, OptionsName name, double &value) const
 Returns value of an existing option item of double type within the option list of given index.
returnValue addOption (OptionsName name, int value)
 Add an option item with a given integer default value to the all option lists.
returnValue addOption (OptionsName name, double value)
 Add an option item with a given double default value to the all option lists.
returnValue addOption (uint idx, OptionsName name, int value)
 Add an option item with a given integer default value to option list with given index.
returnValue addOption (uint idx, OptionsName name, double value)
 Add an option item with a given double default value to option list with given index.
BooleanType haveOptionsChanged () const
 Determines whether options of at least one option list have been modified.
BooleanType haveOptionsChanged (uint idx) const
 Determines whether options of option list with given index have been modified.
returnValue setAll (LogName _name, const MatrixVariablesGrid &values)
 Sets all numerical values at all time instants of all items with given name within all records.
returnValue setLast (LogName _name, int lastValue, double time=-INFTY)
 Sets numerical value at last time instant of all items with given name within all records.
returnValue setLast (LogName _name, double lastValue, double time=-INFTY)
 Sets numerical value at last time instant of all items with given name within all records.
returnValue setLast (LogName _name, const Vector &lastValue, double time=-INFTY)
 Sets numerical value at last time instant of all items with given name within all records.
returnValue setLast (LogName _name, const Matrix &lastValue, double time=-INFTY)
 Sets numerical value at last time instant of all items with given name within all records.
returnValue setLast (LogName _name, const VariablesGrid &lastValue, double time=-INFTY)
 Sets numerical value at last time instant of all items with given name within all records.
int addLogRecord (LogRecord &_record)
 Adds a record to the log collection.
returnValue printLogRecord (int idx, LogPrintMode _mode=PRINT_ITEM_BY_ITEM) const
 Prints whole record with specified index into internally specified file; all items are printed according to the output format settings.
returnValue plot (PlotFrequency _frequency=PLOT_IN_ANY_CASE)
 Plots all windows of the plot collection, each one into a new figure.
returnValue replot (PlotFrequency _frequency=PLOT_IN_ANY_CASE)
 Plots all windows of the plot collection, each one into the corresponding existing figure, if possible.

Protected Member Functions

returnValue getCRSIndex (uint output, ExportIndex row, ExportIndex col)
 Returns the index corresponding Compressed Row Storage (CRS) for the dependency matrix of a specific output function.
virtual returnValue sensitivitiesInputSystem (ExportStatementBlock *block, const ExportIndex &index1, const ExportIndex &index2, const ExportVariable &Bh, BooleanType STATES)
 Exports the code needed to compute the sensitivities of the states, defined by the linear input system.
returnValue sensitivitiesOutputs (ExportStatementBlock *block, const ExportIndex &index0, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &tmp_index1, const ExportIndex &tmp_index2, const ExportIndex &tmp_index3, const ExportVariable &tmp_meas, const ExportVariable &time_tmp, BooleanType STATES, uint base)
 Exports the computation of the sensitivities for the continuous output.
virtual returnValue propagateOutputs (ExportStatementBlock *block, const ExportIndex &index, const ExportIndex &index0, const ExportIndex &index1, const ExportIndex &index2, const ExportIndex &index3, const ExportIndex &tmp_index1, const ExportIndex &tmp_index2, const ExportIndex &tmp_index3, const ExportIndex &tmp_index4, const ExportVariable &tmp_meas)
 Exports the propagation of the sensitivities for the continuous output.
ExportVariable getAuxVariable () const
 Returns the largest global export variable.
returnValue initializeDDMatrix ()
 Initializes the matrix DD, which is used to extrapolate the variables of the IRK method to the next step.
returnValue initializeCoefficients ()
 Initializes the matrix coeffs, containing coefficients of polynomials that are used to evaluate the continuous output (see evaluatePolynomial).
Vector computeCombinations (const Vector &cVec, uint index, uint numEls)
 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.
Vector evaluatePolynomial (double time)
 Returns the coefficients of the polynomial, representing the continuous output of the integrator.
returnValue evaluatePolynomial (ExportStatementBlock &block, const ExportVariable &variable, const ExportVariable &grid, const String &h)
 Exports the evaluation of the coefficients of the polynomial, representing the continuous output of the integrator.
Matrix evaluatePolynomial (uint index)
 Returns the coefficients of the polynomial for the complete grid of the output, corresponding a certain index.
Vector evaluateDerivedPolynomial (double time)
 Returns the coefficients of the derived polynomial, representing the derivative of the continuous output with respect to time.
returnValue evaluateDerivedPolynomial (ExportStatementBlock &block, const ExportVariable &variable, const ExportVariable &grid)
 Exports the evaluation of the coefficients of the derived polynomial, representing the derivative of the continuous output with respect to time.
Matrix evaluateDerivedPolynomial (uint index)
 Returns the coefficients of the derived polynomial for the complete grid of the output, corresponding a certain index.
Vector divideMeasurements (uint index)
 Divide the total number of measurements over the different integration steps.
returnValue evaluateStatesOutputSystem (ExportStatementBlock *block, const ExportVariable &Ah, const ExportIndex &stage)
 Exports the evaluation of the states at a specific stage.
returnValue prepareOutputEvaluation (ExportStatementBlock &code)
 Prepares the structures to evaluate the continuous output and exports the resulting definitions.
returnValue prepareFullRhs ()
 Prepares a function that evaluates the complete right-hand side.
returnValue generateOutput (ExportStatementBlock *block, const ExportIndex &index0, const ExportIndex &index1, const ExportIndex &tmp_index1, const ExportIndex &tmp_index2, const ExportVariable &tmp_meas, const ExportVariable &time_tmp, const uint directions)
 Exports the necessary code for the computation of the continuous output.
virtual returnValue copy (const ImplicitRungeKuttaExport &arg)
 Copies all class members from given object.
virtual returnValue copy (const RungeKuttaExport &arg)
 Copies all class members from given object.
virtual returnValue copy (const IntegratorExport &arg)
 Copies all class members from given object.
returnValue copy (const ExportAlgorithm &arg)
 Copies all class members from given object.
uint getNumIts () const
 Returns the performed number of Newton iterations.
uint getNumItsInit () const
 Returns the performed number of Newton iterations for the initialization of the first step.
Matrix expandOutputMatrix (const Matrix &A3)
 
virtual returnValue clear ()
 Frees internal dynamic memory to yield an empty function.
uint getIntegrationInterval (double time)
 Get the index of the integration interval, corresponding a certain time.

Protected Attributes

BooleanType REUSE
 This boolean is true when the IFTR method is used instead of the IFT method.
BooleanType CONTINUOUS_OUTPUT
 This boolean is true when continuous output needs to be provided.
uint numIts
 This is the performed number of Newton iterations.
uint numItsInit
 This is the performed number of Newton iterations for the initialization of the first step.
uint NDX2
uint NVARS2
uint NVARS3
ExportLinearSolversolver
 This is the exported linear solver that is used by the implicit Runge-Kutta method.
Matrix DD
 This matrix is used for the initialization of the variables for the next integration step.
Matrix coeffs
 This matrix contains coefficients of polynomials that are used to evaluate the continuous output (see evaluatePolynomial).
Vector numDX_output
Vector numXA_output
Vector numVARS_output
ExportVariable rk_rhsOutputTemp
 Variable containing intermediate results of evaluations of the right-hand side expression of an output function.
ExportVariable rk_diffsOutputTemp
 Variable containing intermediate results of evaluations of the derivatives of an output function.
ExportVariable rk_outH
 Variable that is used for the evaluations of the continuous output.
ExportVariable rk_out
 Variable that is used for the evaluations of the continuous output.
ExportVariable polynEvalVar
 Local variable that is used for the evaluations of the continuous output.
ExportVariable stepsH
 Variable defining the different integration step sizes in case of a non equidistant grid.
std::vector< ExportVariablegridVariables
 This vector contains an ExportVariable for the grid of each continuous output.
std::vector< uinttotalMeas
 This vector contains the total number of measurements per output (per shooting or integration interval, depending on grid type).
std::vector< ExportVariablerk_outputs
 Variables containing the evaluations of the continuous output from the integrator.
std::vector< ExportVariablepolynVariables
 Variables containing the coefficients for the polynomial.
std::vector< ExportVariablepolynDerVariables
 Variables containing the coefficients for the derived polynomial.
std::vector< ExportVariablenumMeasVariables
 Variables containing the number of measurements per integration interval.
std::vector< ExportIndexnumMeas
 Indices containing the number of measurements that are already computed.
ExportVariable rk_mat1
ExportVariable rk_dk1
ExportVariable rk_A
 Variable containing the matrix of the linear system.
ExportVariable rk_b
 Variable containing the right-hand side of the linear system.
ExportVariable rk_auxSolver
 Variable containing auxiliary values for the exported linear solver.
ExportVariable rk_rhsTemp
 Variable containing intermediate results of evaluations of the right-hand side expression.
ExportAcadoFunction lin_output
ExportVariable rk_mat3
ExportVariable rk_dk3
ExportVariable rk_diffsTemp3
ExportVariable rk_diffK
ExportVariable debug_mat
ExportVariable rk_kkk
 Variable containing intermediate results of the RK integrator.
Matrix AA
 This matrix defines the Runge-Kutta method to be exported.
Vector bb
Vector cc
 These vectors define the Runge-Kutta method to be exported.
uint numStages
 This is the number of stages for the Runge-Kutta method.
uint NX1
uint NX2
uint NX3
uint NDX3
uint NXA3
uint diffsDim
 This is the total number of sensitivities needed.
uint inputDim
 This is the dimension of the input to the integrator.
BooleanType timeDependant
Matrix M11
Matrix A11
Matrix B11
Matrix A33
Matrix M33
BooleanType exportRhs
 True if the right-hand side and their derivatives should be exported too.
BooleanType crsFormat
 True if the CRS format is used for the jacobian of output functions.
String name_rhs
 The name of the function evaluating the ODE right-hand side, if provided.
String name_diffs_rhs
 The name of the function evaluating the derivatives of the ODE right-hand side, if provided.
String name_rhs3
 The name of the nonlinear function in the linear output system, if provided.
String name_diffs_rhs3
 The name of the function evaluating the derivatives for the linear output system, if provided.
Grid grid
 Evaluation grid along the prediction horizon.
Vector numSteps
 The number of integration steps per shooting interval.
ExportFunction fullRhs
 Function that evaluates the full right-hand side.
ExportVariable rhs_in
ExportVariable rhs_out
ExportFunction integrate
 Function that integrates the exported ODE.
ExportAcadoFunction rhs
 Module to export ODE.
ExportAcadoFunction diffs_rhs
 Module to export the evaluation of the derivatives of the ordinary differential equations.
ExportAcadoFunction lin_input
ExportAcadoFunction rhs3
ExportAcadoFunction diffs_rhs3
ExportVariable error_code
 Variable containing the error code, returned by the integrator.
ExportVariable reset_int
 Variable containing the number of the current integration step.
ExportVariable rk_index
 Variable containing the number of the current shooting interval.
ExportVariable rk_ttt
 Variable containing the integration time.
ExportVariable rk_xxx
 Variable containing the current integrator state.
ExportVariable rk_eta
 Variable containing the inputs or the results of the integrator.
ExportVariable rk_diffsPrev1
ExportVariable rk_diffsNew1
ExportVariable rk_diffsPrev2
 Variable containing the sensitivities from the previous integration step.
ExportVariable rk_diffsNew2
 Variable containing the derivatives wrt the previous values.
ExportVariable rk_diffsTemp2
 Variable containing intermediate results of evaluations of the derivatives of the differential equations (ordinary and algebraic).
ExportVariable rk_diffsNew3
ExportVariable rk_diffsPrev3
DifferentialState x
 The differential states in the model.
DifferentialStateDerivative dx
 The differential state derivatives in the model.
AlgebraicState z
 The algebraic states in the model.
Control u
 The control inputs in the model.
Parameter p
 The parameters in the model.
std::vector< GridoutputGrids
 A separate grid for each output.
std::vector< ExpressionoutputExpressions
 A separate expression for each output.
std::vector< MatrixoutputDependencies
 A separate dependency matrix for each output.
std::vector< ExportAcadoFunctionoutputs
 Module to export output functions.
std::vector< ExportAcadoFunctiondiffs_outputs
 Module to export the evaluation of the derivatives of the output functions.
std::vector< Stringname_outputs
 A separate function name for each output.
std::vector< Stringname_diffs_outputs
 A separate function name for evaluating the derivatives of each output.
std::vector< uintnum_outputs
 A separate dimension for each output.
uint NX
 Number of differential states.
uint NDX
 Number of differential states derivatives.
uint NXA
 Number of algebraic states.
uint NU
 Number of control inputs.
uint NP
 Number of parameters.
uint N
 Number of control intervals.
uint NY
 Number of measurements, k = 0,..., N - 1.
uint NYN
 Number of measurements, k = N.
String commonHeaderName
 Name of common header file.
UserInteractionuserInteraction
 Pointer to top-level user interface.
BooleanType useModuleStandalone
 Flag indicating whether algorithmic module is used stand-alone.
int outputLoggingIdx
 Index of log record for algorithmic standard output to be optionally used within derived classes.

Detailed Description

The class DiagonallyIRK5Export allows to export a tailored diagonally implicit 5-stage Runge-Kutta method of order 5 for fast model predictive control.

Author:
Rien Quirynen

Member Function Documentation

int AlgorithmicBase::addLogRecord ( LogRecord _record) [inline, inherited]
Parameters:
[in]recordRecord to be added.
Returns:
>= 0: index of added record,
-RET_LOG_COLLECTION_CORRUPTED

References Logging::addLogRecord(), and AlgorithmicBase::userInteraction.

Referenced by SCPmethod::setupLogging(), DenseQPsolver::setupLogging(), DynamicDiscretization::setupLogging(), and Integrator::setupLogging().

returnValue AlgorithmicBase::addOption ( OptionsName  name,
int  value 
) [inline, inherited]
Parameters:
[in]nameName of new option item.
[in]valueDefault value of new option.
Returns:
SUCCESSFUL_RETURN,
RET_OPTION_ALREADY_EXISTS,
RET_OPTIONS_LIST_CORRUPTED

References Options::addOption(), and AlgorithmicBase::userInteraction.

Referenced by BandedCPsolver::setupOptions(), NLPsolver::setupOptions(), DynamicDiscretization::setupOptions(), and Integrator::setupOptions().

returnValue AlgorithmicBase::addOption ( OptionsName  name,
double  value 
) [inline, inherited]
Parameters:
[in]nameName of new option item.
[in]valueDefault value of new option.
Returns:
SUCCESSFUL_RETURN,
RET_OPTION_ALREADY_EXISTS,
RET_OPTIONS_LIST_CORRUPTED

References Options::addOption(), and AlgorithmicBase::userInteraction.

returnValue AlgorithmicBase::addOption ( uint  idx,
OptionsName  name,
int  value 
) [inline, inherited]
Parameters:
[in]idxIndex of option list.
[in]nameName of new option item.
[in]valueDefault value of new option.
Returns:
SUCCESSFUL_RETURN,
RET_OPTION_ALREADY_EXISTS,
RET_OPTIONS_LIST_CORRUPTED,
RET_INDEX_OUT_OF_BOUNDS

References Options::addOption(), and AlgorithmicBase::userInteraction.

returnValue AlgorithmicBase::addOption ( uint  idx,
OptionsName  name,
double  value 
) [inline, inherited]
Parameters:
[in]idxIndex of option list.
[in]nameName of new option item.
[in]valueDefault value of new option.
Returns:
SUCCESSFUL_RETURN,
RET_OPTION_ALREADY_EXISTS,
RET_OPTIONS_LIST_CORRUPTED,
RET_INDEX_OUT_OF_BOUNDS

References Options::addOption(), and AlgorithmicBase::userInteraction.

Returns:
SUCCESSFUL_RETURN

References Options::addOptionsList(), and AlgorithmicBase::userInteraction.

Referenced by ShootingMethod::addStage().

returnValue IntegratorExport::clear ( ) [protected, virtual, inherited]
Vector ImplicitRungeKuttaExport::computeCombinations ( const Vector cVec,
uint  index,
uint  numEls 
) [protected, inherited]
Parameters:
[in]cVecThe vector with all the elements of the vector cc from the Butcher table, of which combinations are computed in a recursive way.
[in]indexAn index of the vector cVec which denotes the relevant part for this invocation.
[in]numElsThe number of elements in the combination.
Returns:
SUCCESSFUL_RETURN

References Vector::append(), VectorspaceElement::getDim(), and uint.

Referenced by ImplicitRungeKuttaExport::initializeCoefficients().

returnValue RungeKuttaExport::copy ( const RungeKuttaExport arg) [protected, virtual, inherited]
returnValue ExportAlgorithm::copy ( const ExportAlgorithm arg) [protected, inherited]
returnValue IntegratorExport::copy ( const IntegratorExport arg) [protected, virtual, inherited]
returnValue ImplicitRungeKuttaExport::copy ( const ImplicitRungeKuttaExport arg) [protected, virtual, inherited]
Parameters:
[in]argRight-hand side object.
Returns:
SUCCESSFUL_RETURN

References ImplicitRungeKuttaExport::coeffs, ImplicitRungeKuttaExport::CONTINUOUS_OUTPUT, ImplicitRungeKuttaExport::DD, ImplicitRungeKuttaExport::debug_mat, IntegratorExport::diffs_outputs, IntegratorExport::diffs_rhs, IntegratorExport::diffsDim, IntegratorExport::fullRhs, IntegratorExport::grid, ImplicitRungeKuttaExport::gridVariables, IntegratorExport::inputDim, IntegratorExport::integrate, IntegratorExport::name_diffs_outputs, IntegratorExport::name_diffs_rhs, IntegratorExport::name_outputs, IntegratorExport::name_rhs, IntegratorExport::num_outputs, ImplicitRungeKuttaExport::numIts, ImplicitRungeKuttaExport::numItsInit, RungeKuttaExport::numStages, IntegratorExport::outputGrids, IntegratorExport::outputs, ImplicitRungeKuttaExport::polynEvalVar, ImplicitRungeKuttaExport::REUSE, IntegratorExport::rhs, ImplicitRungeKuttaExport::rk_A, ImplicitRungeKuttaExport::rk_b, ImplicitRungeKuttaExport::rk_diffK, IntegratorExport::rk_diffsNew1, IntegratorExport::rk_diffsNew2, IntegratorExport::rk_diffsNew3, ImplicitRungeKuttaExport::rk_diffsOutputTemp, IntegratorExport::rk_diffsPrev1, IntegratorExport::rk_diffsPrev2, IntegratorExport::rk_diffsPrev3, IntegratorExport::rk_diffsTemp2, ImplicitRungeKuttaExport::rk_diffsTemp3, IntegratorExport::rk_eta, RungeKuttaExport::rk_kkk, ImplicitRungeKuttaExport::rk_out, ImplicitRungeKuttaExport::rk_outH, ImplicitRungeKuttaExport::rk_outputs, ImplicitRungeKuttaExport::rk_rhsOutputTemp, ImplicitRungeKuttaExport::rk_rhsTemp, IntegratorExport::rk_ttt, IntegratorExport::rk_xxx, ImplicitRungeKuttaExport::solver, SUCCESSFUL_RETURN, and ImplicitRungeKuttaExport::totalMeas.

Referenced by AdjointIRKExport::operator=(), ForwardIRKExport::operator=(), and ImplicitRungeKuttaExport::operator=().

Vector ImplicitRungeKuttaExport::divideMeasurements ( uint  index) [protected, inherited]
Parameters:
[in]indexThe index of the continuous output for which the division of measurements is returned.
Returns:
The division of measurements over the integration steps, corresponding the given continuous output.

References IntegratorExport::getIntegrationInterval(), Grid::getNumIntervals(), IntegratorExport::grid, IntegratorExport::outputGrids, uint, and zeros().

Referenced by ImplicitRungeKuttaExport::prepareOutputEvaluation().

BooleanType IntegratorExport::equidistantControlGrid ( ) const [virtual, inherited]
Vector ImplicitRungeKuttaExport::evaluateDerivedPolynomial ( double  time) [protected, inherited]
returnValue ImplicitRungeKuttaExport::evaluateDerivedPolynomial ( ExportStatementBlock block,
const ExportVariable variable,
const ExportVariable grid 
) [protected, inherited]
Parameters:
[in]blockThe block to which the code will be exported.
[in]variableThe variable containing the coefficients of the polynomial.
[in]gridThe variable containing the grid point for the specific output.
Returns:
SUCCESSFUL_RETURN

References ExportStatementBlock::addStatement(), RungeKuttaExport::cc, ExportData::getFullName(), ExportData::getName(), RungeKuttaExport::numStages, SUCCESSFUL_RETURN, and uint.

Parameters:
[in]indexThe index of the continuous output for which the coefficients are returned.
Returns:
Coefficients of the derived polynomial, corresponding the given continuous output

References ImplicitRungeKuttaExport::evaluateDerivedPolynomial(), Grid::getFirstTime(), IntegratorExport::getIntegrationInterval(), Grid::getLastTime(), Grid::getTime(), IntegratorExport::grid, MEASUREMENT_GRID, RungeKuttaExport::numStages, OFFLINE_GRID, IntegratorExport::outputGrids, Matrix::setRow(), ImplicitRungeKuttaExport::totalMeas, and uint.

returnValue DiagonallyImplicitRKExport::evaluateMatrix ( ExportStatementBlock block,
const ExportIndex index1,
const ExportIndex index2,
const ExportIndex tmp_index,
const ExportVariable Ah,
const ExportVariable C,
BooleanType  evaluateB,
BooleanType  DERIVATIVES 
) [virtual, inherited]
Parameters:
[in]blockThe block to which the code will be exported.
[in]index1The loop index of the outer loop.
[in]index2The loop index of the inner loop.
[in]tmp_indexA temporary index to be used.
[in]AhThe matrix A of the IRK method, multiplied by the step size h.
[in]evaluateBTrue if the right-hand side of the linear system should also be evaluated, false otherwise.
Returns:
SUCCESSFUL_RETURN

Reimplemented from ImplicitRungeKuttaExport.

References ExportStatementBlock::addFunctionCall(), ExportStatementBlock::addStatement(), DiagonallyImplicitRKExport::evaluateRhsImplicitSystem(), DiagonallyImplicitRKExport::evaluateStatesImplicitSystem(), ExportArgument::getAddress(), IntegratorExport::getNameDiffsRHS(), ExportVariable::getSubMatrix(), ImplicitRungeKuttaExport::NDX2, ImplicitRungeKuttaExport::NVARS2, IntegratorExport::NX1, IntegratorExport::NX2, ExportAlgorithm::NXA, ImplicitRungeKuttaExport::rk_A, IntegratorExport::rk_diffsTemp2, IntegratorExport::rk_xxx, SUCCESSFUL_RETURN, and zeros().

Referenced by DiagonallyImplicitRKExport::solveImplicitSystem().

Vector ImplicitRungeKuttaExport::evaluatePolynomial ( double  time) [protected, inherited]
Parameters:
[in]timeThe point in the interval (0,1] for which the coefficients are returned.
Returns:
Coefficients of the polynomial, corresponding the given grid point

References ImplicitRungeKuttaExport::coeffs, RungeKuttaExport::numStages, pow(), and uint.

Referenced by ImplicitRungeKuttaExport::evaluatePolynomial(), ImplicitRungeKuttaExport::generateOutput(), ImplicitRungeKuttaExport::prepareOutputEvaluation(), ForwardIRKExport::sensitivitiesOutputs(), and AdjointIRKExport::sensitivitiesOutputs().

returnValue ImplicitRungeKuttaExport::evaluatePolynomial ( ExportStatementBlock block,
const ExportVariable variable,
const ExportVariable grid,
const String h 
) [protected, inherited]
Parameters:
[in]blockThe block to which the code will be exported.
[in]variableThe variable containing the coefficients of the polynomial.
[in]gridThe variable containing the grid point for the specific output.
[in]hThe integration step size.
Returns:
SUCCESSFUL_RETURN

References ExportStatementBlock::addStatement(), ImplicitRungeKuttaExport::coeffs, ExportData::getFullName(), ExportVariable::getRow(), RungeKuttaExport::numStages, ImplicitRungeKuttaExport::polynEvalVar, SUCCESSFUL_RETURN, and uint.

Matrix ImplicitRungeKuttaExport::evaluatePolynomial ( uint  index) [protected, inherited]
Parameters:
[in]indexThe index of the continuous output for which the coefficients are returned.
Returns:
Coefficients of the polynomial, corresponding the given continuous output

References ImplicitRungeKuttaExport::evaluatePolynomial(), Grid::getFirstTime(), IntegratorExport::getIntegrationInterval(), Grid::getLastTime(), Grid::getTime(), IntegratorExport::grid, MEASUREMENT_GRID, RungeKuttaExport::numStages, OFFLINE_GRID, IntegratorExport::outputGrids, Matrix::setRow(), ImplicitRungeKuttaExport::totalMeas, and uint.

returnValue DiagonallyImplicitRKExport::evaluateStatesImplicitSystem ( ExportStatementBlock block,
const ExportVariable Ah,
const ExportVariable C,
const ExportIndex stage,
const ExportIndex i,
const ExportIndex j 
) [virtual, inherited]
returnValue ImplicitRungeKuttaExport::evaluateStatesOutputSystem ( ExportStatementBlock block,
const ExportVariable Ah,
const ExportIndex stage 
) [protected, inherited]
Matrix IntegratorExport::expandOutputMatrix ( const Matrix A3) [protected, inherited]
Parameters:
[in]A3.
Returns:
SUCCESSFUL_RETURN

References ExportAlgorithm::NX, IntegratorExport::NX3, uint, and zeros().

Referenced by IntegratorExport::setLinearOutput(), and NARXExport::setLinearOutput().

Matrix DiagonallyImplicitRKExport::formMatrix ( const Matrix mass,
const Matrix jacobian 
) [virtual, inherited]
returnValue ImplicitRungeKuttaExport::generateOutput ( ExportStatementBlock block,
const ExportIndex index0,
const ExportIndex index1,
const ExportIndex tmp_index1,
const ExportIndex tmp_index2,
const ExportVariable tmp_meas,
const ExportVariable time_tmp,
const uint  directions 
) [protected, inherited]
Parameters:
[in]blockThe block to which the code will be exported.
[in]tmp_measThe number of measurements in the current integration step (in case of an online grid).
[in]rk_tPrevThe time point, defining the beginning of the current integration step (in case of an online grid).
[in]time_tmpA variable used for time transformations (in case of an online grid).
Returns:
SUCCESSFUL_RETURN

References acadoRoundAway(), ExportStatementBlock::addFunctionCall(), ExportStatementBlock::addStatement(), IntegratorExport::crsFormat, IntegratorExport::diffsDim, ImplicitRungeKuttaExport::evaluateDerivedPolynomial(), ImplicitRungeKuttaExport::evaluatePolynomial(), IntegratorExport::exportRhs, ExportVariable::get(), ExportArgument::getAddress(), ExportVariable::getCol(), IntegratorExport::getDimOUTPUT(), Grid::getFirstTime(), Grid::getLastTime(), ExportData::getName(), IntegratorExport::getNameOUTPUT(), Grid::getNumIntervals(), ExportVariable::getRow(), IntegratorExport::grid, ImplicitRungeKuttaExport::gridVariables, IntegratorExport::inputDim, MEASUREMENT_GRID, ExportAlgorithm::NDX, ExportAlgorithm::NU, ImplicitRungeKuttaExport::numDX_output, ImplicitRungeKuttaExport::numMeas, ImplicitRungeKuttaExport::numMeasVariables, RungeKuttaExport::numStages, ImplicitRungeKuttaExport::numXA_output, ExportAlgorithm::NX, ExportAlgorithm::NXA, OFFLINE_GRID, IntegratorExport::outputDependencies, ImplicitRungeKuttaExport::polynDerVariables, ImplicitRungeKuttaExport::polynVariables, IntegratorExport::rk_eta, RungeKuttaExport::rk_kkk, ImplicitRungeKuttaExport::rk_out, ImplicitRungeKuttaExport::rk_outH, ImplicitRungeKuttaExport::rk_outputs, ImplicitRungeKuttaExport::rk_rhsOutputTemp, IntegratorExport::rk_xxx, SUCCESSFUL_RETURN, sumRow(), and uint.

Referenced by AdjointIRKExport::getCode(), ForwardIRKExport::getCode(), and ImplicitRungeKuttaExport::getCode().

returnValue AlgorithmicBase::get ( OptionsName  name,
int &  value 
) const [inline, inherited]
Parameters:
[in]nameName of option item.
[out]valueValue of option.
Returns:
SUCCESSFUL_RETURN,
RET_OPTION_DOESNT_EXISTS

References Options::get(), and AlgorithmicBase::userInteraction.

returnValue AlgorithmicBase::get ( OptionsName  name,
double &  value 
) const [inline, inherited]
Parameters:
[in]nameName of option item.
[out]valueValue of option.
Returns:
SUCCESSFUL_RETURN,
RET_OPTION_DOESNT_EXISTS

References Options::get(), and AlgorithmicBase::userInteraction.

returnValue AlgorithmicBase::get ( uint  idx,
OptionsName  name,
int &  value 
) const [inline, inherited]
Parameters:
[in]idxIndex of option list.
[in]nameName of option item.
[out]valueValue of option.
Returns:
SUCCESSFUL_RETURN,
RET_OPTION_DOESNT_EXISTS,
RET_INDEX_OUT_OF_BOUNDS

References Options::get(), and AlgorithmicBase::userInteraction.

returnValue AlgorithmicBase::get ( uint  idx,
OptionsName  name,
double &  value 
) const [inline, inherited]
Parameters:
[in]idxIndex of option list.
[in]nameName of option item.
[out]valueValue of option.
Returns:
SUCCESSFUL_RETURN,
RET_OPTION_DOESNT_EXISTS,
RET_INDEX_OUT_OF_BOUNDS

References Options::get(), and AlgorithmicBase::userInteraction.

BEGIN_NAMESPACE_ACADO returnValue AlgorithmicBase::getAll ( LogName  _name,
MatrixVariablesGrid values 
) const [inline, inherited]

If this item exists in more than one record, the first one is choosen as they are expected to have identical values anyhow.

Parameters:
[in]_nameInternal name of item.
[out]valuesAll numerical values at all time instants of given item.
Returns:
SUCCESSFUL_RETURN,
RET_LOG_ENTRY_DOESNT_EXIST

References Logging::getAll(), and AlgorithmicBase::userInteraction.

ExportVariable ForwardIRKExport::getAuxVariable ( ) const [protected, virtual, inherited]
Parameters:
[in]codeCode block containing the auto-generated integrator.
Returns:
SUCCESSFUL_RETURN

Reimplemented from ImplicitRungeKuttaExport.

References RungeKuttaExport::AA, ACADO_LOCAL, ACADOERROR, ExportStatementBlock::addComment(), ExportStatementBlock::addDeclaration(), ExportStatementBlock::addFunction(), ExportFunction::addIndex(), ExportStatementBlock::addLinebreak(), ExportStatementBlock::addStatement(), ExportLinearSolver::appendVariableNames(), RungeKuttaExport::bb, BT_FALSE, BT_TRUE, RungeKuttaExport::cc, CG_USE_OPENMP, ImplicitRungeKuttaExport::CONTINUOUS_OUTPUT, IntegratorExport::diffs_outputs, IntegratorExport::diffs_rhs, IntegratorExport::diffs_rhs3, IntegratorExport::diffsDim, DYNAMIC_SENSITIVITY, IntegratorExport::equidistantControlGrid(), IntegratorExport::error_code, ImplicitRungeKuttaExport::evaluateDerivedPolynomial(), IntegratorExport::exportRhs, FORWARD, IntegratorExport::fullRhs, ImplicitRungeKuttaExport::generateOutput(), ExportVariable::get(), ForwardIRKExport::getAuxVariable(), ExportLinearSolver::getCode(), ExportVariable::getCol(), ExportVariable::getCols(), ForwardIRKExport::getDataDeclarations(), Grid::getFirstTime(), ExportData::getFullName(), Grid::getLastTime(), ExportData::getName(), String::getName(), Grid::getNumIntervals(), ExportVariable::getRow(), ExportVariable::getSubMatrix(), IntegratorExport::grid, ImplicitRungeKuttaExport::gridVariables, ImplicitRungeKuttaExport::initializeCoefficients(), ImplicitRungeKuttaExport::initializeDDMatrix(), IntegratorExport::inputDim, INT, IntegratorExport::integrate, IntegratorExport::lin_input, max(), MEASUREMENT_GRID, ExportAlgorithm::NU, ImplicitRungeKuttaExport::numMeas, ImplicitRungeKuttaExport::numMeasVariables, RungeKuttaExport::numStages, IntegratorExport::numSteps, ExportAlgorithm::NX, IntegratorExport::NX1, IntegratorExport::NX2, IntegratorExport::NX3, ExportAlgorithm::NXA, OFFLINE_GRID, ONLINE_GRID, IntegratorExport::outputGrids, IntegratorExport::outputs, ImplicitRungeKuttaExport::polynEvalVar, ImplicitRungeKuttaExport::prepareFullRhs(), ForwardIRKExport::prepareInputSystem(), ImplicitRungeKuttaExport::prepareOutputEvaluation(), ForwardIRKExport::prepareOutputSystem(), IntegratorExport::propagateImplicitSystem(), IntegratorExport::propagateInputSystem(), ForwardIRKExport::propagateOutputs(), IntegratorExport::propagateOutputSystem(), REAL, IntegratorExport::reset_int, RET_INVALID_OPTION, IntegratorExport::rhs, IntegratorExport::rhs3, ImplicitRungeKuttaExport::rk_A, ImplicitRungeKuttaExport::rk_auxSolver, ImplicitRungeKuttaExport::rk_b, ImplicitRungeKuttaExport::rk_diffK, IntegratorExport::rk_diffsNew1, IntegratorExport::rk_diffsNew2, IntegratorExport::rk_diffsNew3, IntegratorExport::rk_diffsPrev1, IntegratorExport::rk_diffsPrev2, IntegratorExport::rk_diffsPrev3, IntegratorExport::rk_diffsTemp2, ImplicitRungeKuttaExport::rk_diffsTemp3, IntegratorExport::rk_eta, IntegratorExport::rk_index, RungeKuttaExport::rk_kkk, ImplicitRungeKuttaExport::rk_outputs, ImplicitRungeKuttaExport::rk_rhsTemp, IntegratorExport::rk_ttt, IntegratorExport::rk_xxx, ForwardIRKExport::sensitivitiesImplicitSystem(), ForwardIRKExport::sensitivitiesInputSystem(), ForwardIRKExport::sensitivitiesOutputs(), ForwardIRKExport::sensitivitiesOutputSystem(), ExportData::setDataStruct(), ExportAcadoFunction::setGlobalExportVariable(), ExportData::setName(), ImplicitRungeKuttaExport::solveImplicitSystem(), ImplicitRungeKuttaExport::solveInputSystem(), ImplicitRungeKuttaExport::solveOutputSystem(), ImplicitRungeKuttaExport::solver, STATIC_CONST_INT, STATIC_CONST_REAL, SUCCESSFUL_RETURN, IntegratorExport::timeDependant, ImplicitRungeKuttaExport::totalMeas, uint, IntegratorExport::updateImplicitSystem(), IntegratorExport::updateInputSystem(), IntegratorExport::updateOutputSystem(), and zeros().

returnValue ForwardIRKExport::getCRSIndex ( uint  output,
ExportIndex  row,
ExportIndex  col 
) [protected, inherited]
Parameters:
[in]outputThe number of the output function.
[in]rowThe number of the row, corresponding the element of interest.
[in]colThe number of the column, corresponding the element of interest.
Returns:
The CRS index.

Reimplemented from ImplicitRungeKuttaExport.

returnValue ForwardIRKExport::getDataDeclarations ( ExportStatementBlock declarations,
ExportStruct  dataStruct = ACADO_ANY 
) const [virtual, inherited]
uint IntegratorExport::getDimOUTPUT ( uint  index) const [inherited]
returnValue AlgorithmicBase::getFirst ( LogName  _name,
Matrix firstValue 
) const [inline, inherited]

If this item exists in more than one record, the first one is choosen as they are expected to have identical values anyhow.

Parameters:
[in]_nameInternal name of item.
[out]firstValueNumerical value at first time instant of given item.
Returns:
SUCCESSFUL_RETURN,
RET_LOG_ENTRY_DOESNT_EXIST

References Logging::getFirst(), and AlgorithmicBase::userInteraction.

returnValue AlgorithmicBase::getFirst ( LogName  _name,
VariablesGrid firstValue 
) const [inline, inherited]

If this item exists in more than one record, the first one is choosen as they are expected to have identical values anyhow.

Parameters:
[in]_nameInternal name of item.
[out]firstValueNumerical value at first time instant of given item.
Returns:
SUCCESSFUL_RETURN,
RET_LOG_ENTRY_DOESNT_EXIST

References Logging::getFirst(), and AlgorithmicBase::userInteraction.

returnValue ForwardIRKExport::getFunctionDeclarations ( ExportStatementBlock declarations) const [virtual, inherited]
returnValue IntegratorExport::getGrid ( Grid grid_) const [virtual, inherited]


Returns:
SUCCESSFUL_RETURN

References IntegratorExport::grid, and SUCCESSFUL_RETURN.

uint IntegratorExport::getIntegrationInterval ( double  time) [protected, inherited]
returnValue AlgorithmicBase::getLast ( LogName  _name,
Matrix lastValue 
) const [inline, inherited]

If this item exists in more than one record, the first one is choosen as they are expected to have identical values anyhow.

Parameters:
[in]_nameInternal name of item.
[out]lastValueNumerical value at last time instant of given item.
Returns:
SUCCESSFUL_RETURN,
RET_LOG_ENTRY_DOESNT_EXIST

References Logging::getLast(), and AlgorithmicBase::userInteraction.

Referenced by Process::simulate().

returnValue AlgorithmicBase::getLast ( LogName  _name,
VariablesGrid lastValue 
) const [inline, inherited]

If this item exists in more than one record, the first one is choosen as they are expected to have identical values anyhow.

Parameters:
[in]_nameInternal name of item.
[out]lastValueNumerical value at last time instant of given item.
Returns:
SUCCESSFUL_RETURN,
RET_LOG_ENTRY_DOESNT_EXIST

References Logging::getLast(), and AlgorithmicBase::userInteraction.

uint ExportAlgorithm::getN ( ) const [inherited]
Returns:
Number of control intervals

References ExportAlgorithm::N.

Referenced by ExportNLPSolver::setupResidualVariables(), and ExportNLPSolver::setupSimulation().

const String IntegratorExport::getNameDiffsOUTPUT ( uint  index) const [inherited]
const String IntegratorExport::getNameDiffsRHS ( ) const [inherited]
const String IntegratorExport::getNameFullRHS ( ) const [virtual, inherited]
const String IntegratorExport::getNameOUTPUT ( uint  index) const [inherited]
const String IntegratorExport::getNameOutputDiffs ( ) const [inherited]
const String IntegratorExport::getNameOutputRHS ( ) const [inherited]
const String IntegratorExport::getNameRHS ( ) const [inherited]
uint ExportAlgorithm::getNDX ( ) const [inherited]
Returns:
The requested number of differential state derivatives
uint ExportAlgorithm::getNP ( ) const [inherited]
Returns:
Number of parameters

References ExportAlgorithm::NP.

Referenced by ExportNLPSolver::setupSimulation().

uint ExportAlgorithm::getNU ( ) const [inherited]
uint ImplicitRungeKuttaExport::getNumIts ( ) const [protected, inherited]
Returns:
The performed number of Newton iterations.

References ImplicitRungeKuttaExport::numIts.

uint ImplicitRungeKuttaExport::getNumItsInit ( ) const [protected, inherited]
Returns:
The performed number of Newton iterations for the initialization of the first step.

References ImplicitRungeKuttaExport::numItsInit.

returnValue IntegratorExport::getNumSteps ( Vector _numSteps) const [virtual, inherited]


Returns:
SUCCESSFUL_RETURN

References IntegratorExport::numSteps, and SUCCESSFUL_RETURN.

uint ExportAlgorithm::getNX ( ) const [inherited]
uint ExportAlgorithm::getNXA ( ) const [inherited]
Returns:
Number of algebraic states

References ExportAlgorithm::NXA.

Referenced by ExportNLPSolver::setupSimulation().

uint ExportAlgorithm::getNY ( ) const [inherited]
uint ExportAlgorithm::getNYN ( ) const [inherited]
Options AlgorithmicBase::getOptions ( uint  idx) const [inherited]
Parameters:
[in]idxIndex of option list.
Returns:
Options object containing exactly the option list with given index

References Options::getOptions(), and AlgorithmicBase::userInteraction.

Referenced by ShootingMethod::evaluate().

returnValue IntegratorExport::getOutputExpressions ( std::vector< Expression > &  outputExpressions_) const [virtual, inherited]


Returns:
SUCCESSFUL_RETURN

References IntegratorExport::outputExpressions, and SUCCESSFUL_RETURN.

returnValue IntegratorExport::getOutputGrids ( std::vector< Grid > &  outputGrids_) const [virtual, inherited]


Returns:
SUCCESSFUL_RETURN

References IntegratorExport::outputGrids, and SUCCESSFUL_RETURN.

BooleanType AlgorithmicBase::haveOptionsChanged ( ) const [inline, inherited]
Returns:
BT_TRUE iff options have been modified,
BT_FALSE otherwise

References Options::haveOptionsChanged(), and AlgorithmicBase::userInteraction.

BooleanType AlgorithmicBase::haveOptionsChanged ( uint  idx) const [inline, inherited]
Parameters:
[in]idxIndex of option list.
Returns:
BT_TRUE iff options have been modified,
BT_FALSE otherwise

References Options::haveOptionsChanged(), and AlgorithmicBase::userInteraction.

returnValue RungeKuttaExport::initializeButcherTableau ( const Matrix _AA,
const Vector _bb,
const Vector _cc 
) [inherited]
FILE * ExportAlgorithm::openFile ( const String dirName,
const String fileName 
) const [inherited]
Parameters:
[in]dirNameName of directory in which to open the file.
[in]fileNameName of file to be opened.
[in]includeCommonHeaderFlag indicating whether common header shall be included.
Returns:
Pointer to prepared file with given name,
NULL iff file could not be opened

References acadoFOpen(), acadoFPrintf(), acadoPrintAutoGenerationNotice(), BT_FALSE, ExportAlgorithm::commonHeaderName, String::getName(), and String::isEmpty().

returnValue AlgorithmicBase::plot ( PlotFrequency  _frequency = PLOT_IN_ANY_CASE) [inline, inherited]
Parameters:
[in]_frequencyFrequency determining at which time instants the window is to be plotted.
Returns:
SUCCESSFUL_RETURN

References Plotting::plot(), and AlgorithmicBase::userInteraction.

returnValue ImplicitRungeKuttaExport::prepareFullRhs ( ) [protected, virtual, inherited]
returnValue AlgorithmicBase::printLogRecord ( int  idx,
LogPrintMode  _mode = PRINT_ITEM_BY_ITEM 
) const [inline, inherited]
Parameters:
[in]idxIndex of record to be printed.
[in]_modePrint mode: see documentation of LogPrintMode of details.
Returns:
SUCCESSFUL_RETURN,
RET_INDEX_OUT_OF_BOUNDS,
RET_INVALID_ARGUMENTS,
RET_UNKNOWN_BUG

References ACADOERROR, LogCollection::getNumLogRecords(), Logging::logCollection, LogCollection::print(), RET_INDEX_OUT_OF_BOUNDS, and AlgorithmicBase::userInteraction.

Referenced by SCPmethod::printIteration(), SCPmethod::printRuntimeProfile(), and Integrator::printRunTimeProfile().

returnValue IntegratorExport::propagateImplicitSystem ( ExportStatementBlock block,
const ExportIndex index1,
const ExportIndex index2,
const ExportIndex index3,
const ExportIndex tmp_index 
) [virtual, inherited]
returnValue IntegratorExport::propagateInputSystem ( ExportStatementBlock block,
const ExportIndex index1,
const ExportIndex index2,
const ExportIndex index3,
const ExportIndex tmp_index 
) [virtual, inherited]
returnValue ForwardIRKExport::propagateOutputs ( ExportStatementBlock block,
const ExportIndex index,
const ExportIndex index0,
const ExportIndex index1,
const ExportIndex index2,
const ExportIndex index3,
const ExportIndex tmp_index1,
const ExportIndex tmp_index2,
const ExportIndex tmp_index3,
const ExportIndex tmp_index4,
const ExportVariable tmp_meas 
) [protected, virtual, inherited]
returnValue IntegratorExport::propagateOutputSystem ( ExportStatementBlock block,
const ExportIndex index1,
const ExportIndex index2,
const ExportIndex index3,
const ExportIndex tmp_index 
) [virtual, inherited]
returnValue AlgorithmicBase::replot ( PlotFrequency  _frequency = PLOT_IN_ANY_CASE) [inline, inherited]
Parameters:
[in]_frequencyFrequency determining at which time instants the window is to be plotted.
Returns:
SUCCESSFUL_RETURN

References Plotting::replot(), and AlgorithmicBase::userInteraction.

Referenced by SCPmethod::printIteration(), SCPmethod::solve(), and SCPmethod::step().

returnValue DiagonallyImplicitRKExport::sensitivitiesImplicitSystem ( ExportStatementBlock block,
const ExportIndex index1,
const ExportIndex index2,
const ExportIndex index3,
const ExportIndex tmp_index1,
const ExportIndex tmp_index2,
const ExportVariable Ah,
const ExportVariable Bh,
const ExportVariable det,
BooleanType  STATES,
uint  number 
) [virtual, inherited]
Parameters:
[in]blockThe block to which the code will be exported.
[in]AhThe variable containing the internal coefficients of the RK method, multiplied with the step size.
[in]BhThe variable containing the weights of the RK method, multiplied with the step size.
[in]detThe variable that holds the determinant of the matrix in the linear system.
[in]STATESTrue if the sensitivities with respect to a state are needed, false otherwise.
[in]numberThis number defines the stage of the state with respect to which the sensitivities are computed.
Returns:
SUCCESSFUL_RETURN

Reimplemented from ForwardIRKExport.

References ExportStatementBlock::addFunctionCall(), ExportStatementBlock::addStatement(), BT_FALSE, ImplicitRungeKuttaExport::evaluateDerivedPolynomial(), ExportVariable::get(), ExportArgument::getAddress(), ExportData::getFullName(), ExportData::getName(), ExportLinearSolver::getNameSolveFunction(), ExportLinearSolver::getNameSolveReuseFunction(), Matrix::getRow(), ExportVariable::getRow(), ExportVariable::getRows(), ExportVariable::getSubMatrix(), ImplicitRungeKuttaExport::NDX2, RungeKuttaExport::numStages, ImplicitRungeKuttaExport::NVARS2, ExportAlgorithm::NX, IntegratorExport::NX1, IntegratorExport::NX2, ExportAlgorithm::NXA, ImplicitRungeKuttaExport::rk_A, ImplicitRungeKuttaExport::rk_auxSolver, ImplicitRungeKuttaExport::rk_b, ImplicitRungeKuttaExport::rk_diffK, IntegratorExport::rk_diffsNew2, IntegratorExport::rk_diffsTemp2, ImplicitRungeKuttaExport::rk_rhsTemp, ImplicitRungeKuttaExport::solver, SUCCESSFUL_RETURN, uint, and zeros().

returnValue ForwardIRKExport::sensitivitiesInputSystem ( ExportStatementBlock block,
const ExportIndex index1,
const ExportIndex index2,
const ExportVariable Bh,
BooleanType  STATES 
) [protected, virtual, inherited]
Parameters:
[in]blockThe block to which the code will be exported.
[in]BhThe variable containing the weights of the RK method, multiplied with the step size.
[in]STATESTrue if the sensitivities with respect to a state are needed, false otherwise.
Returns:
SUCCESSFUL_RETURN

Implements RKSensitivitiesExport.

References ExportStatementBlock::addStatement(), IntegratorExport::equidistantControlGrid(), ExportVariable::get(), ExportData::getName(), Grid::getNumIntervals(), ExportVariable::getRow(), ExportVariable::getRows(), ExportVariable::getSubMatrix(), IntegratorExport::grid, IntegratorExport::NX1, ImplicitRungeKuttaExport::rk_diffK, IntegratorExport::rk_diffsNew1, ImplicitRungeKuttaExport::rk_dk1, and SUCCESSFUL_RETURN.

Referenced by ForwardIRKExport::getCode().

returnValue ForwardIRKExport::sensitivitiesOutputs ( ExportStatementBlock block,
const ExportIndex index0,
const ExportIndex index1,
const ExportIndex index2,
const ExportIndex tmp_index1,
const ExportIndex tmp_index2,
const ExportIndex tmp_index3,
const ExportVariable tmp_meas,
const ExportVariable time_tmp,
BooleanType  STATES,
uint  base 
) [protected, virtual, inherited]
Parameters:
[in]blockThe block to which the code will be exported.
[in]tmp_measThe number of measurements in the current integration step (in case of an online grid).
[in]rk_tPrevThe time point, defining the beginning of the current integration step (in case of an online grid).
[in]time_tmpA variable used for time transformations (in case of an online grid).
[in]STATESTrue if the sensitivities with respect to a state are needed, false otherwise.
[in]baseThe number of states in stages with respect to which the sensitivities have already been computed.
Returns:
SUCCESSFUL_RETURN

Implements RKSensitivitiesExport.

References acadoRoundAway(), ExportStatementBlock::addFunctionCall(), ExportStatementBlock::addStatement(), IntegratorExport::crsFormat, IntegratorExport::diffsDim, ImplicitRungeKuttaExport::evaluateDerivedPolynomial(), ImplicitRungeKuttaExport::evaluatePolynomial(), IntegratorExport::exportRhs, ExportVariable::get(), ExportArgument::getAddress(), ExportVariable::getCol(), IntegratorExport::getDimOUTPUT(), Grid::getFirstTime(), Grid::getLastTime(), ExportData::getName(), IntegratorExport::getNameDiffsOUTPUT(), Grid::getNumIntervals(), ExportVariable::getRow(), ExportVariable::getRows(), IntegratorExport::grid, ImplicitRungeKuttaExport::gridVariables, IntegratorExport::inputDim, MEASUREMENT_GRID, ExportAlgorithm::NDX, ExportAlgorithm::NU, ImplicitRungeKuttaExport::numDX_output, ImplicitRungeKuttaExport::numMeas, ImplicitRungeKuttaExport::numMeasVariables, RungeKuttaExport::numStages, ImplicitRungeKuttaExport::numVARS_output, ImplicitRungeKuttaExport::numXA_output, ExportAlgorithm::NX, IntegratorExport::NX1, IntegratorExport::NX2, ExportAlgorithm::NXA, OFFLINE_GRID, IntegratorExport::outputDependencies, ImplicitRungeKuttaExport::polynDerVariables, ImplicitRungeKuttaExport::polynVariables, ImplicitRungeKuttaExport::rk_diffK, ImplicitRungeKuttaExport::rk_diffsOutputTemp, IntegratorExport::rk_eta, RungeKuttaExport::rk_kkk, ImplicitRungeKuttaExport::rk_out, ImplicitRungeKuttaExport::rk_outH, ImplicitRungeKuttaExport::rk_outputs, ImplicitRungeKuttaExport::rk_rhsTemp, IntegratorExport::rk_xxx, SUCCESSFUL_RETURN, sumRow(), and uint.

Referenced by ForwardIRKExport::getCode().

returnValue DiagonallyImplicitRKExport::sensitivitiesOutputSystem ( ExportStatementBlock block,
const ExportIndex index1,
const ExportIndex index2,
const ExportIndex index3,
const ExportIndex index4,
const ExportIndex tmp_index1,
const ExportIndex tmp_index2,
const ExportVariable Ah,
const ExportVariable Bh,
BooleanType  STATES,
uint  number 
) [virtual, inherited]
Parameters:
[in]blockThe block to which the code will be exported.
[in]AhThe variable containing the internal coefficients of the RK method, multiplied with the step size.
[in]BhThe variable containing the weights of the RK method, multiplied with the step size.
[in]STATESTrue if the sensitivities with respect to a state are needed, false otherwise.
[in]numberThis number defines the stage of the state with respect to which the sensitivities are computed.
Returns:
SUCCESSFUL_RETURN

Reimplemented from ForwardIRKExport.

References IntegratorExport::A33, acadoRoundAway(), ExportStatementBlock::addStatement(), IntegratorExport::equidistantControlGrid(), ExportVariable::get(), ExportData::getName(), Grid::getNumIntervals(), ExportVariable::getRow(), ExportVariable::getRows(), ExportVariable::getSubMatrix(), IntegratorExport::grid, IntegratorExport::NDX3, RungeKuttaExport::numStages, ImplicitRungeKuttaExport::NVARS3, ExportAlgorithm::NX, IntegratorExport::NX1, IntegratorExport::NX2, IntegratorExport::NX3, ExportAlgorithm::NXA, IntegratorExport::NXA3, ImplicitRungeKuttaExport::rk_b, ImplicitRungeKuttaExport::rk_diffK, IntegratorExport::rk_diffsNew3, ImplicitRungeKuttaExport::rk_diffsTemp3, ImplicitRungeKuttaExport::rk_dk3, ImplicitRungeKuttaExport::rk_mat3, ImplicitRungeKuttaExport::rk_rhsTemp, SUCCESSFUL_RETURN, and uint.

returnValue AlgorithmicBase::set ( OptionsName  name,
int  value 
) [inherited]
Parameters:
[in]nameName of option item.
[in]valueNew value of option.
Returns:
SUCCESSFUL_RETURN,
RET_OPTION_DOESNT_EXISTS,
RET_OPTIONS_LIST_CORRUPTED

References Options::set(), and AlgorithmicBase::userInteraction.

Referenced by SCPmethod::initializeHessianProjection().

returnValue AlgorithmicBase::set ( OptionsName  name,
double  value 
) [inherited]
Parameters:
[in]nameName of option item.
[in]valueNew value of option.
Returns:
SUCCESSFUL_RETURN,
RET_OPTION_DOESNT_EXISTS,
RET_OPTIONS_LIST_CORRUPTED

References Options::set(), and AlgorithmicBase::userInteraction.

returnValue AlgorithmicBase::set ( uint  idx,
OptionsName  name,
int  value 
) [inherited]
Parameters:
[in]idxIndex of option list.
[in]nameName of option item.
[in]valueNew value of option.
Returns:
SUCCESSFUL_RETURN,
RET_OPTION_DOESNT_EXISTS,
RET_OPTIONS_LIST_CORRUPTED,
RET_INDEX_OUT_OF_BOUNDS

References Options::set(), and AlgorithmicBase::userInteraction.

returnValue AlgorithmicBase::set ( uint  idx,
OptionsName  name,
double  value 
) [inherited]
Parameters:
[in]idxIndex of option list.
[in]nameName of option item.
[in]valueNew value of option.
Returns:
SUCCESSFUL_RETURN,
RET_OPTION_DOESNT_EXISTS,
RET_OPTIONS_LIST_CORRUPTED,
RET_INDEX_OUT_OF_BOUNDS

References Options::set(), and AlgorithmicBase::userInteraction.

returnValue AlgorithmicBase::setAll ( LogName  _name,
const MatrixVariablesGrid values 
) [inline, inherited]
Parameters:
[in]_nameInternal name of item.
[in]valuesAll numerical values at all time instants of given item.
Returns:
SUCCESSFUL_RETURN,
RET_LOG_COLLECTION_CORRUPTED

References Logging::logCollection, LogCollection::setAll(), and AlgorithmicBase::userInteraction.

returnValue ExportAlgorithm::setDimensions ( uint  _NX = 0,
uint  _NU = 0,
uint  _NP = 0,
uint  _NI = 0 
) [inherited]
Parameters:
[in]_NXNew number of differential states.
[in]_NUNew number of control inputs.
[in]_NPNew number of parameters.
[in]_NINew number of control intervals. (using _N resulted in a strange error when compiling with cygwin!)
Returns:
SUCCESSFUL_RETURN

Referenced by ExportAlgorithm::ExportAlgorithm(), and IntegratorExport::setModelData().

returnValue ExportAlgorithm::setDimensions ( uint  _NX,
uint  _NDX,
uint  _NXA,
uint  _NU,
uint  _NP,
uint  _NI 
) [inherited]
Parameters:
[in]_NXNew number of differential states.
[in]_NDXNew number of differential states derivatives.
[in]_NXANew number of algebraic states.
[in]_NUNew number of control inputs.
[in]_NPNew number of parameters.
[in]_NINew number of control intervals. (using _N resulted in a strange error when compiling with cygwin!)
Returns:
SUCCESSFUL_RETURN

References ExportAlgorithm::N, ExportAlgorithm::NDX, ExportAlgorithm::NP, ExportAlgorithm::NU, ExportAlgorithm::NX, ExportAlgorithm::NXA, and SUCCESSFUL_RETURN.

returnValue IntegratorExport::setGrid ( const Grid _grid) [virtual, inherited]
Parameters:
[in]_gridintegration grid
Returns:
SUCCESSFUL_RETURN

References IntegratorExport::grid, and SUCCESSFUL_RETURN.

returnValue AlgorithmicBase::setLast ( LogName  _name,
int  lastValue,
double  time = -INFTY 
) [inline, inherited]
returnValue AlgorithmicBase::setLast ( LogName  _name,
double  lastValue,
double  time = -INFTY 
) [inline, inherited]
Parameters:
[in]_nameInternal name of item.
[in]lastValueNumerical value at last time instant of given item.
[in]timeTime label of the instant.
Returns:
SUCCESSFUL_RETURN,
RET_LOG_ENTRY_DOESNT_EXIST

References Logging::logCollection, LogCollection::setLast(), and AlgorithmicBase::userInteraction.

returnValue AlgorithmicBase::setLast ( LogName  _name,
const Vector lastValue,
double  time = -INFTY 
) [inline, inherited]
Parameters:
[in]_nameInternal name of item.
[in]lastValueNumerical value at last time instant of given item.
[in]timeTime label of the instant.
Returns:
SUCCESSFUL_RETURN,
RET_LOG_ENTRY_DOESNT_EXIST

References Logging::logCollection, LogCollection::setLast(), and AlgorithmicBase::userInteraction.

returnValue AlgorithmicBase::setLast ( LogName  _name,
const Matrix lastValue,
double  time = -INFTY 
) [inline, inherited]
Parameters:
[in]_nameInternal name of item.
[in]lastValueNumerical value at last time instant of given item.
[in]timeTime label of the instant.
Returns:
SUCCESSFUL_RETURN,
RET_LOG_ENTRY_DOESNT_EXIST

References Logging::logCollection, LogCollection::setLast(), and AlgorithmicBase::userInteraction.

returnValue AlgorithmicBase::setLast ( LogName  _name,
const VariablesGrid lastValue,
double  time = -INFTY 
) [inline, inherited]
Parameters:
[in]_nameInternal name of item.
[in]lastValueNumerical value at last time instant of given item.
[in]timeTime label of the instant.
Returns:
SUCCESSFUL_RETURN,
RET_LOG_ENTRY_DOESNT_EXIST

References Logging::logCollection, LogCollection::setLast(), and AlgorithmicBase::userInteraction.

returnValue IntegratorExport::setLinearInput ( const Matrix M1,
const Matrix A1,
const Matrix B1 
) [virtual, inherited]
returnValue IntegratorExport::setLinearOutput ( const Matrix M3,
const Matrix A3,
const Expression rhs 
) [virtual, inherited]
returnValue IntegratorExport::setLinearOutput ( const Matrix M3,
const Matrix A3,
const String _rhs3,
const String _diffs_rhs3 
) [virtual, inherited]
returnValue ImplicitRungeKuttaExport::setModel ( const String _rhs,
const String _diffs_rhs 
) [virtual, inherited]
Parameters:
[in]_rhsName of the function, evaluating the right-hand side.
[in]_diffs_rhsName of the function, evaluating the derivatives of the right-hand side.
Returns:
SUCCESSFUL_RETURN

Reimplemented from IntegratorExport.

References ExportAlgorithm::NDX, ImplicitRungeKuttaExport::NDX2, ImplicitRungeKuttaExport::setup(), and SUCCESSFUL_RETURN.

returnValue IntegratorExport::setModelData ( const ModelData data) [virtual, inherited]
Parameters:
[in]dataThe model data.
Returns:
SUCCESSFUL_RETURN

References ModelData::exportRhs(), IntegratorExport::exportRhs, Function::getDim(), ModelData::getDimOutputs(), Function::getExpression(), ModelData::getIntegrationGrid(), ModelData::getLinearInput(), ModelData::getLinearOutput(), ModelData::getModel(), ModelData::getN(), ModelData::getNameDiffsOutput(), ModelData::getNameDiffsOutputs(), ModelData::getNameDiffsRhs(), ModelData::getNameOutput(), ModelData::getNameOutputs(), ModelData::getNameRhs(), ModelData::getNARXmodel(), ModelData::getNDX(), ModelData::getNDX3(), ModelData::getNP(), ModelData::getNU(), Matrix::getNumRows(), ModelData::getNumSteps(), ModelData::getNX(), ModelData::getNX1(), ModelData::getNX2(), ModelData::getNX3(), ModelData::getNXA(), ModelData::getNXA3(), ModelData::getOutputDependencies(), ModelData::getOutputExpressions(), ModelData::getOutputGrids(), IntegratorExport::grid, ModelData::hasCompressedStorage(), ModelData::hasOutputs(), VectorspaceElement::isEmpty(), IntegratorExport::NDX3, IntegratorExport::numSteps, IntegratorExport::NX1, IntegratorExport::NX2, IntegratorExport::NX3, IntegratorExport::NXA3, RET_UNABLE_TO_EXPORT_CODE, IntegratorExport::setDifferentialEquation(), ExportAlgorithm::setDimensions(), IntegratorExport::setLinearInput(), IntegratorExport::setLinearOutput(), IntegratorExport::setModel(), IntegratorExport::setNARXmodel(), IntegratorExport::setup(), IntegratorExport::setupOutput(), SUCCESSFUL_RETURN, and uint.

Referenced by SIMexport::setup().

returnValue RungeKuttaExport::setNARXmodel ( const uint  delay,
const Matrix parms 
) [virtual, inherited]
Parameters:
[in]delayThe delay for the states in the NARX model.
[in]parmsThe parameters defining the polynomial NARX model.
Returns:
SUCCESSFUL_RETURN

Implements IntegratorExport.

References RET_INVALID_OPTION.

void ExportAlgorithm::setNY ( uint  NY_) [inherited]
void ExportAlgorithm::setNYN ( uint  NYN_) [inherited]
returnValue AlgorithmicBase::setOptions ( const Options arg) [inherited]
Parameters:
[in]argNew Options object to be assigned.
Note:
This routine is introduced only for convenience and is equivalent to the assignment operator.
Returns:
SUCCESSFUL_RETURN

References Options::setOptions(), and AlgorithmicBase::userInteraction.

Referenced by ShootingMethod::evaluate().

returnValue AlgorithmicBase::setOptions ( uint  idx,
const Options arg 
) [inherited]
Parameters:
[in]idxIndex of option list.
[in]argOptions object containing the option list to be assigned.
Returns:
SUCCESSFUL_RETURN

References Options::setOptions(), and AlgorithmicBase::userInteraction.

returnValue ImplicitRungeKuttaExport::setupOutput ( const std::vector< Grid outputGrids_,
const std::vector< Expression rhs 
) [virtual, inherited]
returnValue ImplicitRungeKuttaExport::setupOutput ( const std::vector< Grid outputGrids_,
const std::vector< String _outputNames,
const std::vector< String _diffs_outputNames,
const std::vector< uint _dims_output 
) [virtual, inherited]
returnValue ImplicitRungeKuttaExport::setupOutput ( const std::vector< Grid outputGrids_,
const std::vector< String _outputNames,
const std::vector< String _diffs_outputNames,
const std::vector< uint _dims_output,
const std::vector< Matrix _outputDependencies 
) [virtual, inherited]



Parameters:
outputGrids_The vector containing a grid for each output function.
_outputNamesThe names of the output functions.
_diffs_outputNamesThe names of the functions, evaluating the derivatives of the outputs.
_dims_outputThe dimensions of the output functions.
_outputDependenciesA separate dependency matrix for each output.

Returns:
SUCCESSFUL_RETURN

Implements IntegratorExport.

References BT_TRUE, IntegratorExport::crsFormat, IntegratorExport::outputDependencies, and ImplicitRungeKuttaExport::setupOutput().

returnValue DiagonallyImplicitRKExport::solveImplicitSystem ( ExportStatementBlock block,
const ExportIndex index1,
const ExportIndex index2,
const ExportIndex index3,
const ExportIndex tmp_index,
const ExportVariable Ah,
const ExportVariable C,
const ExportVariable det,
BooleanType  DERIVATIVES = BT_FALSE 
) [virtual, inherited]
returnValue DiagonallyImplicitRKExport::solveInputSystem ( ExportStatementBlock block,
const ExportIndex index1,
const ExportIndex index2,
const ExportIndex index3,
const ExportIndex tmp_index,
const ExportVariable Ah 
) [virtual, inherited]
Parameters:
[in]blockThe block to which the code will be exported.
[in]A1A constant matrix defining the equations of the linear input system.
[in]B1A constant matrix defining the equations of the linear input system.
[in]AhThe variable containing the internal coefficients of the RK method, multiplied with the step size.
Returns:
SUCCESSFUL_RETURN

Reimplemented from ImplicitRungeKuttaExport.

References ExportStatementBlock::addFunctionCall(), ExportStatementBlock::addStatement(), ExportArgument::getAddress(), ExportVariable::getCol(), ExportVariable::getCols(), ExportFunction::getName(), ExportVariable::getRow(), ExportVariable::getSubMatrix(), IntegratorExport::lin_input, RungeKuttaExport::numStages, IntegratorExport::NX1, ImplicitRungeKuttaExport::rk_b, IntegratorExport::rk_eta, RungeKuttaExport::rk_kkk, ImplicitRungeKuttaExport::rk_mat1, IntegratorExport::rk_xxx, and SUCCESSFUL_RETURN.

returnValue DiagonallyImplicitRKExport::solveOutputSystem ( ExportStatementBlock block,
const ExportIndex index1,
const ExportIndex index2,
const ExportIndex index3,
const ExportIndex tmp_index,
const ExportVariable Ah,
BooleanType  DERIVATIVES = BT_FALSE 
) [virtual, inherited]
returnValue IntegratorExport::updateImplicitSystem ( ExportStatementBlock block,
const ExportIndex index1,
const ExportIndex index2,
const ExportIndex tmp_index 
) [virtual, inherited]
returnValue IntegratorExport::updateInputSystem ( ExportStatementBlock block,
const ExportIndex index1,
const ExportIndex index2,
const ExportIndex tmp_index 
) [virtual, inherited]
returnValue IntegratorExport::updateOutputSystem ( ExportStatementBlock block,
const ExportIndex index1,
const ExportIndex index2,
const ExportIndex tmp_index 
) [virtual, inherited]

Member Data Documentation

Matrix IntegratorExport::A11 [protected, inherited]
Matrix IntegratorExport::A33 [protected, inherited]
Matrix RungeKuttaExport::AA [protected, inherited]
Matrix IntegratorExport::B11 [protected, inherited]
Vector RungeKuttaExport::bb [protected, inherited]
Vector RungeKuttaExport::cc [protected, inherited]
Matrix ImplicitRungeKuttaExport::coeffs [protected, inherited]
String ExportAlgorithm::commonHeaderName [protected, inherited]
BooleanType IntegratorExport::crsFormat [protected, inherited]
Matrix ImplicitRungeKuttaExport::DD [protected, inherited]
std::vector<ExportAcadoFunction> IntegratorExport::diffs_outputs [protected, inherited]
uint IntegratorExport::diffsDim [protected, inherited]
BooleanType IntegratorExport::exportRhs [protected, inherited]
ExportFunction IntegratorExport::fullRhs [protected, inherited]
Grid IntegratorExport::grid [protected, inherited]
std::vector<ExportVariable> ImplicitRungeKuttaExport::gridVariables [protected, inherited]
uint IntegratorExport::inputDim [protected, inherited]
Matrix IntegratorExport::M11 [protected, inherited]
Matrix IntegratorExport::M33 [protected, inherited]
uint ExportAlgorithm::N [protected, inherited]
std::vector<String> IntegratorExport::name_diffs_outputs [protected, inherited]
String IntegratorExport::name_diffs_rhs [protected, inherited]
String IntegratorExport::name_diffs_rhs3 [protected, inherited]
std::vector<String> IntegratorExport::name_outputs [protected, inherited]
String IntegratorExport::name_rhs [protected, inherited]
String IntegratorExport::name_rhs3 [protected, inherited]
uint ExportAlgorithm::NDX [protected, inherited]
uint ImplicitRungeKuttaExport::NDX2 [protected, inherited]
uint IntegratorExport::NDX3 [protected, inherited]
uint ExportAlgorithm::NP [protected, inherited]
uint ExportAlgorithm::NU [protected, inherited]

Referenced by ExportAlgorithm::copy(), ImplicitRungeKuttaExport::generateOutput(), AdjointIRKExport::getCode(), ForwardIRKExport::getCode(), ExportAlgorithm::getNU(), ExportGaussNewtonCN2::getNumQPvars(), ExportGaussNewtonQpDunes::getNumQPvars(), ExportGaussNewtonCondensed::getNumQPvars(), ExportGaussNewtonForces::getNumQPvars(), NARXExport::prepareFullRhs(), IntegratorExport::prepareFullRhs(), ImplicitRungeKuttaExport::prepareFullRhs(), DiagonallyImplicitRKExport::prepareInputSystem(), AdjointIRKExport::prepareInputSystem(), ForwardIRKExport::prepareInputSystem(), NARXExport::propagateImplicitSystem(), IntegratorExport::propagateImplicitSystem(), NARXExport::propagateInputSystem(), IntegratorExport::propagateInputSystem(), AdjointIRKExport::propagateOutputs(), ForwardIRKExport::propagateOutputs(), NARXExport::propagateOutputSystem(), IntegratorExport::propagateOutputSystem(), AdjointIRKExport::sensitivitiesOutputs(), ForwardIRKExport::sensitivitiesOutputs(), ExportNLPSolver::setConstraints(), ExplicitRungeKuttaExport::setDifferentialEquation(), DiscreteTimeExport::setDifferentialEquation(), ImplicitRungeKuttaExport::setDifferentialEquation(), ExportAlgorithm::setDimensions(), IntegratorExport::setLinearInput(), IntegratorExport::setLinearOutput(), NARXExport::setLinearOutput(), IntegratorExport::setModel(), NARXExport::setNARXmodel(), ExportNLPSolver::setObjective(), ExplicitRungeKuttaExport::setup(), NARXExport::setup(), DiscreteTimeExport::setup(), AdjointIRKExport::setup(), ImplicitRungeKuttaExport::setup(), ForwardIRKExport::setup(), ExportNLPSolver::setupArrivalCostCalculation(), ExportNLPSolver::setupAuxiliaryFunctions(), ExportGaussNewtonCN2::setupCondensing(), ExportGaussNewtonCondensed::setupCondensing(), ExportGaussNewtonQpDunes::setupConstraintsEvaluation(), ExportGaussNewtonCN2::setupConstraintsEvaluation(), ExportGaussNewtonForces::setupConstraintsEvaluation(), ExportGaussNewtonCondensed::setupConstraintsEvaluation(), ExportGaussNewtonQpDunes::setupEvaluation(), ExportGaussNewtonForces::setupEvaluation(), ExportGaussNewtonCN2::setupMultiplicationRoutines(), ExportGaussNewtonCondensed::setupMultiplicationRoutines(), ExportGaussNewtonQpDunes::setupObjectiveEvaluation(), ExportGaussNewtonForces::setupObjectiveEvaluation(), ExportGaussNewtonCN2::setupObjectiveEvaluation(), ExportGaussNewtonCondensed::setupObjectiveEvaluation(), ImplicitRungeKuttaExport::setupOutput(), ExportGaussNewtonForces::setupQPInterface(), ExportNLPSolver::setupSimulation(), ExportGaussNewtonCN2::setupVariables(), ExportGaussNewtonCondensed::setupVariables(), NARXExport::updateImplicitSystem(), IntegratorExport::updateImplicitSystem(), NARXExport::updateInputSystem(), IntegratorExport::updateInputSystem(), NARXExport::updateOutputSystem(), and IntegratorExport::updateOutputSystem().

std::vector<uint> IntegratorExport::num_outputs [protected, inherited]
uint ImplicitRungeKuttaExport::numIts [protected, inherited]
std::vector<ExportIndex> ImplicitRungeKuttaExport::numMeas [protected, inherited]
std::vector<ExportVariable> ImplicitRungeKuttaExport::numMeasVariables [protected, inherited]
uint RungeKuttaExport::numStages [protected, inherited]

Referenced by RungeKuttaExport::copy(), ImplicitRungeKuttaExport::copy(), ImplicitRungeKuttaExport::evaluateDerivedPolynomial(), ImplicitRungeKuttaExport::evaluateMatrix(), ImplicitRungeKuttaExport::evaluatePolynomial(), ImplicitRungeKuttaExport::evaluateStatesImplicitSystem(), ImplicitRungeKuttaExport::evaluateStatesOutputSystem(), DiagonallyImplicitRKExport::formMatrix(), ImplicitRungeKuttaExport::formMatrix(), ImplicitRungeKuttaExport::generateOutput(), ForwardIRKExport::getCode(), AdjointIRKExport::getCode(), ImplicitRungeKuttaExport::getCode(), RungeKuttaExport::getNumStages(), RungeKuttaExport::initializeButcherTableau(), ImplicitRungeKuttaExport::initializeCoefficients(), ImplicitRungeKuttaExport::initializeDDMatrix(), DiagonallyImplicitRKExport::prepareInputSystem(), ForwardIRKExport::prepareInputSystem(), AdjointIRKExport::prepareInputSystem(), ImplicitRungeKuttaExport::prepareInputSystem(), ImplicitRungeKuttaExport::prepareOutputEvaluation(), ForwardIRKExport::prepareOutputSystem(), AdjointIRKExport::prepareOutputSystem(), DiagonallyImplicitRKExport::prepareOutputSystem(), ImplicitRungeKuttaExport::prepareOutputSystem(), ForwardIRKExport::sensitivitiesImplicitSystem(), AdjointIRKExport::sensitivitiesImplicitSystem(), DiagonallyImplicitRKExport::sensitivitiesImplicitSystem(), ForwardIRKExport::sensitivitiesOutputs(), AdjointIRKExport::sensitivitiesOutputs(), DiagonallyImplicitRKExport::sensitivitiesOutputSystem(), ForwardIRKExport::sensitivitiesOutputSystem(), AdjointIRKExport::sensitivitiesOutputSystem(), AdjointIRKExport::setup(), ForwardIRKExport::setup(), ImplicitRungeKuttaExport::setup(), DiagonallyImplicitRKExport::setup(), ImplicitRungeKuttaExport::setupOutput(), DiagonallyImplicitRKExport::solveImplicitSystem(), ImplicitRungeKuttaExport::solveImplicitSystem(), DiagonallyImplicitRKExport::solveInputSystem(), ImplicitRungeKuttaExport::solveInputSystem(), DiagonallyImplicitRKExport::solveOutputSystem(), and ImplicitRungeKuttaExport::solveOutputSystem().

Vector IntegratorExport::numSteps [protected, inherited]
uint ImplicitRungeKuttaExport::NVARS2 [protected, inherited]
uint ImplicitRungeKuttaExport::NVARS3 [protected, inherited]
uint ExportAlgorithm::NX [protected, inherited]

Referenced by ExportAlgorithm::copy(), DiagonallyImplicitRKExport::evaluateStatesImplicitSystem(), ImplicitRungeKuttaExport::evaluateStatesImplicitSystem(), ImplicitRungeKuttaExport::evaluateStatesOutputSystem(), IntegratorExport::expandOutputMatrix(), ImplicitRungeKuttaExport::generateOutput(), ForwardIRKExport::getCode(), AdjointIRKExport::getCode(), DiscreteTimeExport::getCode(), ImplicitRungeKuttaExport::getCode(), DiscreteTimeExport::getFunctionDeclarations(), ImplicitRungeKuttaExport::getFunctionDeclarations(), IntegratorExport::getNameFullRHS(), ExportGaussNewtonCN2::getNumQPvars(), ExportGaussNewtonQpDunes::getNumQPvars(), ExportGaussNewtonCondensed::getNumQPvars(), ExportGaussNewtonForces::getNumQPvars(), ExportAlgorithm::getNX(), NARXExport::prepareFullRhs(), IntegratorExport::prepareFullRhs(), ImplicitRungeKuttaExport::prepareFullRhs(), NARXExport::propagateImplicitSystem(), IntegratorExport::propagateImplicitSystem(), NARXExport::propagateInputSystem(), IntegratorExport::propagateInputSystem(), ForwardIRKExport::propagateOutputs(), AdjointIRKExport::propagateOutputs(), NARXExport::propagateOutputSystem(), IntegratorExport::propagateOutputSystem(), ForwardIRKExport::sensitivitiesImplicitSystem(), AdjointIRKExport::sensitivitiesImplicitSystem(), DiagonallyImplicitRKExport::sensitivitiesImplicitSystem(), ForwardIRKExport::sensitivitiesOutputs(), AdjointIRKExport::sensitivitiesOutputs(), DiagonallyImplicitRKExport::sensitivitiesOutputSystem(), ForwardIRKExport::sensitivitiesOutputSystem(), AdjointIRKExport::sensitivitiesOutputSystem(), ExportNLPSolver::setConstraints(), ExplicitRungeKuttaExport::setDifferentialEquation(), DiscreteTimeExport::setDifferentialEquation(), ImplicitRungeKuttaExport::setDifferentialEquation(), ExportAlgorithm::setDimensions(), IntegratorExport::setLinearInput(), IntegratorExport::setLinearOutput(), NARXExport::setLinearOutput(), IntegratorExport::setModel(), NARXExport::setNARXmodel(), ExportNLPSolver::setObjective(), NARXExport::setup(), ExplicitRungeKuttaExport::setup(), DiscreteTimeExport::setup(), ImplicitRungeKuttaExport::setup(), AdjointIRKExport::setup(), ForwardIRKExport::setup(), ExportNLPSolver::setupArrivalCostCalculation(), ExportNLPSolver::setupAuxiliaryFunctions(), ExportGaussNewtonCN2::setupCondensing(), ExportGaussNewtonCondensed::setupCondensing(), ExportGaussNewtonQpDunes::setupConstraintsEvaluation(), ExportGaussNewtonCN2::setupConstraintsEvaluation(), ExportGaussNewtonForces::setupConstraintsEvaluation(), ExportGaussNewtonCondensed::setupConstraintsEvaluation(), ExportGaussNewtonQpDunes::setupEvaluation(), ExportGaussNewtonForces::setupEvaluation(), ExportGaussNewtonCN2::setupMultiplicationRoutines(), ExportGaussNewtonCondensed::setupMultiplicationRoutines(), ExportGaussNewtonQpDunes::setupObjectiveEvaluation(), ExportGaussNewtonCN2::setupObjectiveEvaluation(), ExportGaussNewtonForces::setupObjectiveEvaluation(), ExportGaussNewtonCondensed::setupObjectiveEvaluation(), ImplicitRungeKuttaExport::setupOutput(), ExportGaussNewtonForces::setupQPInterface(), ExportNLPSolver::setupSimulation(), ExportGaussNewtonQpDunes::setupVariables(), ExportGaussNewtonForces::setupVariables(), ExportGaussNewtonCN2::setupVariables(), ExportGaussNewtonCondensed::setupVariables(), DiagonallyImplicitRKExport::solveImplicitSystem(), ImplicitRungeKuttaExport::solveImplicitSystem(), DiagonallyImplicitRKExport::solveOutputSystem(), NARXExport::updateImplicitSystem(), IntegratorExport::updateImplicitSystem(), NARXExport::updateInputSystem(), IntegratorExport::updateInputSystem(), NARXExport::updateOutputSystem(), and IntegratorExport::updateOutputSystem().

uint IntegratorExport::NX1 [protected, inherited]

Referenced by DiagonallyImplicitRKExport::evaluateMatrix(), ImplicitRungeKuttaExport::evaluateMatrix(), DiagonallyImplicitRKExport::evaluateRhsImplicitSystem(), ImplicitRungeKuttaExport::evaluateRhsImplicitSystem(), DiagonallyImplicitRKExport::evaluateStatesImplicitSystem(), ImplicitRungeKuttaExport::evaluateStatesImplicitSystem(), ImplicitRungeKuttaExport::evaluateStatesOutputSystem(), NARXExport::formNARXpolynomial(), DiscreteTimeExport::getAuxVariable(), AdjointIRKExport::getAuxVariable(), ForwardIRKExport::getAuxVariable(), ImplicitRungeKuttaExport::getAuxVariable(), ForwardIRKExport::getCode(), AdjointIRKExport::getCode(), DiscreteTimeExport::getCode(), ImplicitRungeKuttaExport::getCode(), ImplicitRungeKuttaExport::getDataDeclarations(), ImplicitRungeKuttaExport::ImplicitRungeKuttaExport(), IntegratorExport::IntegratorExport(), NARXExport::prepareFullRhs(), IntegratorExport::prepareFullRhs(), ImplicitRungeKuttaExport::prepareFullRhs(), DiagonallyImplicitRKExport::prepareInputSystem(), AdjointIRKExport::prepareInputSystem(), ForwardIRKExport::prepareInputSystem(), ImplicitRungeKuttaExport::prepareInputSystem(), NARXExport::propagateImplicitSystem(), IntegratorExport::propagateImplicitSystem(), NARXExport::propagateInputSystem(), IntegratorExport::propagateInputSystem(), ForwardIRKExport::propagateOutputs(), AdjointIRKExport::propagateOutputs(), NARXExport::propagateOutputSystem(), IntegratorExport::propagateOutputSystem(), AdjointIRKExport::sensitivitiesImplicitSystem(), ForwardIRKExport::sensitivitiesImplicitSystem(), DiagonallyImplicitRKExport::sensitivitiesImplicitSystem(), ForwardIRKExport::sensitivitiesInputSystem(), AdjointIRKExport::sensitivitiesInputSystem(), ForwardIRKExport::sensitivitiesOutputs(), AdjointIRKExport::sensitivitiesOutputs(), DiagonallyImplicitRKExport::sensitivitiesOutputSystem(), AdjointIRKExport::sensitivitiesOutputSystem(), ForwardIRKExport::sensitivitiesOutputSystem(), ImplicitRungeKuttaExport::setDifferentialEquation(), DiscreteTimeExport::setDifferentialEquation(), IntegratorExport::setLinearInput(), IntegratorExport::setLinearOutput(), NARXExport::setLinearOutput(), IntegratorExport::setModel(), IntegratorExport::setModelData(), NARXExport::setNARXmodel(), NARXExport::setup(), DiscreteTimeExport::setup(), ForwardIRKExport::setup(), AdjointIRKExport::setup(), ImplicitRungeKuttaExport::setup(), DiagonallyImplicitRKExport::setup(), DiagonallyImplicitRKExport::solveImplicitSystem(), ImplicitRungeKuttaExport::solveImplicitSystem(), DiagonallyImplicitRKExport::solveInputSystem(), ImplicitRungeKuttaExport::solveInputSystem(), DiagonallyImplicitRKExport::solveOutputSystem(), ImplicitRungeKuttaExport::solveOutputSystem(), NARXExport::updateImplicitSystem(), IntegratorExport::updateImplicitSystem(), NARXExport::updateInputSystem(), IntegratorExport::updateInputSystem(), NARXExport::updateOutputSystem(), and IntegratorExport::updateOutputSystem().

uint IntegratorExport::NX2 [protected, inherited]

Referenced by DiagonallyImplicitRKExport::evaluateMatrix(), ImplicitRungeKuttaExport::evaluateMatrix(), DiagonallyImplicitRKExport::evaluateRhsImplicitSystem(), ImplicitRungeKuttaExport::evaluateRhsImplicitSystem(), DiagonallyImplicitRKExport::evaluateStatesImplicitSystem(), ImplicitRungeKuttaExport::evaluateStatesImplicitSystem(), ImplicitRungeKuttaExport::evaluateStatesOutputSystem(), NARXExport::formNARXpolynomial(), DiscreteTimeExport::getAuxVariable(), ForwardIRKExport::getAuxVariable(), AdjointIRKExport::getAuxVariable(), ImplicitRungeKuttaExport::getAuxVariable(), ForwardIRKExport::getCode(), AdjointIRKExport::getCode(), DiscreteTimeExport::getCode(), ImplicitRungeKuttaExport::getCode(), ImplicitRungeKuttaExport::getDataDeclarations(), DiscreteTimeExport::getFunctionDeclarations(), ImplicitRungeKuttaExport::getFunctionDeclarations(), IntegratorExport::getNameFullRHS(), ImplicitRungeKuttaExport::ImplicitRungeKuttaExport(), IntegratorExport::IntegratorExport(), NARXExport::prepareFullRhs(), IntegratorExport::prepareFullRhs(), ImplicitRungeKuttaExport::prepareFullRhs(), NARXExport::propagateImplicitSystem(), IntegratorExport::propagateImplicitSystem(), AdjointIRKExport::propagateOutputs(), ForwardIRKExport::propagateOutputs(), NARXExport::propagateOutputSystem(), IntegratorExport::propagateOutputSystem(), ForwardIRKExport::sensitivitiesImplicitSystem(), AdjointIRKExport::sensitivitiesImplicitSystem(), DiagonallyImplicitRKExport::sensitivitiesImplicitSystem(), AdjointIRKExport::sensitivitiesOutputs(), ForwardIRKExport::sensitivitiesOutputs(), DiagonallyImplicitRKExport::sensitivitiesOutputSystem(), AdjointIRKExport::sensitivitiesOutputSystem(), ForwardIRKExport::sensitivitiesOutputSystem(), ImplicitRungeKuttaExport::setDifferentialEquation(), DiscreteTimeExport::setDifferentialEquation(), IntegratorExport::setLinearOutput(), NARXExport::setLinearOutput(), IntegratorExport::setModel(), IntegratorExport::setModelData(), NARXExport::setNARXmodel(), NARXExport::setup(), DiscreteTimeExport::setup(), ForwardIRKExport::setup(), AdjointIRKExport::setup(), ImplicitRungeKuttaExport::setup(), DiagonallyImplicitRKExport::setup(), DiagonallyImplicitRKExport::solveImplicitSystem(), ImplicitRungeKuttaExport::solveImplicitSystem(), DiagonallyImplicitRKExport::solveOutputSystem(), ImplicitRungeKuttaExport::solveOutputSystem(), NARXExport::updateImplicitSystem(), IntegratorExport::updateImplicitSystem(), NARXExport::updateOutputSystem(), and IntegratorExport::updateOutputSystem().

uint IntegratorExport::NX3 [protected, inherited]

Referenced by ImplicitRungeKuttaExport::evaluateStatesOutputSystem(), IntegratorExport::expandOutputMatrix(), DiscreteTimeExport::getAuxVariable(), AdjointIRKExport::getAuxVariable(), ForwardIRKExport::getAuxVariable(), ImplicitRungeKuttaExport::getAuxVariable(), ForwardIRKExport::getCode(), AdjointIRKExport::getCode(), DiscreteTimeExport::getCode(), ImplicitRungeKuttaExport::getCode(), ForwardIRKExport::getFunctionDeclarations(), AdjointIRKExport::getFunctionDeclarations(), ImplicitRungeKuttaExport::getFunctionDeclarations(), ImplicitRungeKuttaExport::ImplicitRungeKuttaExport(), IntegratorExport::IntegratorExport(), NARXExport::prepareFullRhs(), IntegratorExport::prepareFullRhs(), ImplicitRungeKuttaExport::prepareFullRhs(), ForwardIRKExport::prepareOutputSystem(), AdjointIRKExport::prepareOutputSystem(), DiagonallyImplicitRKExport::prepareOutputSystem(), ImplicitRungeKuttaExport::prepareOutputSystem(), NARXExport::propagateOutputSystem(), IntegratorExport::propagateOutputSystem(), DiagonallyImplicitRKExport::sensitivitiesOutputSystem(), ForwardIRKExport::sensitivitiesOutputSystem(), AdjointIRKExport::sensitivitiesOutputSystem(), IntegratorExport::setLinearOutput(), NARXExport::setLinearOutput(), IntegratorExport::setModel(), IntegratorExport::setModelData(), NARXExport::setup(), DiscreteTimeExport::setup(), ImplicitRungeKuttaExport::setup(), ForwardIRKExport::setup(), AdjointIRKExport::setup(), DiagonallyImplicitRKExport::setup(), DiagonallyImplicitRKExport::solveOutputSystem(), ImplicitRungeKuttaExport::solveOutputSystem(), IntegratorExport::updateImplicitSystem(), NARXExport::updateOutputSystem(), and IntegratorExport::updateOutputSystem().

uint ExportAlgorithm::NXA [protected, inherited]

Referenced by ExportAlgorithm::copy(), DiagonallyImplicitRKExport::evaluateMatrix(), ImplicitRungeKuttaExport::evaluateMatrix(), DiagonallyImplicitRKExport::evaluateRhsImplicitSystem(), ImplicitRungeKuttaExport::evaluateRhsImplicitSystem(), DiagonallyImplicitRKExport::evaluateStatesImplicitSystem(), ImplicitRungeKuttaExport::evaluateStatesImplicitSystem(), ImplicitRungeKuttaExport::generateOutput(), ForwardIRKExport::getAuxVariable(), AdjointIRKExport::getAuxVariable(), ImplicitRungeKuttaExport::getAuxVariable(), ForwardIRKExport::getCode(), AdjointIRKExport::getCode(), DiscreteTimeExport::getCode(), ImplicitRungeKuttaExport::getCode(), ImplicitRungeKuttaExport::getDataDeclarations(), ExportAlgorithm::getNXA(), IntegratorExport::prepareFullRhs(), ImplicitRungeKuttaExport::prepareFullRhs(), ImplicitRungeKuttaExport::prepareOutputEvaluation(), IntegratorExport::propagateImplicitSystem(), IntegratorExport::propagateInputSystem(), IntegratorExport::propagateOutputSystem(), ForwardIRKExport::sensitivitiesImplicitSystem(), AdjointIRKExport::sensitivitiesImplicitSystem(), DiagonallyImplicitRKExport::sensitivitiesImplicitSystem(), AdjointIRKExport::sensitivitiesOutputs(), ForwardIRKExport::sensitivitiesOutputs(), DiagonallyImplicitRKExport::sensitivitiesOutputSystem(), ForwardIRKExport::sensitivitiesOutputSystem(), AdjointIRKExport::sensitivitiesOutputSystem(), ExplicitRungeKuttaExport::setDifferentialEquation(), DiscreteTimeExport::setDifferentialEquation(), ImplicitRungeKuttaExport::setDifferentialEquation(), ExportAlgorithm::setDimensions(), IntegratorExport::setLinearInput(), IntegratorExport::setLinearOutput(), NARXExport::setLinearOutput(), IntegratorExport::setModel(), NARXExport::setNARXmodel(), DiscreteTimeExport::setup(), AdjointIRKExport::setup(), ForwardIRKExport::setup(), ImplicitRungeKuttaExport::setup(), DiagonallyImplicitRKExport::setup(), ExportNLPSolver::setupArrivalCostCalculation(), ExportNLPSolver::setupAuxiliaryFunctions(), ImplicitRungeKuttaExport::setupOutput(), ExportNLPSolver::setupSimulation(), DiagonallyImplicitRKExport::solveImplicitSystem(), ImplicitRungeKuttaExport::solveImplicitSystem(), IntegratorExport::updateImplicitSystem(), IntegratorExport::updateInputSystem(), and IntegratorExport::updateOutputSystem().

uint IntegratorExport::NXA3 [protected, inherited]
uint ExportAlgorithm::NY [protected, inherited]
uint ExportAlgorithm::NYN [protected, inherited]
std::vector<Matrix> IntegratorExport::outputDependencies [protected, inherited]
std::vector<Expression> IntegratorExport::outputExpressions [protected, inherited]
std::vector<Grid> IntegratorExport::outputGrids [protected, inherited]
int AlgorithmicBase::outputLoggingIdx [protected, inherited]
std::vector<ExportAcadoFunction> IntegratorExport::outputs [protected, inherited]
Parameter IntegratorExport::p [protected, inherited]
std::vector<ExportVariable> ImplicitRungeKuttaExport::polynDerVariables [protected, inherited]
std::vector<ExportVariable> ImplicitRungeKuttaExport::polynVariables [protected, inherited]
ExportVariable IntegratorExport::rhs_in [protected, inherited]
ExportVariable IntegratorExport::rhs_out [protected, inherited]
ExportVariable IntegratorExport::rk_eta [protected, inherited]
ExportVariable RungeKuttaExport::rk_kkk [protected, inherited]
std::vector<ExportVariable> ImplicitRungeKuttaExport::rk_outputs [protected, inherited]
ExportVariable IntegratorExport::rk_ttt [protected, inherited]
ExportVariable IntegratorExport::rk_xxx [protected, inherited]
std::vector<uint> ImplicitRungeKuttaExport::totalMeas [protected, inherited]
Control IntegratorExport::u [protected, inherited]
DifferentialState IntegratorExport::x [protected, inherited]
AlgebraicState IntegratorExport::z [protected, inherited]

The documentation for this class was generated from the following files:
 All Classes Files Functions Variables Typedefs Enumerations Enumerator Friends Defines