public:
/**
* Purely virtual function. This function is used to advance from time @p
- * t to p+ @p delta_t. @p F is a vector of functions \f$ f(t,y) \f$ that should be
+ * t to t+ @p delta_t. @p F is a vector of functions \f$ f(t,y) \f$ that should be
* integrated, the input parameters are the time t and the vector y and the
* output is value of f at this point. @p J_inverse is a vector
* functions that compute the inverse of the Jacobians associated to the
virtual void initialize(runge_kutta_method method) = 0;
/**
* This function is used to advance from time @p
- * t to p+ @p delta_t. @p F is a vector of functions \f$ f(t,y) \f$ that should be
+ * t to t+ @p delta_t. @p F is a vector of functions \f$ f(t,y) \f$ that should be
* integrated, the input parameters are the time t and the vector y and the
* output is value of f at this point. @p J_inverse is a vector
* functions that compute the inverse of the Jacobians associated to the
/**
* Purely virtual function. This function is used to advance from time @p t
- * to p+ @p delta_t. @p f is the function \f$ f(t,y) \f$ that should be
+ * to t+ @p delta_t. @p f is the function \f$ f(t,y) \f$ that should be
* integrated, the input parameters are the time t and the vector y and the
* output is value of f at this point. @p id_minus_tau_J_inverse is a function
* that computes \f$ inv(I-\tau J)\f$ where \f$ I \f$ is the identity matrix,
void initialize(runge_kutta_method method);
/**
- * This function is used to advance from time @p t to p+ @p delta_t. @p f
+ * This function is used to advance from time @p t to t+ @p delta_t. @p f
* is the function \f$ f(t,y) \f$ that should be integrated, the input
* parameters are the time t and the vector y and the output is value of
* f at this point. @p id_minus_tau_J_inverse is a function that computes
VECTOR &y);
/**
- * This function is used to advance from time @p t to p+ @p delta_t.
+ * This function is used to advance from time @p t to t+ @p delta_t.
* This function is similar to the one derived from RungeKutta, but
* does not required id_minus_tau_J_inverse because it is not used for
* explicit methods. evolve_one_time_step returns the time at the end of the
void initialize(runge_kutta_method method);
/**
- * This function is used to advance from time @p t to p+ @p delta_t. @p f
+ * This function is used to advance from time @p t to t+ @p delta_t. @p f
* is the function \f$ f(t,y) \f$ that should be integrated, the input
* parameters are the time t and the vector y and the output is value of
* f at this point. @p id_minus_tau_J_inverse is a function that computes
void initialize(runge_kutta_method method);
/**
- * This function is used to advance from time @p t to p+ @p delta_t. @p f
+ * This function is used to advance from time @p t to t+ @p delta_t. @p f
* is the function \f$ f(t,y) \f$ that should be integrated, the input
* parameters are the time t and the vector y and the output is value of
* f at this point. @p id_minus_tau_J_inverse is a function that computes
VECTOR &y);
/**
- * This function is used to advance from time @p t to p+ @p delta_t.
+ * This function is used to advance from time @p t to t+ @p delta_t.
* This function is similar to the one derived from TimeStepping, but
* does not required id_minus_tau_J_inverse because it is not used for
* explicit methods. evolve_one_time_step returns the time at the end of the