diff --git a/include/amici/abstract_model.h b/include/amici/abstract_model.h index 35846ec0e3..9466ffac7f 100644 --- a/include/amici/abstract_model.h +++ b/include/amici/abstract_model.h @@ -101,7 +101,7 @@ class AbstractModel { * @param dxB Vector with the adjoint derivative states * @param xBdot Vector with the adjoint state right hand side */ - virtual void writeSteadystateJB( + virtual void write_steady_state_JB( realtype t, realtype cj, AmiVector const& x, AmiVector const& dx, AmiVector const& xB, AmiVector const& dxB, AmiVector const& xBdot ) = 0; diff --git a/include/amici/edata.h b/include/amici/edata.h index 845bcbbfa0..f060c917f0 100644 --- a/include/amici/edata.h +++ b/include/amici/edata.h @@ -507,7 +507,7 @@ inline bool operator==(ExpData const& lhs, ExpData const& rhs) { * @param sigmaVector vector input to be checked * @param vectorName name of the input */ -void checkSigmaPositivity( +void check_sigma_positivity( std::vector const& sigmaVector, char const* vectorName ); @@ -517,7 +517,7 @@ void checkSigmaPositivity( * @param sigma input to be checked * @param sigmaName name of the input */ -void checkSigmaPositivity(realtype sigma, char const* sigmaName); +void check_sigma_positivity(realtype sigma, char const* sigmaName); /** * @brief The ConditionContext class applies condition-specific amici::Model diff --git a/include/amici/model_dae.h b/include/amici/model_dae.h index b3407a0d95..66f6559a1d 100644 --- a/include/amici/model_dae.h +++ b/include/amici/model_dae.h @@ -284,7 +284,7 @@ class Model_DAE : public Model { * @param dxB Vector with the adjoint derivative states * @param xBdot Vector with the adjoint state right hand side */ - void writeSteadystateJB( + void write_steady_state_JB( realtype t, realtype cj, AmiVector const& x, AmiVector const& dx, AmiVector const& xB, AmiVector const& dxB, AmiVector const& xBdot ) override; diff --git a/include/amici/model_ode.h b/include/amici/model_ode.h index 6866d68e8d..b3cb844cd8 100644 --- a/include/amici/model_ode.h +++ b/include/amici/model_ode.h @@ -254,7 +254,7 @@ class Model_ODE : public Model { * @param dxB Vector with the adjoint derivative states * @param xBdot Vector with the adjoint state right hand side */ - void writeSteadystateJB( + void write_steady_state_JB( realtype t, realtype cj, AmiVector const& x, AmiVector const& dx, AmiVector const& xB, AmiVector const& dxB, AmiVector const& xBdot ) override; diff --git a/include/amici/rdata.h b/include/amici/rdata.h index 881e6fdf6e..28923a6db3 100644 --- a/include/amici/rdata.h +++ b/include/amici/rdata.h @@ -546,7 +546,7 @@ class ReturnData : public ModelDimensions { * @param quadratic_llh whether model defines a quadratic nllh and computing * res, sres and FIM makes sense. */ - void initializeObservablesLikelihoodReporting(bool quadratic_llh); + void initialize_observables_likelihood_reporting(bool quadratic_llh); /** * @brief initializes storage for residual reporting mode diff --git a/src/edata.cpp b/src/edata.cpp index 2139d3cc33..d626deaa20 100644 --- a/src/edata.cpp +++ b/src/edata.cpp @@ -103,8 +103,8 @@ ExpData::ExpData( realtype sigma; - checkSigmaPositivity(sigma_y, "sigma_y"); - checkSigmaPositivity(sigma_z, "sigma_z"); + check_sigma_positivity(sigma_y, "sigma_y"); + check_sigma_positivity(sigma_z, "sigma_z"); for (int iy = 0; iy < nytrue_; ++iy) { for (int it = 0; it < nt(); ++it) { @@ -195,7 +195,7 @@ void ExpData::set_observed_data_std_dev( std::vector const& observedDataStdDev ) { check_data_dimension(observedDataStdDev, "observedDataStdDev"); - checkSigmaPositivity(observedDataStdDev, "observedDataStdDev"); + check_sigma_positivity(observedDataStdDev, "observedDataStdDev"); if (observedDataStdDev.size() == static_cast(nt()) * nytrue_) observed_data_std_dev_ = observedDataStdDev; @@ -204,7 +204,7 @@ void ExpData::set_observed_data_std_dev( } void ExpData::set_observed_data_std_dev(realtype const stdDev) { - checkSigmaPositivity(stdDev, "stdDev"); + check_sigma_positivity(stdDev, "stdDev"); std::ranges::fill(observed_data_std_dev_, stdDev); } @@ -216,7 +216,7 @@ void ExpData::set_observed_data_std_dev( "Input observedDataStdDev did not match dimensions nt (%i), was %i", nt(), observedDataStdDev.size() ); - checkSigmaPositivity(observedDataStdDev, "observedDataStdDev"); + check_sigma_positivity(observedDataStdDev, "observedDataStdDev"); for (int it = 0; it < nt(); ++it) observed_data_std_dev_.at(iy + it * nytrue_) @@ -224,7 +224,7 @@ void ExpData::set_observed_data_std_dev( } void ExpData::set_observed_data_std_dev(realtype const stdDev, int const iy) { - checkSigmaPositivity(stdDev, "stdDev"); + check_sigma_positivity(stdDev, "stdDev"); for (int it = 0; it < nt(); ++it) observed_data_std_dev_.at(iy + it * nytrue_) = stdDev; } @@ -289,7 +289,7 @@ void ExpData::set_observed_events_std_dev( std::vector const& observedEventsStdDev ) { check_events_dimension(observedEventsStdDev, "observedEventsStdDev"); - checkSigmaPositivity(observedEventsStdDev, "observedEventsStdDev"); + check_sigma_positivity(observedEventsStdDev, "observedEventsStdDev"); if (observedEventsStdDev.size() == (unsigned)nmaxevent_ * nztrue_) observed_events_std_dev_ = observedEventsStdDev; @@ -298,7 +298,7 @@ void ExpData::set_observed_events_std_dev( } void ExpData::set_observed_events_std_dev(realtype const stdDev) { - checkSigmaPositivity(stdDev, "stdDev"); + check_sigma_positivity(stdDev, "stdDev"); std::ranges::fill(observed_events_std_dev_, stdDev); } @@ -311,7 +311,7 @@ void ExpData::set_observed_events_std_dev( "(%i), was %i", nmaxevent_, observedEventsStdDev.size() ); - checkSigmaPositivity(observedEventsStdDev, "observedEventsStdDev"); + check_sigma_positivity(observedEventsStdDev, "observedEventsStdDev"); for (int ie = 0; ie < nmaxevent_; ++ie) observed_events_std_dev_.at(iz + ie * nztrue_) @@ -319,7 +319,7 @@ void ExpData::set_observed_events_std_dev( } void ExpData::set_observed_events_std_dev(realtype const stdDev, int const iz) { - checkSigmaPositivity(stdDev, "stdDev"); + check_sigma_positivity(stdDev, "stdDev"); for (int ie = 0; ie < nmaxevent_; ++ie) observed_events_std_dev_.at(iz + ie * nztrue_) = stdDev; @@ -386,14 +386,14 @@ void ExpData::check_events_dimension( ); } -void checkSigmaPositivity( +void check_sigma_positivity( std::vector const& sigmaVector, char const* vectorName ) { for (auto&& sigma : sigmaVector) - checkSigmaPositivity(sigma, vectorName); + check_sigma_positivity(sigma, vectorName); } -void checkSigmaPositivity(realtype const sigma, char const* sigmaName) { +void check_sigma_positivity(realtype const sigma, char const* sigmaName) { if (sigma <= 0.0) throw AmiException( "Encountered sigma <= 0 in %s! value: %f", sigmaName, sigma diff --git a/src/hdf5.cpp b/src/hdf5.cpp index 5034f0927d..9c40d5a4a3 100644 --- a/src/hdf5.cpp +++ b/src/hdf5.cpp @@ -25,7 +25,7 @@ namespace amici::hdf5 { * @param n * @param model */ -void checkMeasurementDimensionsCompatible( +void check_measurement_dimensions_compatible( hsize_t const m, hsize_t const n, Model const& model ) { bool compatible = true; @@ -54,7 +54,7 @@ void checkMeasurementDimensionsCompatible( * @param n * @param model */ -void checkEventDimensionsCompatible( +void check_event_dimensions_compatible( hsize_t const m, hsize_t const n, Model const& model ) { bool compatible = true; @@ -126,7 +126,7 @@ std::unique_ptr read_exp_data_from_hdf5( if (model.ny * model.nt() > 0) { if (location_exists(file, hdf5Root + "/Y")) { auto const my = get_double_2d_dataset(file, hdf5Root + "/Y", m, n); - checkMeasurementDimensionsCompatible(m, n, model); + check_measurement_dimensions_compatible(m, n, model); edata->set_observed_data(my); } else { throw AmiException( @@ -137,7 +137,7 @@ std::unique_ptr read_exp_data_from_hdf5( if (location_exists(file, hdf5Root + "/Sigma_Y")) { auto const sigmay = get_double_2d_dataset(file, hdf5Root + "/Sigma_Y", m, n); - checkMeasurementDimensionsCompatible(m, n, model); + check_measurement_dimensions_compatible(m, n, model); edata->set_observed_data_std_dev(sigmay); } else { throw AmiException( @@ -150,7 +150,7 @@ std::unique_ptr read_exp_data_from_hdf5( if (model.nz * model.n_max_event() > 0) { if (location_exists(file, hdf5Root + "/Z")) { auto const mz = get_double_2d_dataset(file, hdf5Root + "/Z", m, n); - checkEventDimensionsCompatible(m, n, model); + check_event_dimensions_compatible(m, n, model); edata->set_observed_events(mz); } else { throw AmiException( @@ -161,7 +161,7 @@ std::unique_ptr read_exp_data_from_hdf5( if (location_exists(file, hdf5Root + "/Sigma_Z")) { auto sigmaz = get_double_2d_dataset(file, hdf5Root + "/Sigma_Z", m, n); - checkEventDimensionsCompatible(m, n, model); + check_event_dimensions_compatible(m, n, model); edata->set_observed_events_std_dev(sigmaz); } else { throw AmiException( diff --git a/src/model.cpp b/src/model.cpp index fc0a67108b..398a24342d 100644 --- a/src/model.cpp +++ b/src/model.cpp @@ -76,7 +76,7 @@ std::map const model_quantity_to_str{ }; -static void setNaNtoZero(std::vector& vec) { +static void set_nan_to_zero(std::vector& vec) { std::ranges::for_each(vec, [](double& val) { if (std::isnan(val)) { val = 0.0; @@ -93,7 +93,7 @@ static void setNaNtoZero(std::vector& vec) { * @param id_name string indicating whether name or id was specified * @return value of the selected parameter */ -static realtype getValueById( +static realtype get_value_by_id( std::vector const& ids, std::vector const& values, std::string const& id, char const* variable_name, char const* id_name ) { @@ -115,7 +115,7 @@ static realtype getValueById( * @param variable_name string indicating what variable we are looking at * @param id_name string indicating whether name or id was specified */ -static void setValueById( +static void set_value_by_id( std::vector const& ids, std::vector& values, realtype const value, std::string const& id, char const* variable_name, char const* id_name @@ -140,7 +140,7 @@ static void setValueById( * @return number of matched names/ids */ -static int setValueByIdRegex( +static int set_value_by_id_regex( std::vector const& ids, std::vector& values, realtype value, std::string const& regex, char const* variable_name, char const* id_name @@ -534,7 +534,7 @@ realtype Model::get_parameter_by_id(std::string const& par_id) const { throw AmiException( "Could not access parameters by id as they are not set" ); - return getValueById( + return get_value_by_id( get_parameter_ids(), simulation_parameters_.parameters, par_id, "parameters", "id" ); @@ -545,7 +545,7 @@ realtype Model::get_parameter_by_name(std::string const& par_name) const { throw AmiException( "Could not access parameters by name as they are not set" ); - return getValueById( + return get_value_by_id( get_parameter_names(), simulation_parameters_.parameters, par_name, "parameters", "name" ); @@ -586,7 +586,7 @@ void Model::set_parameter_by_id( "Could not access parameters by id as they are not set" ); - setValueById( + set_value_by_id( get_parameter_ids(), simulation_parameters_.parameters, value, par_id, "parameter", "id" ); @@ -603,7 +603,7 @@ int Model::set_parameters_by_id_regex( throw AmiException( "Could not access parameters by id as they are not set" ); - int n_found = setValueByIdRegex( + int n_found = set_value_by_id_regex( get_parameter_ids(), simulation_parameters_.parameters, value, par_id_regex, "parameter", "id" ); @@ -622,7 +622,7 @@ void Model::set_parameter_by_name( "Could not access parameters by name as they are not set" ); - setValueById( + set_value_by_id( get_parameter_names(), simulation_parameters_.parameters, value, par_name, "parameter", "name" ); @@ -653,7 +653,7 @@ int Model::set_parameters_by_name_regex( "Could not access parameters by name as they are not set" ); - int n_found = setValueByIdRegex( + int n_found = set_value_by_id_regex( get_parameter_names(), simulation_parameters_.parameters, value, par_name_regex, "parameter", "name" ); @@ -675,7 +675,7 @@ realtype Model::get_fixed_parameter_by_id(std::string const& par_id) const { "Could not access fixed parameters by id as they are not set" ); - return getValueById( + return get_value_by_id( get_fixed_parameter_ids(), state_.fixed_parameters, par_id, "fixedParameters", "id" ); @@ -687,7 +687,7 @@ realtype Model::get_fixed_parameter_by_name(std::string const& par_name) const { "Could not access fixed parameters by name as they are not set" ); - return getValueById( + return get_value_by_id( get_fixed_parameter_names(), state_.fixed_parameters, par_name, "fixedParameters", "name" ); @@ -710,7 +710,7 @@ void Model::set_fixed_parameter_by_id( "Could not access fixed parameters by id as they are not set" ); - setValueById( + set_value_by_id( get_fixed_parameter_ids(), state_.fixed_parameters, value, par_id, "fixedParameters", "id" ); @@ -724,7 +724,7 @@ int Model::set_fixed_parameters_by_id_regex( "Could not access fixed parameters by id as they are not set" ); - return setValueByIdRegex( + return set_value_by_id_regex( get_fixed_parameter_ids(), state_.fixed_parameters, value, par_id_regex, "fixedParameters", "id" ); @@ -738,7 +738,7 @@ void Model::set_fixed_parameter_by_name( "Could not access fixed parameters by name as they are not set" ); - setValueById( + set_value_by_id( get_fixed_parameter_names(), state_.fixed_parameters, value, par_name, "fixedParameters", "name" ); @@ -752,7 +752,7 @@ int Model::set_fixed_parameters_by_name_regex( "Could not access fixed parameters by name as they are not set" ); - return setValueByIdRegex( + return set_value_by_id_regex( get_fixed_parameter_ids(), state_.fixed_parameters, value, par_name_regex, "fixedParameters", "name" ); @@ -1113,8 +1113,8 @@ void Model::get_observable_sensitivity( // lda ldb ldc if (nx_solver) { - setNaNtoZero(derived_state_.dydx_); - setNaNtoZero(derived_state_.sx_); + set_nan_to_zero(derived_state_.dydx_); + set_nan_to_zero(derived_state_.sx_); amici_dgemm( BLASLayout::colMajor, BLASTranspose::noTrans, BLASTranspose::noTrans, ny, nplist(), nx_solver, 1.0, @@ -1151,9 +1151,9 @@ void Model::get_observable_sigma_sensitivity( // dsigmaydp C[ny,nplist] += dsigmaydy A[ny,ny] * sy B[ny,nplist] // M N M K K N // ldc lda ldb - setNaNtoZero(derived_state_.dsigmaydy_); + set_nan_to_zero(derived_state_.dsigmaydy_); derived_state_.sy_.assign(sy.begin(), sy.end()); - setNaNtoZero(derived_state_.sy_); + set_nan_to_zero(derived_state_.sy_); amici_dgemm( BLASLayout::colMajor, BLASTranspose::noTrans, BLASTranspose::noTrans, ny, nplist(), ny, 1.0, derived_state_.dsigmaydy_.data(), ny, @@ -1199,8 +1199,8 @@ void Model::add_observable_objective_sensitivity( sx.flatten_to_vector(derived_state_.sx_); // C := alpha*op(A)*op(B) + beta*C, - setNaNtoZero(derived_state_.dJydx_); - setNaNtoZero(derived_state_.sx_); + set_nan_to_zero(derived_state_.dJydx_); + set_nan_to_zero(derived_state_.sx_); amici_dgemm( BLASLayout::colMajor, BLASTranspose::noTrans, BLASTranspose::noTrans, nJ, nplist(), nx_solver, 1.0, derived_state_.dJydx_.data(), nJ, @@ -1255,8 +1255,8 @@ void Model::get_event_sensitivity( // dzdx A[nz,nx_solver] * sx B[nx_solver,nplist] = sz C[nz,nplist] // M K K N M N // lda ldb ldc - setNaNtoZero(derived_state_.dzdx_); - setNaNtoZero(derived_state_.sx_); + set_nan_to_zero(derived_state_.dzdx_); + set_nan_to_zero(derived_state_.sx_); amici_dgemm( BLASLayout::colMajor, BLASTranspose::noTrans, BLASTranspose::noTrans, nz, nplist(), nx_solver, 1.0, derived_state_.dzdx_.data(), nz, @@ -1306,8 +1306,8 @@ void Model::get_event_regularization_sensitivity( // drzdx A[nz,nx_solver] * sx B[nx_solver,nplist] = srz C[nz,nplist] // M K K N M N // lda ldb ldc - setNaNtoZero(derived_state_.drzdx_); - setNaNtoZero(derived_state_.sx_); + set_nan_to_zero(derived_state_.drzdx_); + set_nan_to_zero(derived_state_.sx_); amici_dgemm( BLASLayout::colMajor, BLASTranspose::noTrans, BLASTranspose::noTrans, nz, nplist(), nx_solver, 1.0, derived_state_.drzdx_.data(), nz, @@ -1401,8 +1401,8 @@ void Model::add_event_objective_sensitivity( sx.flatten_to_vector(derived_state_.sx_); // C := alpha*op(A)*op(B) + beta*C, - setNaNtoZero(derived_state_.dJzdx_); - setNaNtoZero(derived_state_.sx_); + set_nan_to_zero(derived_state_.dJzdx_); + set_nan_to_zero(derived_state_.sx_); amici_dgemm( BLASLayout::colMajor, BLASTranspose::noTrans, BLASTranspose::noTrans, nJ, nplist(), nx_solver, 1.0, derived_state_.dJzdx_.data(), nJ, @@ -2139,7 +2139,7 @@ void Model::fsigmay(int const it, ExpData const* edata) { std::stringstream ss; ss << "sigmay (" << obs_id << ", ExpData::id=" << edata->id << ", t=" << get_timepoint(it) << ")"; - checkSigmaPositivity( + check_sigma_positivity( derived_state_.sigmay_.at(iytrue), ss.str().c_str() ); } @@ -2220,8 +2220,8 @@ void Model::fdJydy(int const it, AmiVector const& x, ExpData const& edata) { fdJydsigma(it, x, edata); fdsigmaydy(it, &edata); - setNaNtoZero(derived_state_.dJydsigma_); - setNaNtoZero(derived_state_.dsigmaydy_); + set_nan_to_zero(derived_state_.dJydsigma_); + set_nan_to_zero(derived_state_.dsigmaydy_); for (int iyt = 0; iyt < nytrue; iyt++) { if (!derived_state_.dJydy_.at(iyt).capacity()) continue; @@ -2317,8 +2317,8 @@ void Model::fdJydp(int const it, AmiVector const& x, ExpData const& edata) { fdJydsigma(it, x, edata); fdsigmaydp(it, &edata); - setNaNtoZero(derived_state_.dJydsigma_); - setNaNtoZero(derived_state_.dsigmaydp_); + set_nan_to_zero(derived_state_.dJydsigma_); + set_nan_to_zero(derived_state_.dsigmaydp_); for (int iyt = 0; iyt < nytrue; ++iyt) { if (!edata.is_set_observed_data(it, iyt)) continue; @@ -2495,7 +2495,7 @@ void Model::fsigmaz( derived_state_.sigmaz_.at(iztrue + iJ * nztrue) = 0; if (edata->is_set_observed_events(nroots, iztrue)) - checkSigmaPositivity( + check_sigma_positivity( derived_state_.sigmaz_.at(iztrue), "sigmaz" ); } @@ -2625,12 +2625,12 @@ void Model::fdJzdp( fdJzdsigma(ie, nroots, t, x, edata); fdJrzdsigma(ie, nroots, t, x, edata); - setNaNtoZero(derived_state_.dzdp_); - setNaNtoZero(derived_state_.dsigmazdp_); - setNaNtoZero(derived_state_.dJzdz_); - setNaNtoZero(derived_state_.dJrzdz_); - setNaNtoZero(derived_state_.dJzdsigma_); - setNaNtoZero(derived_state_.dJrzdsigma_); + set_nan_to_zero(derived_state_.dzdp_); + set_nan_to_zero(derived_state_.dsigmazdp_); + set_nan_to_zero(derived_state_.dJzdz_); + set_nan_to_zero(derived_state_.dJrzdz_); + set_nan_to_zero(derived_state_.dJzdsigma_); + set_nan_to_zero(derived_state_.dJrzdsigma_); for (int izt = 0; izt < nztrue; ++izt) { if (!edata.is_set_observed_events(nroots, izt)) continue; @@ -2690,10 +2690,10 @@ void Model::fdJzdx( fdzdx(ie, t, x); fdrzdx(ie, t, x); - setNaNtoZero(derived_state_.dJzdz_); - setNaNtoZero(derived_state_.dJrzdz_); - setNaNtoZero(derived_state_.dzdx_); - setNaNtoZero(derived_state_.drzdx_); + set_nan_to_zero(derived_state_.dJzdz_); + set_nan_to_zero(derived_state_.dJrzdz_); + set_nan_to_zero(derived_state_.dzdx_); + set_nan_to_zero(derived_state_.drzdx_); for (int izt = 0; izt < nztrue; ++izt) { if (!edata.is_set_observed_events(nroots, izt)) diff --git a/src/model_dae.cpp b/src/model_dae.cpp index 601640d430..94b5a8f300 100644 --- a/src/model_dae.cpp +++ b/src/model_dae.cpp @@ -448,7 +448,7 @@ void Model_DAE::fJSparseB_ss(SUNMatrix JB) { derived_state_.JB_.refresh(); } -void Model_DAE::writeSteadystateJB( +void Model_DAE::write_steady_state_JB( realtype const t, realtype cj, AmiVector const& x, AmiVector const& dx, AmiVector const& xB, AmiVector const& dxB, AmiVector const& /*xBdot*/ ) { diff --git a/src/model_ode.cpp b/src/model_ode.cpp index f4132f5780..46fde9a726 100644 --- a/src/model_ode.cpp +++ b/src/model_ode.cpp @@ -398,7 +398,7 @@ void Model_ODE::fJSparseB_ss(SUNMatrix JB) { derived_state_.JB_.refresh(); } -void Model_ODE::writeSteadystateJB( +void Model_ODE::write_steady_state_JB( realtype const t, realtype /*cj*/, AmiVector const& x, AmiVector const& /*dx*/, AmiVector const& xB, AmiVector const& /*dxB*/, AmiVector const& xBdot diff --git a/src/rdata.cpp b/src/rdata.cpp index e76cabc88f..3ad5b7f2b5 100644 --- a/src/rdata.cpp +++ b/src/rdata.cpp @@ -67,7 +67,7 @@ ReturnData::ReturnData( break; case RDataReporting::observables_likelihood: - initializeObservablesLikelihoodReporting(quadratic_llh_); + initialize_observables_likelihood_reporting(quadratic_llh_); break; } } @@ -88,7 +88,7 @@ void ReturnData::initialize_likelihood_reporting(bool enable_fim) { } } -void ReturnData::initializeObservablesLikelihoodReporting(bool enable_fim) { +void ReturnData::initialize_observables_likelihood_reporting(bool enable_fim) { initialize_likelihood_reporting(enable_fim); y.resize(nt * ny, 0.0); diff --git a/src/solver.cpp b/src/solver.cpp index 6608bcc92e..a53b3d4ed2 100644 --- a/src/solver.cpp +++ b/src/solver.cpp @@ -311,7 +311,7 @@ void Solver::setup_steady_state( ); /* Set Jacobian function and initialize values */ set_sparse_jac_fn_ss(); - model->writeSteadystateJB(t0, 0, x0, dx0, xB0, dxB0, xB0); + model->write_steady_state_JB(t0, 0, x0, dx0, xB0, dxB0, xB0); } void Solver::update_and_reinit_states_and_sensitivities(Model* model) const { diff --git a/swig/abstract_model.i b/swig/abstract_model.i index 7189a23dfa..54a2b9c336 100644 --- a/swig/abstract_model.i +++ b/swig/abstract_model.i @@ -8,7 +8,7 @@ %ignore fJSparseB; %ignore fxBdot_ss; %ignore fJSparseB_ss; -%ignore writeSteadystateJB; +%ignore write_steady_state_JB; %ignore fdx0; %ignore fdxdotdp; %ignore froot; diff --git a/tests/cpp/testfunctions.h b/tests/cpp/testfunctions.h index ece3249d0f..fea4ad0726 100644 --- a/tests/cpp/testfunctions.h +++ b/tests/cpp/testfunctions.h @@ -139,7 +139,7 @@ class Model_Test : public Model { throw AmiException("not implemented"); } - void writeSteadystateJB( + void write_steady_state_JB( realtype const /*t*/, realtype /*cj*/, AmiVector const& /*x*/, AmiVector const& /*dx*/, AmiVector const& /*xB*/, AmiVector const& /*dxB*/, AmiVector const& /*xBdot*/