![]() |
|
#include <ode_problem.h>
Public Member Functions | |
ODEProblem () | |
constructor More... | |
virtual | ~ODEProblem () |
virtual void | build (Vector< Mesh * > &bulk_mesh_pt) |
Perform set up of problem. More... | |
void | my_set_initial_condition (const SolutionFunctorBase &ic) |
Assign initial conditions from function pointer. More... | |
virtual void | write_additional_trace_headers (std::ofstream &trace_file) const |
virtual void | write_additional_trace_data (const unsigned &t_hist, std::ofstream &trace_file) const |
virtual double | get_error_norm (const unsigned &t_hist=0) const |
Error norm calculator. More... | |
Vector< double > | exact_solution (const double &time) const |
double | global_temporal_error_norm () |
Error norm: use abs(error in data). More... | |
Vector< double > | trace_values (const unsigned &t_hist=0) const |
ODEElement * | element_pt () |
const ODEElement * | element_pt () const |
TimeStepper * | ts_pt () const |
unsigned | nvalue () const |
void | output_solution (const unsigned &t, std::ostream &outstream, const unsigned &npoints=2) const |
Vector< double > | solution (const unsigned ×tep=0) const |
![]() | |
MyProblem () | |
Default constructor. More... | |
virtual | ~MyProblem () |
double | smart_time_step (double dt, const double &tol) |
virtual bool | finished () const |
void | get_solver_parameters (SolverParameters &sp) |
void | set_solver_parameters (SolverParameters &sp) |
bool | explicit_flag () |
bool | is_steady () |
virtual void | actions_before_newton_step () |
unsigned | nnewton_step_this_solve () const |
virtual void | actions_before_explicit_stage () |
virtual void | actions_after_explicit_stage () |
virtual void | actions_before_time_integration () |
virtual void | actions_before_explicit_timestep () |
Actions that should be performed before each explicit time step. More... | |
virtual void | actions_after_explicit_timestep () |
Actions that should be performed after each explicit time step. More... | |
virtual void | actions_after_implicit_timestep () |
virtual void | actions_before_implicit_timestep () |
virtual void | actions_after_newton_step () |
virtual void | actions_before_newton_solve () |
void | segregated_pin_indices (const Vector< unsigned > &indices) |
void | undo_segregated_pinning () |
Remove pinning set up by segregated_pin_indices. More... | |
void | check_not_segregated (const char *function) const |
Check that nothing is currently pinned for a segregated solve. More... | |
void | check_norm_limits () |
double | min_element_size () |
??ds More... | |
void | write_trace (const unsigned &t_hist=0) |
virtual void | output_solution (std::ofstream &soln_file) const |
Overload to write any problem specific data. More... | |
virtual void | final_doc_additional () const |
virtual void | initial_doc_additional () const |
void | initial_doc () |
void | final_doc () |
void | doc_solution (const unsigned &t_hist=0, const std::string &prefix="") |
virtual void | doc_boundaries (const std::string &boundary_file_basename) const |
Output nodes with boundary number to csv file. More... | |
void | output_solution (std::ostream &outstream, const unsigned &npoints=2) const |
virtual void | output_exact_solution (const unsigned &t_hist, std::ostream &outstream, const unsigned &npoints=2) const |
virtual double | get_solution_norm (const unsigned &t_hist=0) const |
Dummy solution norm calculator (overload in derived classes). More... | |
virtual bool | should_doc_this_step (const double &dt, const double &time) const |
void | set_doc_times (Vector< double > &doc_times) |
Assign a vector of times to output the full solution at. More... | |
double | lte_norm () |
bool | doc_exact () const |
void | dump_current_mm_or_jacobian_residuals (const std::string &label) |
IterativeLinearSolver * | iterative_linear_solver_pt () const |
const unsigned | dim () const |
Get problem dimension (nodal dimension). More... | |
virtual std::string | problem_name () const |
virtual void | set_up_impulsive_initial_condition () |
Set all history values/dts to be the same as the present values/dt. More... | |
virtual void | actions_after_set_initial_condition () |
virtual double | integrate_over_problem (const ElementalFunction *func_pt, const Integral *quadrature_pt=0) const |
virtual void | dump (std::ofstream &dump_file) const |
virtual void | read (std::ifstream &restart_file) |
void | output_ltes (const unsigned &t_hist, std::ostream &output) const |
Vector< double > | exact_solution (const double &t, const Vector< double > &x) const |
Get exact solution. More... | |
![]() | |
virtual void | debug_hook_fct (const unsigned &i) |
void | set_analytic_dparameter (double *const ¶meter_pt) |
void | unset_analytic_dparameter (double *const ¶meter_pt) |
bool | is_dparameter_calculated_analytically (double *const ¶meter_pt) |
void | set_analytic_hessian_products () |
void | unset_analytic_hessian_products () |
bool | are_hessian_products_calculated_analytically () |
void | set_pinned_values_to_zero () |
bool | distributed () const |
virtual void | actions_before_adapt () |
virtual void | actions_after_adapt () |
Actions that are to be performed after a mesh adaptation. More... | |
OomphCommunicator * | communicator_pt () |
access function to the oomph-lib communicator More... | |
const OomphCommunicator * | communicator_pt () const |
access function to the oomph-lib communicator, const version More... | |
Problem () | |
Problem (const Problem &dummy)=delete | |
Broken copy constructor. More... | |
void | operator= (const Problem &)=delete |
Broken assignment operator. More... | |
virtual | ~Problem () |
Virtual destructor to clean up memory. More... | |
Mesh *& | mesh_pt () |
Return a pointer to the global mesh. More... | |
Mesh *const & | mesh_pt () const |
Return a pointer to the global mesh (const version) More... | |
Mesh *& | mesh_pt (const unsigned &imesh) |
Mesh *const & | mesh_pt (const unsigned &imesh) const |
Return a pointer to the i-th submesh (const version) More... | |
unsigned | nsub_mesh () const |
Return number of submeshes. More... | |
unsigned | add_sub_mesh (Mesh *const &mesh_pt) |
void | flush_sub_meshes () |
void | build_global_mesh () |
void | rebuild_global_mesh () |
LinearSolver *& | linear_solver_pt () |
Return a pointer to the linear solver object. More... | |
LinearSolver *const & | linear_solver_pt () const |
Return a pointer to the linear solver object (const version) More... | |
LinearSolver *& | mass_matrix_solver_for_explicit_timestepper_pt () |
LinearSolver * | mass_matrix_solver_for_explicit_timestepper_pt () const |
EigenSolver *& | eigen_solver_pt () |
Return a pointer to the eigen solver object. More... | |
EigenSolver *const & | eigen_solver_pt () const |
Return a pointer to the eigen solver object (const version) More... | |
Time *& | time_pt () |
Return a pointer to the global time object. More... | |
Time * | time_pt () const |
Return a pointer to the global time object (const version). More... | |
double & | time () |
Return the current value of continuous time. More... | |
double | time () const |
Return the current value of continuous time (const version) More... | |
TimeStepper *& | time_stepper_pt () |
const TimeStepper * | time_stepper_pt () const |
TimeStepper *& | time_stepper_pt (const unsigned &i) |
Return a pointer to the i-th timestepper. More... | |
ExplicitTimeStepper *& | explicit_time_stepper_pt () |
Return a pointer to the explicit timestepper. More... | |
unsigned long | set_timestepper_for_all_data (TimeStepper *const &time_stepper_pt, const bool &preserve_existing_data=false) |
virtual void | shift_time_values () |
Shift all values along to prepare for next timestep. More... | |
AssemblyHandler *& | assembly_handler_pt () |
Return a pointer to the assembly handler object. More... | |
AssemblyHandler *const & | assembly_handler_pt () const |
Return a pointer to the assembly handler object (const version) More... | |
double & | minimum_dt () |
Access function to min timestep in adaptive timestepping. More... | |
double & | maximum_dt () |
Access function to max timestep in adaptive timestepping. More... | |
unsigned & | max_newton_iterations () |
Access function to max Newton iterations before giving up. More... | |
void | problem_is_nonlinear (const bool &prob_lin) |
Access function to Problem_is_nonlinear. More... | |
double & | max_residuals () |
bool & | time_adaptive_newton_crash_on_solve_fail () |
Access function for Time_adaptive_newton_crash_on_solve_fail. More... | |
double & | newton_solver_tolerance () |
void | add_time_stepper_pt (TimeStepper *const &time_stepper_pt) |
void | set_explicit_time_stepper_pt (ExplicitTimeStepper *const &explicit_time_stepper_pt) |
void | initialise_dt (const double &dt) |
void | initialise_dt (const Vector< double > &dt) |
Data *& | global_data_pt (const unsigned &i) |
Return a pointer to the the i-th global data object. More... | |
void | add_global_data (Data *const &global_data_pt) |
void | flush_global_data () |
LinearAlgebraDistribution *const & | dof_distribution_pt () const |
Return the pointer to the dof distribution (read-only) More... | |
unsigned long | ndof () const |
Return the number of dofs. More... | |
unsigned | ntime_stepper () const |
Return the number of time steppers. More... | |
unsigned | nglobal_data () const |
Return the number of global data values. More... | |
unsigned | self_test () |
Self-test: Check meshes and global data. Return 0 for OK. More... | |
void | enable_store_local_dof_pt_in_elements () |
void | disable_store_local_dof_pt_in_elements () |
unsigned long | assign_eqn_numbers (const bool &assign_local_eqn_numbers=true) |
void | describe_dofs (std::ostream &out= *(oomph_info.stream_pt())) const |
void | enable_discontinuous_formulation () |
void | disable_discontinuous_formulation () |
void | get_dofs (DoubleVector &dofs) const |
void | get_dofs (const unsigned &t, DoubleVector &dofs) const |
Return vector of the t'th history value of all dofs. More... | |
void | set_dofs (const DoubleVector &dofs) |
Set the values of the dofs. More... | |
void | set_dofs (const unsigned &t, DoubleVector &dofs) |
Set the history values of the dofs. More... | |
void | set_dofs (const unsigned &t, Vector< double * > &dof_pt) |
void | add_to_dofs (const double &lambda, const DoubleVector &increment_dofs) |
Add lambda x incremenet_dofs[l] to the l-th dof. More... | |
double * | global_dof_pt (const unsigned &i) |
double & | dof (const unsigned &i) |
i-th dof in the problem More... | |
double | dof (const unsigned &i) const |
i-th dof in the problem (const version) More... | |
double *& | dof_pt (const unsigned &i) |
Pointer to i-th dof in the problem. More... | |
double * | dof_pt (const unsigned &i) const |
Pointer to i-th dof in the problem (const version) More... | |
virtual void | get_inverse_mass_matrix_times_residuals (DoubleVector &Mres) |
virtual void | get_dvaluesdt (DoubleVector &f) |
virtual void | get_residuals (DoubleVector &residuals) |
Get the total residuals Vector for the problem. More... | |
virtual void | get_jacobian (DoubleVector &residuals, DenseDoubleMatrix &jacobian) |
virtual void | get_jacobian (DoubleVector &residuals, CRDoubleMatrix &jacobian) |
virtual void | get_jacobian (DoubleVector &residuals, CCDoubleMatrix &jacobian) |
virtual void | get_jacobian (DoubleVector &residuals, SumOfMatrices &jacobian) |
void | get_fd_jacobian (DoubleVector &residuals, DenseMatrix< double > &jacobian) |
Get the full Jacobian by finite differencing. More... | |
void | get_derivative_wrt_global_parameter (double *const ¶meter_pt, DoubleVector &result) |
void | get_hessian_vector_products (DoubleVectorWithHaloEntries const &Y, Vector< DoubleVectorWithHaloEntries > const &C, Vector< DoubleVectorWithHaloEntries > &product) |
void | solve_eigenproblem (const unsigned &n_eval, Vector< std::complex< double >> &eigenvalue, Vector< DoubleVector > &eigenvector, const bool &steady=true) |
Solve the eigenproblem. More... | |
void | solve_eigenproblem (const unsigned &n_eval, Vector< std::complex< double >> &eigenvalue, const bool &steady=true) |
virtual void | get_eigenproblem_matrices (CRDoubleMatrix &mass_matrix, CRDoubleMatrix &main_matrix, const double &shift=0.0) |
void | assign_eigenvector_to_dofs (DoubleVector &eigenvector) |
Assign the eigenvector passed to the function to the dofs. More... | |
void | add_eigenvector_to_dofs (const double &epsilon, const DoubleVector &eigenvector) |
void | store_current_dof_values () |
Store the current values of the degrees of freedom. More... | |
void | restore_dof_values () |
Restore the stored values of the degrees of freedom. More... | |
void | enable_jacobian_reuse () |
void | disable_jacobian_reuse () |
Disable recycling of Jacobian in Newton iteration. More... | |
bool | jacobian_reuse_is_enabled () |
Is recycling of Jacobian in Newton iteration enabled? More... | |
bool & | use_predictor_values_as_initial_guess () |
void | newton_solve () |
Use Newton method to solve the problem. More... | |
void | enable_globally_convergent_newton_method () |
enable globally convergent Newton method More... | |
void | disable_globally_convergent_newton_method () |
disable globally convergent Newton method More... | |
void | newton_solve (unsigned const &max_adapt) |
void | steady_newton_solve (unsigned const &max_adapt=0) |
void | copy (Problem *orig_problem_pt) |
virtual Problem * | make_copy () |
virtual void | read (std::ifstream &restart_file, bool &unsteady_restart) |
void | dump (const std::string &dump_file_name) const |
void | delete_all_external_storage () |
virtual void | symmetrise_eigenfunction_for_adaptive_pitchfork_tracking () |
double * | bifurcation_parameter_pt () const |
void | get_bifurcation_eigenfunction (Vector< DoubleVector > &eigenfunction) |
void | activate_fold_tracking (double *const ¶meter_pt, const bool &block_solve=true) |
void | activate_bifurcation_tracking (double *const ¶meter_pt, const DoubleVector &eigenvector, const bool &block_solve=true) |
void | activate_bifurcation_tracking (double *const ¶meter_pt, const DoubleVector &eigenvector, const DoubleVector &normalisation, const bool &block_solve=true) |
void | activate_pitchfork_tracking (double *const ¶meter_pt, const DoubleVector &symmetry_vector, const bool &block_solve=true) |
void | activate_hopf_tracking (double *const ¶meter_pt, const bool &block_solve=true) |
void | activate_hopf_tracking (double *const ¶meter_pt, const double &omega, const DoubleVector &null_real, const DoubleVector &null_imag, const bool &block_solve=true) |
void | deactivate_bifurcation_tracking () |
void | reset_assembly_handler_to_default () |
Reset the system to the standard non-augemented state. More... | |
double | arc_length_step_solve (double *const ¶meter_pt, const double &ds, const unsigned &max_adapt=0) |
double | arc_length_step_solve (Data *const &data_pt, const unsigned &data_index, const double &ds, const unsigned &max_adapt=0) |
void | reset_arc_length_parameters () |
int & | sign_of_jacobian () |
void | explicit_timestep (const double &dt, const bool &shift_values=true) |
Take an explicit timestep of size dt. More... | |
void | unsteady_newton_solve (const double &dt) |
void | unsteady_newton_solve (const double &dt, const bool &shift_values) |
void | unsteady_newton_solve (const double &dt, const unsigned &max_adapt, const bool &first, const bool &shift=true) |
double | doubly_adaptive_unsteady_newton_solve (const double &dt, const double &epsilon, const unsigned &max_adapt, const bool &first, const bool &shift=true) |
double | doubly_adaptive_unsteady_newton_solve (const double &dt, const double &epsilon, const unsigned &max_adapt, const unsigned &suppress_resolve_after_spatial_adapt_flag, const bool &first, const bool &shift=true) |
double | adaptive_unsteady_newton_solve (const double &dt_desired, const double &epsilon) |
double | adaptive_unsteady_newton_solve (const double &dt_desired, const double &epsilon, const bool &shift_values) |
void | assign_initial_values_impulsive () |
void | assign_initial_values_impulsive (const double &dt) |
void | calculate_predictions () |
Calculate predictions. More... | |
void | enable_mass_matrix_reuse () |
void | disable_mass_matrix_reuse () |
bool | mass_matrix_reuse_is_enabled () |
Return whether the mass matrix is being reused. More... | |
void | refine_uniformly (const Vector< unsigned > &nrefine_for_mesh) |
void | refine_uniformly (const Vector< unsigned > &nrefine_for_mesh, DocInfo &doc_info) |
void | refine_uniformly_and_prune (const Vector< unsigned > &nrefine_for_mesh) |
void | refine_uniformly_and_prune (const Vector< unsigned > &nrefine_for_mesh, DocInfo &doc_info) |
void | refine_uniformly (DocInfo &doc_info) |
void | refine_uniformly_and_prune (DocInfo &doc_info) |
void | refine_uniformly () |
void | refine_uniformly (const unsigned &i_mesh, DocInfo &doc_info) |
Do uniform refinement for submesh i_mesh with documentation. More... | |
void | refine_uniformly (const unsigned &i_mesh) |
Do uniform refinement for submesh i_mesh without documentation. More... | |
void | p_refine_uniformly (const Vector< unsigned > &nrefine_for_mesh) |
void | p_refine_uniformly (const Vector< unsigned > &nrefine_for_mesh, DocInfo &doc_info) |
void | p_refine_uniformly_and_prune (const Vector< unsigned > &nrefine_for_mesh) |
void | p_refine_uniformly_and_prune (const Vector< unsigned > &nrefine_for_mesh, DocInfo &doc_info) |
void | p_refine_uniformly (DocInfo &doc_info) |
void | p_refine_uniformly_and_prune (DocInfo &doc_info) |
void | p_refine_uniformly () |
void | p_refine_uniformly (const unsigned &i_mesh, DocInfo &doc_info) |
Do uniform p-refinement for submesh i_mesh with documentation. More... | |
void | p_refine_uniformly (const unsigned &i_mesh) |
Do uniform p-refinement for submesh i_mesh without documentation. More... | |
void | refine_selected_elements (const Vector< unsigned > &elements_to_be_refined) |
void | refine_selected_elements (const Vector< RefineableElement * > &elements_to_be_refined_pt) |
void | refine_selected_elements (const unsigned &i_mesh, const Vector< unsigned > &elements_to_be_refined) |
void | refine_selected_elements (const unsigned &i_mesh, const Vector< RefineableElement * > &elements_to_be_refined_pt) |
void | refine_selected_elements (const Vector< Vector< unsigned >> &elements_to_be_refined) |
void | refine_selected_elements (const Vector< Vector< RefineableElement * >> &elements_to_be_refined_pt) |
void | p_refine_selected_elements (const Vector< unsigned > &elements_to_be_refined) |
void | p_refine_selected_elements (const Vector< PRefineableElement * > &elements_to_be_refined_pt) |
void | p_refine_selected_elements (const unsigned &i_mesh, const Vector< unsigned > &elements_to_be_refined) |
void | p_refine_selected_elements (const unsigned &i_mesh, const Vector< PRefineableElement * > &elements_to_be_refined_pt) |
void | p_refine_selected_elements (const Vector< Vector< unsigned >> &elements_to_be_refined) |
void | p_refine_selected_elements (const Vector< Vector< PRefineableElement * >> &elements_to_be_refined_pt) |
unsigned | unrefine_uniformly () |
unsigned | unrefine_uniformly (const unsigned &i_mesh) |
void | p_unrefine_uniformly (DocInfo &doc_info) |
void | p_unrefine_uniformly (const unsigned &i_mesh, DocInfo &doc_info) |
Do uniform p-unrefinement for submesh i_mesh without documentation. More... | |
void | adapt (unsigned &n_refined, unsigned &n_unrefined) |
void | adapt () |
void | p_adapt (unsigned &n_refined, unsigned &n_unrefined) |
void | p_adapt () |
void | adapt_based_on_error_estimates (unsigned &n_refined, unsigned &n_unrefined, Vector< Vector< double >> &elemental_error) |
void | adapt_based_on_error_estimates (Vector< Vector< double >> &elemental_error) |
void | get_all_error_estimates (Vector< Vector< double >> &elemental_error) |
void | doc_errors (DocInfo &doc_info) |
Get max and min error for all elements in submeshes. More... | |
void | doc_errors () |
Get max and min error for all elements in submeshes. More... | |
void | enable_info_in_newton_solve () |
void | disable_info_in_newton_solve () |
Disable the output of information when in the newton solver. More... | |
![]() | |
ExplicitTimeSteppableObject () | |
Empty constructor. More... | |
ExplicitTimeSteppableObject (const ExplicitTimeSteppableObject &)=delete | |
Broken copy constructor. More... | |
void | operator= (const ExplicitTimeSteppableObject &)=delete |
Broken assignment operator. More... | |
virtual | ~ExplicitTimeSteppableObject () |
Empty destructor. More... | |
Public Attributes | |
bool | Use_fd_jacobian |
![]() | |
MyDocInfo | Doc_info |
unsigned | Output_precision |
unsigned | N_steps_taken |
double | Total_step_time |
std::string | Trace_filename |
std::string | Info_filename |
double | Error_norm_limit |
double | Solution_norm_limit |
bool | Disable_mass_matrix_solver_optimisations |
bool | Always_write_trace |
Should we output to trace file every step? More... | |
bool | Want_doc_exact |
Should we try to output exact solution? More... | |
bool | Should_doc_boundaries |
Should we output the locations of the boundary nodes? More... | |
bool | Dump |
Should we dump ready for a restart? More... | |
bool | Output_ltes |
Should we output the local truncation error at each node as well? More... | |
bool | Output_predictor_values |
Should we output the predicted values too? More... | |
bool | Output_initial_condition |
Should we write output for initial conditions as though they are time steps as well? More... | |
SolutionFunctorBase * | Exact_solution_pt |
Function pointer for exact solution. More... | |
![]() | |
bool | Shut_up_in_newton_solve |
|
inline |
constructor
References oomph::MyProblem::Always_write_trace, and Use_fd_jacobian.
Perform set up of problem.
Reimplemented from oomph::MyProblem.
References oomph::Problem::assign_eqn_numbers(), oomph::MyProblem::build(), oomph::Problem::build_global_mesh(), element_pt(), oomph::Problem::ndof(), oomph::oomph_info, Use_fd_jacobian, and oomph::ODEElement::Use_fd_jacobian.
|
inline |
References oomph::Problem::mesh_pt().
Referenced by build(), element_pt(), exact_solution(), nvalue(), and ts_pt().
|
inline |
References element_pt(), and oomph::Problem::mesh_pt().
References element_pt(), oomph::ODEElement::exact_solution(), oomph::Problem::mesh_pt(), and oomph::Problem::time().
Referenced by get_error_norm(), and write_additional_trace_data().
Error norm calculator.
Reimplemented from oomph::MyProblem.
References exact_solution(), oomph::Problem::time(), oomph::Problem::time_pt(), trace_values(), oomph::VectorHelpers::two_norm(), calibrate::val, and oomph::VectorHelpers::vector_diff().
|
inlinevirtual |
Error norm: use abs(error in data).
Reimplemented from oomph::Problem.
References abs(), oomph::Mesh::element_pt(), oomph::GeneralisedElement::internal_data_pt(), oomph::Problem::mesh_pt(), and ts_pt().
|
inlinevirtual |
Assign initial conditions from function pointer.
Reimplemented from oomph::MyProblem.
References oomph::MyProblem::actions_after_set_initial_condition(), oomph::Mesh::element_pt(), oomph::GeneralisedElement::internal_data_pt(), j, oomph::Problem::mesh_pt(), oomph::TimeStepper::nprev_values(), nvalue(), oomph::Data::set_value(), plotPSD::t, oomph::Problem::time(), oomph::Time::time(), oomph::Problem::time_pt(), and oomph::Problem::time_stepper_pt().
|
inline |
References element_pt(), and oomph::ODEElement::nvalue().
Referenced by my_set_initial_condition(), and solution().
|
inlinevirtual |
Standard output function: loop over all elements in all meshes and output.
Reimplemented from oomph::MyProblem.
References i, output_vector(), solution(), plotPSD::t, and oomph::MyProblem::Trace_seperator.
References oomph::Mesh::element_pt(), oomph::GeneralisedElement::internal_data_pt(), oomph::Problem::mesh_pt(), nvalue(), and oomph::Data::value().
Referenced by output_solution(), and trace_values().
|
inline |
References element_pt(), oomph::GeneralisedElement::internal_data_pt(), and oomph::Data::time_stepper_pt().
Referenced by global_temporal_error_norm().
|
inlinevirtual |
Overload to write problem specific data into trace file. Note: don't add any line endings, seperate data with the Trace_seperator string (BEFORE each data entry).
Reimplemented from oomph::MyProblem.
References exact_solution(), i, output_vector(), oomph::Problem::time(), oomph::Problem::time_pt(), and oomph::MyProblem::Trace_seperator.
|
inlinevirtual |
Overload to write problem specific headers into trace file. Note: don't add any line endings, seperate headers with the Trace_seperator string (BEFORE each data entry).
Reimplemented from oomph::MyProblem.
References oomph::MyProblem::Trace_seperator.
bool oomph::ODEProblem::Use_fd_jacobian |
Referenced by build(), and ODEProblem().