9#include "cantera/numerics/sundials_headers.h"
17 return N_VNew_Serial(
static_cast<sd_size_t
>(N), context.get());
36static int ida_rhs(sunrealtype t, N_Vector y, N_Vector ydot, N_Vector r,
void* f_data)
39 return f->
evalDaeNoThrow(t, NV_DATA_S(y), NV_DATA_S(ydot), NV_DATA_S(r));
42#if SUNDIALS_VERSION_MAJOR >= 7
47 static void sundials_err(
int line,
const char *func,
const char *file,
48 const char *msg, SUNErrCode err_code,
49 void *err_user_data, SUNContext sunctx)
51 IdasIntegrator* integrator = (IdasIntegrator*) err_user_data;
52 integrator->m_error_message = fmt::format(
"{}: {}\n", func, msg);
58 static void ida_err(
int error_code,
const char* module,
59 const char* function,
char* msg,
void* eh_data)
74IdasIntegrator::~IdasIntegrator()
80 N_VDestroy_Serial(
m_y);
89 N_VDestroy_Serial(m_constraints);
95 return NV_Ith_S(
m_y, k);
100 return NV_DATA_S(
m_y);
113 for (
size_t i=0; i<n; i++) {
142 checkError(flag,
"setMaxOrder",
"IDASetMaxOrd");
151 int flag = IDASetMaxStep(
m_ida_mem, hmax);
152 checkError(flag,
"setMaxStepSize",
"IDASetMaxStep");
183 int flag = IDAGetNumSteps(
m_ida_mem, &val);
184 checkError(flag,
"solverStats",
"IDAGetNumSteps");
185 stats[
"steps"] = val;
187 stats[
"res_evals"] = val;
189 stats[
"lin_solve_setups"] = val;
191 stats[
"err_tests_fails"] = val;
194 IDAGetNumNonlinSolvIters(
m_ida_mem, &val);
195 stats[
"nonlinear_iters"] = val;
196 IDAGetNumNonlinSolvConvFails(
m_ida_mem, &val);
197 stats[
"nonlinear_conv_fails"] = val;
201void IdasIntegrator::setMaxNonlinIterations(
int n)
206 checkError(flag,
"setMaxNonlinIterations",
"IDASetMaxNonlinIters");
210void IdasIntegrator::setMaxNonlinConvFailures(
int n)
215 checkError(flag,
"setMaxNonlinConvFailures",
"IDASetMaxConvFails");
219void IdasIntegrator::includeAlgebraicInErrorTest(
bool yesno)
224 checkError(flag,
"inclAlgebraicInErrorTest",
"IDASetSuppressAlg");
238 N_VDestroy_Serial(
m_y);
244 N_VDestroy_Serial(
m_ydot);
252 "not enough absolute tolerance values specified.");
256 N_VDestroy_Serial(m_constraints);
272 throw CanteraError(
"IdasIntegrator::initialize",
"IDACreate failed.");
276 if (flag != IDA_SUCCESS) {
277 if (flag == IDA_MEM_FAIL) {
279 "Memory allocation failed.");
280 }
else if (flag == IDA_ILL_INPUT) {
282 "Illegal value for IDAInit input argument.");
284 throw CanteraError(
"IdasIntegrator::initialize",
"IDAInit failed.");
288 #if SUNDIALS_VERSION_MAJOR >= 7
289 flag = SUNContext_PushErrHandler(
m_sundials_ctx.get(), &sundials_err,
this);
295 flag = IDASetId(
m_ida_mem, m_constraints);
300 checkError(flag,
"initialize",
"IDASVtolerances");
303 checkError(flag,
"initialize",
"IDASStolerances");
307 checkError(flag,
"initialize",
"IDASetUserData");
310 throw CanteraError(
"IdasIntegrator::initialize",
"Sensitivity analysis "
311 "for DAE systems is not fully implemented");
315 checkError(flag,
"initialize",
"IDASetSensParams");
320void IdasIntegrator::reinitialize(
double t0,
FuncEval& func)
330 checkError(result,
"reinitialize",
"IDAReInit");
337 sd_size_t N =
static_cast<sd_size_t
>(
m_neq);
338 SUNLinSolFree((SUNLinearSolver)
m_linsol);
341 #if CT_SUNDIALS_USE_LAPACK
350 }
else if (
m_type ==
"GMRES") {
351 SUNLinSolFree((SUNLinearSolver)
m_linsol);
356 "unsupported linear solver flag '{}'",
m_type);
365 checkError(flag,
"applyOptions",
"IDASetMaxOrd");
375 checkError(flag,
"applyOptions",
"IDASetMaxNonlinIters");
379 checkError(flag,
"applyOptions",
"IDASetMaxConvFails");
383 checkError(flag,
"applyOptions",
"IDASetSuppressAlg");
387void IdasIntegrator::sensInit(
double t0,
FuncEval& func)
393 m_yS = N_VCloneVectorArray(
static_cast<int>(
m_np), y);
394 for (
size_t n = 0; n <
m_np; n++) {
395 N_VConst(0.0,
m_yS[n]);
397 N_VDestroy_Serial(y);
399 m_ySdot = N_VCloneVectorArray(
static_cast<int>(
m_np), ydot);
400 for (
size_t n = 0; n <
m_np; n++) {
404 int flag = IDASensInit(
m_ida_mem,
static_cast<sd_size_t
>(
m_np),
408 vector<double> atol(
m_np);
409 for (
size_t n = 0; n <
m_np; n++) {
415 checkError(flag,
"sensInit",
"IDASensSStolerances");
422 }
else if (tout <
m_time) {
424 "Cannot integrate backwards in time.\n"
425 "Requested time {} < current time {}",
432 "Maximum number of timesteps ({}) taken without reaching output "
433 "time ({}).\nCurrent integrator time: {}",
437 if (flag != IDA_SUCCESS) {
439 if (!f_errs.empty()) {
440 f_errs =
"Exceptions caught during RHS evaluation:\n" + f_errs;
443 "IDA error encountered. Error code: {}\n{}\n"
445 "Components with largest weighted error estimates:\n{}",
458 if (flag != IDA_SUCCESS) {
460 if (!f_errs.empty()) {
461 f_errs =
"Exceptions caught during RHS evaluation:\n" + f_errs;
464 "IDA error encountered. Error code: {}\n{}\n"
466 "Components with largest weighted error estimates:\n{}",
474double IdasIntegrator::sensitivity(
size_t k,
size_t p)
482 checkError(flag,
"sensitivity",
"IDAGetSens");
487 throw CanteraError(
"IdasIntegrator::sensitivity",
488 "sensitivity: k out of range ({})", k);
491 throw CanteraError(
"IdasIntegrator::sensitivity",
492 "sensitivity: p out of range ({})", p);
494 return NV_Ith_S(
m_yS[p],k);
504 vector<tuple<double, double, size_t>> weightedErrors;
505 for (
size_t i=0; i<
m_neq; i++) {
506 double err = NV_Ith_S(errs, i) * NV_Ith_S(errw, i);
507 weightedErrors.emplace_back(-abs(err), err, i);
512 N = std::min(N,
static_cast<int>(
m_neq));
513 sort(weightedErrors.begin(), weightedErrors.end());
514 fmt::memory_buffer s;
515 for (
int i=0; i<N; i++) {
516 fmt_append(s,
"{}: {}\n", get<2>(weightedErrors[i]), get<1>(weightedErrors[i]));
522 const string& idaMethod)
const
524 if (flag == IDA_SUCCESS) {
526 }
else if (flag == IDA_MEM_NULL) {
528 "IDAS integrator is not initialized");
530 const char* flagname = IDAGetReturnFlagName(flag);
532 "{} returned error code {} ({}):\n{}",
541 throw CanteraError(
"IdasIntegrator::setMethod",
"unknown method");
Header file for class IdasIntegrator.
A map of string keys to values whose type can vary at runtime.
Base class for exceptions thrown by Cantera classes.
Virtual base class for ODE/DAE right-hand-side function evaluators.
virtual void getStateDae(double *y, double *ydot)
Fill in the vectors y and ydot with the current state of the system.
vector< double > m_paramScales
Scaling factors for each sensitivity parameter.
int evalDaeNoThrow(double t, double *y, double *ydot, double *residual)
Evaluate the right-hand side using return code to indicate status.
void clearErrors()
Clear any previously-stored suppressed errors.
virtual size_t neq() const =0
Number of equations.
virtual void getConstraints(double *constraints)
Given a vector of length neq(), mark which variables should be considered algebraic constraints.
virtual size_t nparams() const
Number of sensitivity parameters.
string getErrors() const
Return a string containing the text of any suppressed errors.
vector< double > m_sens_params
Values for the problem parameters for which sensitivities are computed This is the array which is per...
Wrapper for Sundials IDAS solver.
double step(double tout) override
Integrate the system of equations.
void setMaxStepSize(double hmax) override
Set the maximum step size.
double * solution() override
The current value of the solution of the system of equations.
double m_t0
The start time for the integrator.
N_Vector m_y
The current system state.
void * m_linsol
Sundials linear solver object.
int m_maxNonlinConvFails
Maximum number of nonlinear convergence failures.
double m_init_step
Initial IDA step size.
void checkError(long flag, const string &ctMethod, const string &idaMethod) const
Check whether an IDAS method indicated an error.
double m_abstolsens
Scalar absolute tolerance for sensitivities.
size_t m_nabs
! Number of variables for which absolute tolerances were provided
void setMaxOrder(int n) override
Set the maximum integration order that will be used.
double m_time
The current integrator time, corresponding to m_y.
int m_maxNonlinIters
Maximum number of nonlinear solver iterations at one solution.
bool m_sens_ok
Indicates whether the sensitivities stored in m_yS and m_ySdot have been updated for the current inte...
int maxSteps() override
Returns the maximum number of time-steps the integrator can take before reaching the next output time...
SundialsContext m_sundials_ctx
SUNContext object for Sundials>=6.0.
FuncEval * m_func
Object implementing the DAE residual function .
double m_abstols
Scalar absolute tolerance.
double m_hmax
Maximum time step size.
int m_itol
Flag indicating whether scalar (IDA_SS) or vector (IDA_SV) absolute tolerances are being used.
int m_maxErrTestFails
Maximum number of error test failures in attempting one step.
int m_maxord
Maximum order allowed for the BDF method.
void setSensitivityTolerances(double reltol, double abstol) override
Set the sensitivity error tolerances.
void applyOptions()
Applies user-specified options to the underlying IDAS solver.
void integrate(double tout) override
Integrate the system of equations.
void setTolerances(double reltol, size_t n, double *abstol) override
Set error tolerances.
void setLinearSolverType(const string &linearSolverType) override
Set the linear solver type.
double m_reltol
Relative tolerance for all state variables.
string m_error_message
Error message information provide by IDAS.
double m_reltolsens
Scalar relative tolerance for sensitivities.
N_Vector * m_yS
Sensitivities of y, size m_np by m_neq.
void setMaxErrTestFails(int n) override
Set the maximum permissible number of error test failures.
void setMaxSteps(int nmax) override
Set the maximum number of time-steps the integrator can take before reaching the next output time.
size_t m_neq
Number of equations/variables in the system.
AnyMap solverStats() const override
Get solver stats from integrator.
string m_type
The linear solver type.
size_t m_np
Number of sensitivity parameters.
void * m_linsol_matrix
matrix used by Sundials
N_Vector m_ydot
The time derivatives of the system state.
N_Vector * m_ySdot
Sensitivities of ydot, size m_np by m_neq.
double m_tInteg
The latest time reached by the integrator. May be greater than m_time.
void initialize(double t0, FuncEval &func) override
Initialize the integrator for a new problem.
int m_maxsteps
Maximum number of internal steps taken in a call to integrate()
string getErrorInfo(int N)
Returns a string listing the weighted error estimates associated with each solution component.
IdasIntegrator()
Constructor.
void setMethod(MethodType t) override
Set the solution method.
void * m_ida_mem
Pointer to the IDA memory for the problem.
bool m_setSuppressAlg
If true, the algebraic variables don't contribute to error tolerances.
N_Vector m_abstol
Absolute tolerances for each state variable.
virtual string linearSolverType() const
Return the integrator problem type.
virtual int lastOrder() const
Order used during the last solution step.
A wrapper for managing a SUNContext object.
Namespace for the Cantera kernel.
static int ida_rhs(sunrealtype t, N_Vector y, N_Vector ydot, N_Vector r, void *f_data)
Function called by IDA to evaluate the residual, given y and ydot.
static void ida_err(int error_code, const char *module, const char *function, char *msg, void *eh_data)
Function called by IDA when an error is encountered instead of writing to stdout.
MethodType
Specifies the method used to integrate the system of equations.
@ BDF_Method
Backward Differentiation.
Contains declarations for string manipulation functions within Cantera.