openCARP
Doxygen code documentation for the open cardiac electrophysiology simulator openCARP
electrics_eikonal.cc
Go to the documentation of this file.
1 // ----------------------------------------------------------------------------
2 // openCARP is an open cardiac electrophysiology simulator.
3 //
4 // Copyright (C) 2020 openCARP project
5 //
6 // This program is licensed under the openCARP Academic Public License (APL)
7 // v1.0: You can use and redistribute it and/or modify it in non-commercial
8 // academic environments under the terms of APL as published by the openCARP
9 // project v1.0, or (at your option) any later version. Commercial use requires
10 // a commercial license (info@opencarp.org).
11 //
12 // This program is distributed without any warranty; see the openCARP APL for
13 // more details.
14 //
15 // You should have received a copy of the openCARP APL along with this program
16 // and can find it online: http://www.opencarp.org/license
17 // ----------------------------------------------------------------------------
18 
27 #include "electrics_eikonal.h"
28 #include <cstdlib>
29 #include "SF_globals.h"
30 #include "basics.h"
31 #include "petsc_utils.h"
32 #include "timers.h"
33 #include "stimulate.h"
34 
35 #include "SF_init.h"
36 
37 namespace opencarp
38 {
39 
41 {
42  if (get_size() > 1) {
43  log_msg(NULL, 5, 0, "DREAM/Eikonal physics currently do not support MPI parallelization. Use openMP instead. Aborting!");
44  EXIT(EXIT_FAILURE);
45  }
46 
47  double t1, t2;
48  get_time(t1);
49 
50  set_dir(OUTPUT);
51 
52  // open logger
53  logger = f_open("eikonal.log", param_globals::experiment != 4 ? "w" : "r");
54 
55  // setup mappings between extra and intra grids, algebraic and nodal,
56  // and between PETSc and canonical orderings
57  setup_mappings();
58 
59  eik_tech = static_cast<Eikonal::eikonal_t>(param_globals::dream.solve);
60 
61  // the ionic physics is currently triggered from inside the Electrics to have tighter
62  // control over it. The standalone eikonal solver does not require it.
63  switch (eik_tech) {
64  case EIKONAL: break;
65  default:
66  ion.logger = logger;
67  ion.initialize();
68  }
69 
70  // set up Intracellular tissue
71  set_elec_tissue_properties(mtype, intra_grid, logger);
72  region_mask(intra_elec_msh, mtype[intra_grid].regions, mtype[intra_grid].regionIDs, true, "gregion_i");
73 
74  // add electrics timer for time stepping, add to time stepper tool (TS)
75  double global_time = user_globals::tm_manager->time;
76  timer_idx = user_globals::tm_manager->add_eq_timer(global_time, param_globals::tend, 0,
77  param_globals::dt, 0, "elec::ref_dt", "TS");
78 
79  // electrics stimuli setup
80  setup_stimuli();
81 
82  // set up the linear equation systems. this needs to happen after the stimuli have been
83  // set up, since we need boundary condition info
84  setup_solvers();
85 
86  // the next setup steps require the solvers to be set up, since they use the matrices
87  // generated by those
88 
89  // initialize the LATs detector
90  switch (eik_tech) {
91  case EIKONAL: break; // not available for pure eikonal solve
92  default:
94  }
95 
96  // prepare the electrics output. we skip it if we do post-processing
97  if (param_globals::experiment != EXP_POSTPROCESS)
98  setup_output();
99 
100  this->initialize_time += timing(t2, t1);
101  log_msg(NULL, 0, 0, "All done in %f sec.", float(t2 - t1));
102 }
103 
104 void Eikonal::set_elec_tissue_properties(MaterialType* mtype, Eikonal::grid_t g, FILE_SPEC logger)
105 {
106  MaterialType* m = mtype + g;
107 
108  // initialize random conductivity fluctuation structure with PrM values
109  m->regions.resize(param_globals::num_gregions);
110 
111  const char* grid_name = g == Eikonal::intra_grid ? "intracellular" : "extracellular";
112  log_msg(logger, 0, 0, "Setting up %s tissue poperties for %d regions ..", grid_name,
113  param_globals::num_gregions);
114 
115  char buf[64];
116  RegionSpecs* reg = m->regions.data();
117 
118  for (size_t i = 0; i < m->regions.size(); i++, reg++) {
119  if (!strcmp(param_globals::gregion[i].name, "")) {
120  snprintf(buf, sizeof buf, ", gregion_%d", int(i));
121  param_globals::gregion[i].name = dupstr(buf);
122  }
123 
124  reg->regname = strdup(param_globals::gregion[i].name);
125  reg->regID = i;
126  reg->nsubregs = param_globals::gregion[i].num_IDs;
127  if (!reg->nsubregs)
128  reg->subregtags = NULL;
129  else {
130  reg->subregtags = new int[reg->nsubregs];
131 
132  for (int j = 0; j < reg->nsubregs; j++)
133  reg->subregtags[j] = param_globals::gregion[i].ID[j];
134  }
135 
136  // describe material in given region
137  elecMaterial* emat = new elecMaterial();
138  emat->material_type = ElecMat;
139 
140  emat->InVal[0] = param_globals::gregion[i].g_il;
141  emat->InVal[1] = param_globals::gregion[i].g_it;
142  emat->InVal[2] = param_globals::gregion[i].g_in;
143 
144  emat->ExVal[0] = param_globals::gregion[i].g_el;
145  emat->ExVal[1] = param_globals::gregion[i].g_et;
146  emat->ExVal[2] = param_globals::gregion[i].g_en;
147 
148  emat->BathVal[0] = param_globals::gregion[i].g_bath;
149  emat->BathVal[1] = param_globals::gregion[i].g_bath;
150  emat->BathVal[2] = param_globals::gregion[i].g_bath;
151 
152  // convert units from S/m -> mS/um
153  for (int j = 0; j < 3; j++) {
154  emat->InVal[j] *= 1e-3 * param_globals::gregion[i].g_mult;
155  emat->ExVal[j] *= 1e-3 * param_globals::gregion[i].g_mult;
156  emat->BathVal[j] *= 1e-3 * param_globals::gregion[i].g_mult;
157  }
158  reg->material = emat;
159  }
160 
161  if ((g == Eikonal::intra_grid && strlen(param_globals::gi_scale_vec)) ||
162  (g == Eikonal::extra_grid && strlen(param_globals::ge_scale_vec))) {
164  sf_mesh& mesh = get_mesh(mt);
165  const char* file = g == Eikonal::intra_grid ? param_globals::gi_scale_vec : param_globals::ge_scale_vec;
166 
167  size_t num_file_entries = SF::root_count_ascii_lines(file, mesh.comm);
168 
169  if (num_file_entries != mesh.g_numelem)
170  log_msg(0, 4, 0, "%s warning: number of %s conductivity scaling entries does not match number of elements!",
171  __func__, get_mesh_type_name(mt));
172 
173  // set up parallel element vector and read data
174  sf_vec* escale;
175  SF::init_vector(&escale, get_mesh(mt), 1, sf_vec::elemwise);
176  escale->read_ascii(g == Eikonal::intra_grid ? param_globals::gi_scale_vec : param_globals::ge_scale_vec);
177 
178  if (get_size() > 1) {
179  // set up element vector permutation and permute
180  if (get_permutation(mt, ELEM_PETSC_TO_CANONICAL, 1) == NULL) {
182  }
184  sc(*escale, false);
185  }
186 
187  // copy data into SF::vector
188  SF_real* p = escale->ptr();
189  m->el_scale.assign(p, p + escale->lsize());
190  escale->release_ptr(p);
191  }
192 }
193 
194 void Eikonal::setup_mappings()
195 {
196  bool intra_exits = mesh_is_registered(intra_elec_msh), extra_exists = mesh_is_registered(extra_elec_msh);
197  assert(intra_exits);
198  const int dpn = 1;
199 
200  // It may be that another physic (e.g. ionic models) has already computed the intracellular mappings,
201  // thus we first test their existence
202  if (get_scattering(intra_elec_msh, ALG_TO_NODAL, dpn) == NULL) {
203  log_msg(logger, 0, 0, "%s: Setting up intracellular algebraic-to-nodal scattering.", __func__);
205  }
207  log_msg(logger, 0, 0, "%s: Setting up intracellular PETSc to canonical permutation.", __func__);
209  }
210 }
211 
213 {
214  double t1, t2;
215  get_time(t1);
216 
217  switch (eik_tech) {
218  case EIKONAL: solve_EIKONAL(); break;
219  case DREAM: solve_DREAM(); break;
220  default: solve_RE(); break;
221  }
222 
224  // output lin solver stats
226  }
227  this->compute_time += timing(t2, t1);
228 
229  // since the traces have their own timing, we check for trace dumps in the compute step loop
232 }
233 
235 {
236  double t1, t2;
237  get_time(t1);
238 
239  switch (eik_tech) {
240  case EIKONAL: break;
241  default:
243  output_manager_time.write_data(); // does not exist in EIKONAL
244  }
245 
246  if (do_output_eikonal) {
248  do_output_eikonal = false;
249  }
250 
251  double curtime = timing(t2, t1);
252  this->output_time += curtime;
253 
254  IO_stats.calls++;
255  IO_stats.tot_time += curtime;
256 
259 }
260 
265 {
266  // close logger
267  f_close(logger);
268 
269  switch (eik_tech) {
270  case EIKONAL:
272  break;
273  default:
274  // output LAT data
278  ion.destroy();
279  }
280 }
281 
282 void Eikonal::setup_stimuli()
283 {
284  // initialize basic stim info data (used units, supported types, etc)
285  init_stim_info();
286  bool dumpTrace = true;
287 
288  if (dumpTrace) set_dir(OUTPUT);
289 
290  stimuli.resize(param_globals::num_stim);
291  for (int i = 0; i < param_globals::num_stim; i++) {
292  // construct new stimulus
293  stimulus& s = stimuli[i];
294 
295  if (param_globals::stim[i].crct.type != 0 && param_globals::stim[i].crct.type != 9) {
296  // In the Eikonal class, only the intracellular domain is registered.
297  // Therefore, only I_tm and Vm_clmp are compatible.
298  log_msg(NULL, 5, 0, "%s error: stimulus of type %i is incompatible with the eikonal model! Use I_tm or Vm_clmp instead. Aborting!", __func__, s.phys.type);
299  EXIT(EXIT_FAILURE);
300  }
301 
303  s.translate(i);
304 
305  s.setup(i);
306 
307  log_msg(NULL, 2, 0, "Only geometry, start time, npls, and bcl of stim[%i] are used", i);
308 
309  if (dumpTrace && get_rank() == 0)
310  s.pulse.wave.write_trace(s.name + ".trc");
311  }
312 
314 }
315 
316 void Eikonal::stimulate_intracellular()
317 {
318  parabolic_solver& ps = parab_solver;
319 
320  // iterate over stimuli
321  for (stimulus& s : stimuli) {
322  if (s.is_active()) {
323  // for active stimuli, deal with the stimuli-type specific stimulus application
324  switch (s.phys.type) {
325  case I_tm: {
326  if (param_globals::operator_splitting) {
327  apply_stim_to_vector(s, *ps.Vmv, true);
328  } else {
329  SF_real Cm = 1.0;
330  timer_manager& tm = *user_globals::tm_manager;
331  SF_real sc = tm.time_step / Cm;
332 
333  ps.Irhs->set(0.0);
334  apply_stim_to_vector(s, *ps.Irhs, true);
335 
336  *ps.tmp_i1 = *ps.IIon;
337  *ps.tmp_i1 -= *ps.Irhs;
338  *ps.tmp_i1 *= sc; // tmp_i1 = sc * (IIon - Irhs)
339 
340  // add ionic, transmembrane and intracellular currents to rhs
341  if (param_globals::parab_solve != parabolic_solver::EXPLICIT)
342  ps.mass_i->mult(*ps.tmp_i1, *ps.Irhs);
343  else
344  *ps.Irhs = *ps.tmp_i1;
345  }
346  break;
347  }
348 
349  case Illum: {
350  sf_vec* illum_vec = ion.miif->gdata[limpet::illum];
351 
352  if (illum_vec == NULL) {
353  log_msg(0, 5, 0, "Cannot apply illumination stim: global vector not present!");
354  EXIT(EXIT_FAILURE);
355  } else {
356  apply_stim_to_vector(s, *illum_vec, false);
357  }
358 
359  break;
360  }
361 
362  default: break;
363  }
364  }
365  }
366 }
367 
368 void Eikonal::clamp_Vm()
369 {
370  for (stimulus& s : stimuli) {
371  if (s.phys.type == Vm_clmp && s.is_active())
373  }
374 }
375 
376 void Eikonal::setup_output()
377 {
378  int rank = get_rank();
379  SF::vector<mesh_int_t>* restr_i = NULL;
380  SF::vector<mesh_int_t>* restr_e = NULL;
381  set_dir(OUTPUT);
382 
383  setup_dataout(param_globals::dataout_i, param_globals::dataout_i_vtx, intra_elec_msh,
384  restr_i, param_globals::num_io_nodes > 0);
385 
386  if (param_globals::dataout_i) {
387  switch (eik_tech) {
388  case EIKONAL:
389  output_manager_cycle.register_output(eik_solver.AT, intra_elec_msh, 1, param_globals::dream.output.atfile, "ms", restr_i);
390  break;
391  case DREAM:
392  output_manager_time.register_output(parab_solver.Vmv, intra_elec_msh, 1, param_globals::vofile, "mV", restr_i);
393  output_manager_cycle.register_output(eik_solver.AT, intra_elec_msh, 1, param_globals::dream.output.atfile, "ms", restr_i);
394  output_manager_cycle.register_output(eik_solver.RT, intra_elec_msh, 1, param_globals::dream.output.rtfile, "ms", restr_i);
395  if (strcmp(param_globals::dream.output.idifffile, "") != 0) {
396  output_manager_time.register_output(eik_solver.Idiff, intra_elec_msh, 1, param_globals::dream.output.idifffile, "muA/cm2", restr_i);
397  }
398  break;
399  default:
400  output_manager_time.register_output(parab_solver.Vmv, intra_elec_msh, 1, param_globals::vofile, "mV", restr_i);
401  output_manager_cycle.register_output(eik_solver.AT, intra_elec_msh, 1, param_globals::dream.output.atfile, "ms", restr_i);
402  if (strcmp(param_globals::dream.output.idifffile, "") != 0) {
403  output_manager_time.register_output(eik_solver.Idiff, intra_elec_msh, 1, param_globals::dream.output.idifffile, "muA/cm2", restr_i);
404  }
405  }
406  }
407 
409 
410  if (param_globals::num_trace) {
411  sf_mesh& imesh = get_mesh(intra_elec_msh);
412  open_trace(ion.miif, param_globals::num_trace, param_globals::trace_node, NULL, &imesh);
413  }
414 
415  // initialize generic logger for IO timings per time_dt
416  IO_stats.init_logger("IO_stats.dat");
417 }
418 
419 void Eikonal::dump_matrices()
420 {
421  std::string bsname = param_globals::dump_basename;
422  std::string fn;
423 
424  set_dir(OUTPUT);
425 
426  // dump monodomain matrices
427  if (param_globals::parab_solve == 1) {
428  // using Crank-Nicolson
429  fn = bsname + "_Ki_CN.bin";
430  parab_solver.lhs_parab->write(fn.c_str());
431  }
432  fn = bsname + "_Ki.bin";
433  parab_solver.rhs_parab->write(fn.c_str());
434 
435  fn = bsname + "_Mi.bin";
436  parab_solver.mass_i->write(fn.c_str());
437 }
438 
441 double Eikonal::timer_val(const int timer_id)
442 {
443  // determine
444  int sidx = stimidx_from_timeridx(stimuli, timer_id);
445  double val = 0.0;
446  if (sidx != -1) {
447  stimuli[sidx].value(val);
448  } else
449  val = std::nan("NaN");
450 
451  return val;
452 }
453 
456 std::string Eikonal::timer_unit(const int timer_id)
457 {
458  int sidx = stimidx_from_timeridx(stimuli, timer_id);
459  std::string s_unit;
460 
461  if (sidx != -1)
462  // found a timer-linked stimulus
463  s_unit = stimuli[sidx].pulse.wave.f_unit;
464 
465  return s_unit;
466 }
467 
468 void Eikonal::setup_solvers()
469 {
470  set_dir(OUTPUT);
471 
472  switch (eik_tech) {
473  case EIKONAL:
474  eik_solver.init();
475  break;
476  default:
477  parab_solver.init();
479  eik_solver.init();
481  if (param_globals::dump2MatLab) dump_matrices();
482  }
483 }
484 
485 void Eikonal::checkpointing()
486 {
487  const timer_manager& tm = *user_globals::tm_manager;
488 
489  // regular user selected state save
490  if (tm.trigger(iotm_chkpt_list)) {
491  char save_fnm[1024];
492  const char* tsav_ext = get_tsav_ext(tm.time);
493 
494  snprintf(save_fnm, sizeof save_fnm, "%s.%s.roe", param_globals::write_statef, tsav_ext);
495 
496  ion.miif->dump_state(save_fnm, tm.time, intra_elec_msh, false, GIT_COMMIT_COUNT);
497  eik_solver.save_eikonal_state(tsav_ext);
498  }
499 
500  // checkpointing based on interval
501  if (tm.trigger(iotm_chkpt_intv)) {
502  char save_fnm[1024];
503  snprintf(save_fnm, sizeof save_fnm, "checkpoint.%.1f.roe", tm.time);
504  ion.miif->dump_state(save_fnm, tm.time, intra_elec_msh, false, GIT_COMMIT_COUNT);
505  }
506 }
507 
508 void Eikonal::solve_EIKONAL()
509 {
510  if (user_globals::tm_manager->time == 0) {
511  eik_solver.FIM();
514  do_output_eikonal = true;
515  }
516 }
517 
518 void Eikonal::solve_RE()
519 {
520  if (user_globals::tm_manager->time == 0) {
521  eik_solver.FIM();
524  do_output_eikonal = true;
525  }
526  solve_RD();
527 }
528 
529 void Eikonal::solve_DREAM()
530 {
532  solve_RD();
533  } else {
534  if (user_globals::tm_manager->time != 0) {
536  }
537 
538  eik_solver.cycFIM();
540 
543  do_output_eikonal = true;
544  }
545 }
546 
547 void Eikonal::solve_RD()
548 {
549  // if requested, we checkpoint the current state
550  checkpointing();
551 
552  // activation checking
553  const double time = user_globals::tm_manager->time,
554  time_step = user_globals::tm_manager->time_step;
555 
556  lat.check_acts(time);
557  lat.check_quiescence(time, time_step);
558 
559  clamp_Vm();
560 
561  *parab_solver.old_vm = *parab_solver.Vmv; // needed in step D of DREAM
562 
563  // compute ionics update
564  ion.compute_step();
565 
566  // Compute the I diff current
567  *eik_solver.Idiff *= 0;
570 
571  if (eik_tech == REp) {
573  }
574 
575  switch (eik_tech) {
577  default: break;
578  }
579 
580  clamp_Vm();
581 }
582 
584 {
585  if (param_globals::output_level > 1) log_msg(0, 0, 0, "\n *** Initializing Eikonal Solver ***\n");
586  stats.init_logger("eik_stats.dat");
587 
588  if (param_globals::dream.output.debugNode >= 0) {
589  nodeData.idX = param_globals::dream.output.debugNode;
590  char buf[256];
591  snprintf(buf, sizeof buf, "node_%d.dat", nodeData.idX);
592  nodeData.init_logger(buf);
593  }
594 
595  // currently only used for output
596  const sf_mesh& mesh = get_mesh(intra_elec_msh);
597  twoFib = mesh.she.size() > 0;
601 
602  num_pts = mesh.l_numpts;
603 
604  e2n_con = mesh.con; // Connectivity vector with nodes that belong to each element
605  // The 4 nodes from index 4j to 4j+3 belong to the same element for 0<=j<num elements
606  elem_start = mesh.dsp; // For the i_th element elem_start[j] stores its starting position in the "connect" vector
607 
611 
612  List.assign(num_pts, 0); // List of active nodes
613  T_A.assign(num_pts, inf); // Activation times
614  D_I.assign(num_pts, 0); // Diastolic Intervals
615  T_R.assign(num_pts, -400); // Recovery times
616  TA_old.assign(num_pts, inf); // Activation Time is the previous cycle
617  num_changes.assign(num_pts, 0); // Number of Times entered in the List per current LAT
618  nReadded2List.assign(num_pts, 0); // Number of Times entered in the List per current LAT
619  stim_status.assign(num_pts, 0); // Status of nodes
620 
621  switch (mesh.type[0]) {
622  case 0:
623  MESH_SIZE = 4;
624  break;
625 
626  case 6:
627  MESH_SIZE = 3;
628  break;
629 
630  case 7:
631  MESH_SIZE = 2;
632  break;
633 
634  default:
635  log_msg(0, 5, 0, "Error: Type of element is not compatible with this version of the eikonal model. Use tetrahedra or triangles");
636  EXIT(EXIT_FAILURE);
637  break;
638  }
639 
640  if (strlen(param_globals::start_statef) > 0) load_state_file();
641 
642  create_node_to_node_graph();
643 
644  translate_stim_to_eikonal();
645 
646  precompute_squared_anisotropy_metric();
647 }
648 
650 {
651  double t1, t2;
652  get_time(t1);
653 
654  const sf_mesh& mesh = get_mesh(intra_elec_msh);
655 
656  diff_cur.resize(mesh.l_numpts);
657  rho_cvrest.resize(mesh.l_numpts);
661 
662  // --- Precompute resolved region IDs for each point ---
663  // Use the same region delegation as the ionics class
664  SF::vector<int> regionIDs;
665  SF::vector<RegionSpecs> rs(param_globals::num_imp_regions);
666  for (size_t i = 0; i < rs.size(); i++) {
667  rs[i].nsubregs = param_globals::imp_region[i].num_IDs;
668  rs[i].subregtags = param_globals::imp_region[i].ID;
669  for (int j = 0; j < rs[i].nsubregs; j++) {
670  if (rs[i].subregtags[j] == -1 && get_rank() == 0)
671  log_msg(NULL, 3, ECHO, "Warning: not all %u IDs provided for imp_region[%u]!\n", rs[i].nsubregs, i);
672  }
673  }
674  if (rs.size() == 1) {
675  regionIDs.assign(mesh.l_numpts, 0);
676  } else {
677  region_mask(intra_elec_msh, rs, regionIDs, false, "imp_regions");
678  }
679 
680  // --- Parallel initialization, one write per vertex ---
681  #pragma omp parallel for schedule(dynamic)
682  for (int v = 0; v < mesh.l_numpts; v++) {
683  int reg = regionIDs[v];
684 
685  const auto& region_diff = param_globals::imp_region[reg].dream.Idiff;
686  const auto& region_rest = param_globals::imp_region[reg].dream.CVrest;
687 
688  auto model = static_cast<eikonal_solver::Idiff_t>(region_diff.model);
689  diff_cur[v].model = model;
690 
691  if (model == GAUSS) {
692  diff_cur[v].alpha_1 = region_diff.alpha_i[0];
693  diff_cur[v].alpha_2 = region_diff.alpha_i[1];
694  diff_cur[v].alpha_3 = region_diff.alpha_i[2];
695  diff_cur[v].beta_1 = region_diff.beta_i[0];
696  diff_cur[v].beta_2 = region_diff.beta_i[1];
697  diff_cur[v].beta_3 = region_diff.beta_i[2];
698  diff_cur[v].gamma_1 = region_diff.gamma_i[0];
699  diff_cur[v].gamma_2 = region_diff.gamma_i[1];
700  diff_cur[v].gamma_3 = region_diff.gamma_i[2];
701  } else {
702  diff_cur[v].A_F = region_diff.A_F;
703  diff_cur[v].tau_F = region_diff.tau_F;
704  diff_cur[v].V_th = region_diff.V_th;
705  }
706 
707  rho_cvrest[v] = region_rest.rho;
708  kappa_cvrest[v] = region_rest.kappa;
709  theta_cvrest[v] = region_rest.theta;
710  denom_cvrest[v] = log(region_rest.rho) / region_rest.psi;
711  }
712  if (param_globals::output_level) log_msg(NULL, 0, 0, "Diffusion current and CV restitution initialized in %f sec.", timing(t2, t1));
713 }
714 
715 void eikonal_solver::translate_stim_to_eikonal()
716 {
717  double t1, t2;
718  get_time(t1);
719  Index_currStim = 0;
720 
721  // Collect all pulses as (start_time, stimulus_index)
722  std::vector<std::pair<SF_real, int>> stim_events;
723  stim_events.reserve(param_globals::num_stim * 8); // rough guess
724 
725  for (int stim_idx = 0; stim_idx < stimuliRef->size(); ++stim_idx) {
726  const stimulus& s = (*stimuliRef)[stim_idx];
727  for (int idx_pls = 0; idx_pls < s.ptcl.npls; ++idx_pls) {
728  SF_real start_time = s.ptcl.start + s.ptcl.pcl * idx_pls;
729  stim_events.emplace_back(start_time, stim_idx);
730  }
731  }
732 
733  // Sort events by start_time
734  std::sort(stim_events.begin(), stim_events.end(),
735  [](auto& a, auto& b) { return a.first < b.first; });
736 
737  // Reserve enough space for output
738  size_t total_nodes = 0;
739  for (auto& ev : stim_events)
740  total_nodes += (*stimuliRef)[ev.second].electrode.vertices.size();
741  StimulusPoints.resize(total_nodes + 1, -1);
742  StimulusTimes.resize(total_nodes + 1, -1);
743 
744  // Fill outputs
745  size_t count = 0;
746  for (auto& ev : stim_events) {
747  const stimulus& s = (*stimuliRef)[ev.second];
748  for (mesh_int_t v : s.electrode.vertices) {
749  StimulusPoints[count] = v;
750  StimulusTimes[count] = ev.first;
751  ++count;
752  }
753  }
754 
755  if (param_globals::output_level)
756  log_msg(NULL, 0, 0, "Translating stimuli for eikonal model done in %f sec.", timing(t2, t1));
757 }
758 
759 void eikonal_solver::create_node_to_node_graph()
760 {
761  double t1, t2;
762  get_time(t1);
763 
764  n2n_dsp.resize(num_pts + 1, 0);
765  const sf_mesh& mesh = get_mesh(intra_elec_msh);
766 
767  // Thread-local storage for neighbors
768  std::vector<std::vector<mesh_int_t>> thread_neighbors(num_pts);
769 
770  // Preallocate thread-local marker arrays for O(n) duplicate removal
771  #pragma omp parallel
772  {
773  std::vector<char> mark(num_pts, 0); // one per thread
774 
775  #pragma omp for schedule(dynamic)
776  for (int point_idx = 0; point_idx < num_pts; point_idx++) {
777  int numNBElem = n2e_dsp[point_idx + 1] - n2e_dsp[point_idx];
778  std::vector<mesh_int_t> neighbors;
779  neighbors.reserve(numNBElem * MESH_SIZE); // rough estimate
780 
781  // Loop over all elements containing this node
782  for (int eedsp = 0; eedsp < numNBElem; eedsp++) {
783  int currElem = n2e_con[n2e_dsp[point_idx] + eedsp];
784 
785  // Loop over all nodes of the current element
786  for (int nndsp = 0; nndsp < MESH_SIZE; nndsp++) {
787  int nb = e2n_con[elem_start[currElem] + nndsp];
788 
789  if (nb == point_idx) continue; // skip self
790  if (!mark[nb]) {
791  mark[nb] = 1;
792  neighbors.push_back(nb);
793  }
794  }
795  }
796 
797  // Reset marks for the next iteration
798  for (int nb : neighbors) mark[nb] = 0;
799 
800  // Move neighbor list into the final container
801  thread_neighbors[point_idx] = std::move(neighbors);
802  }
803  }
804 
805  // Build prefix sums (serial, cheap compared to above)
806  for (int i = 0; i < num_pts; i++) {
807  n2n_dsp[i + 1] = n2n_dsp[i] + thread_neighbors[i].size();
808  }
809 
810  // Allocate once, then fill in parallel
811  n2n_connect.resize(n2n_dsp[num_pts]);
812 
813  #pragma omp parallel for schedule(static)
814  for (int i = 0; i < num_pts; i++) {
815  std::copy(thread_neighbors[i].begin(),
816  thread_neighbors[i].end(),
817  n2n_connect.begin() + n2n_dsp[i]);
818  }
819 
820  if (param_globals::output_level) {
821  log_msg(NULL, 0, 0, "Node-to-node graph done in %f sec.", timing(t2, t1));
822  }
823 }
824 
825 void eikonal_solver::precompute_squared_anisotropy_metric()
826 {
827  double t1, t2;
828  get_time(t1);
829 
830  const sf_mesh& mesh = get_mesh(intra_elec_msh);
831 
832  S.resize(mesh.l_numelem); // store anisotropy matrices (dimensionless)
833  CV_L.resize(mesh.l_numelem); // store CV_L per element for later use
834 
835  // temporary variables
836  SF::dmat<double> I(3, 3);
837  I.assign(0.0);
838  I.diag(1.0);
839 
840  #pragma omp parallel
841  {
842  SF::dmat<double> Saniso(3, 3);
843  SF::dmat<double> Ff(3, 3);
844  SF::dmat<double> diff(3, 3);
845  SF::Point f, s, n;
846 
847  #pragma omp for schedule(static)
848  for (int eidx = 0; eidx < mesh.l_numelem; eidx++) {
849  double vl = 0.0, vt = 0.0, vn = 0.0;
850 
851  // Find region match (break early when found)
852  for (int g = 0; g < param_globals::num_gregions; g++) {
853  const auto& reg = param_globals::gregion[g];
854  const auto& dream = reg.dream;
855  for (int j = 0; j < reg.num_IDs; j++) {
856  if (mesh.tag[eidx] == reg.ID[j]) {
857  vl = dream.vel_l;
858  vt = dream.vel_t;
859  vn = dream.vel_n;
860  goto region_found; // break out of both loops
861  }
862  }
863  }
864  region_found:;
865 
866  // Store CV_L directly (for later rescaling)
867  CV_L[eidx] = vl;
868 
869  // Compute anisotropy ratios relative to CV_L
870  double AR_T2 = (vl / vt) * (vl / vt);
871  double AR_N2 = (vl / vn) * (vl / vn);
872 
873  f.x = mesh.fib[3 * eidx + 0];
874  f.y = mesh.fib[3 * eidx + 1];
875  f.z = mesh.fib[3 * eidx + 2];
876 
877  if (twoFib) {
878  s.x = mesh.she[3 * eidx + 0];
879  s.y = mesh.she[3 * eidx + 1];
880  s.z = mesh.she[3 * eidx + 2];
881  n = cross(f, s);
882 
883  SF::outer_prod(f, f, 1.0, Saniso[0], false);
884  SF::outer_prod(s, s, AR_T2, Saniso[0], true);
885  SF::outer_prod(n, n, AR_N2, Saniso[0], true);
886  } else {
887  SF::outer_prod(f, f, 1.0, Ff[0], false);
888  diff = I - Ff;
889  diff *= AR_T2;
890 
891  Saniso = Ff + diff;
892  }
893 
894  S[eidx] = Saniso;
895  }
896  }
897 
898  if (param_globals::output_level)
899  log_msg(NULL, 0, 0, "Anisotropy tensors precomputed in %f sec.", timing(t2, t1));
900 }
901 
903 {
904  double t0, t1;
905  get_time(t0);
906 
907  // --- 0) Reset all activation times to infinity
908  std::fill(T_A.begin(), T_A.end(), inf);
909 
910  // --- 1) Build initial active list = neighbors of stimuli
911  std::vector<mesh_int_t> activeList;
912  activeList.reserve(num_pts / 10); // heuristic reserve to avoid frequent reallocs
913  std::vector<char> in_active(num_pts, 0);
914 
915  // Mark stimuli and seed neighbors
916  for (size_t si = 0; si < StimulusTimes.size() - 1; ++si) { // skip last entry, since its a -1 placeholder currently still used in DREAM
917  mesh_int_t s = StimulusPoints[si];
918  T_A[s] = StimulusTimes[si];
919 
920  for (int off = n2n_dsp[s]; off < n2n_dsp[s + 1]; ++off) {
921  mesh_int_t nb = n2n_connect[off];
922  if (T_A[nb] == inf) {
923  add_to_active(activeList, in_active, nb);
924  }
925  }
926  }
927 
928  // --- 2) Iterative solve of activeList
929  int niter = 0;
930  while (!activeList.empty() && niter <= param_globals::dream.fim.max_iter) {
931  const std::vector<mesh_int_t> activeVec = std::move(activeList);
932  activeList.clear();
933 
934  #pragma omp parallel
935  {
936  std::vector<mesh_int_t> local_active;
937  local_active.reserve(64); // small local buffer
938 
939  #pragma omp for schedule(dynamic)
940  for (size_t i = 0; i < activeVec.size(); ++i) {
941  mesh_int_t id = activeVec[i];
942  remove_from_active(in_active, id);
943 
944  SF_real p = T_A[id];
945  SF_real q = update(id);
946 
947  #pragma omp atomic write
948  T_A[id] = q;
949 
950  if (std::fabs(p - q) < param_globals::dream.fim.tol) {
951  for (int off = n2n_dsp[id]; off < n2n_dsp[id + 1]; ++off) {
952  mesh_int_t nb = n2n_connect[off];
953  p = T_A[nb];
954  q = update(nb);
955  if (p > q) {
956  #pragma omp atomic write
957  T_A[nb] = q;
958  local_active.push_back(nb);
959  }
960  }
961  } else {
962  local_active.push_back(id); // non-converged -> add back
963  }
964  }
965 
966  // Merge local results
967  #pragma omp critical
968  {
969  for (mesh_int_t nb : local_active) {
970  add_to_active(activeList, in_active, nb);
971  }
972  }
973  }
974  ++niter;
975  }
976 
977  // collect iteration stats
978  stats.update_iter(niter);
979  auto [minIt, maxIt] = std::minmax_element(T_A.begin(), T_A.end());
980  actMIN = *minIt;
981  actMAX = *maxIt;
982 
983  // --- 3) Copy into AT for output
984  double* atc = AT->ptr();
985  const SF_real* t_a = T_A.data();
986  #pragma omp parallel for simd
987  for (mesh_int_t i = 0; i < num_pts; ++i)
988  atc[i] = (t_a[i] == inf ? -1.0 : t_a[i]);
989  AT->release_ptr(atc);
990 
991  // --- 4) Timing & list‐size stats
992  auto dur = timing(t1, t0);
993  stats.slvtime_A += dur;
994  stats.minAT = actMIN;
995  stats.maxAT = actMAX;
996  stats.activeList = activeList.size();
997  stats.bc_status = true;
999 }
1000 
1002 {
1003  int niter = 0;
1004  double t1, t0;
1005  get_time(t0);
1006 
1007  if (sum(List) == 0) {
1008  compute_bc();
1009  }
1010 
1011  double time2stop_eikonal = param_globals::dream.tau_inc;
1012  float maxadvance = user_globals::tm_manager->time + param_globals::dream.tau_s + param_globals::dream.tau_inc + param_globals::dream.tau_max;
1013 
1014  do {
1015  if (StimulusTimes[Index_currStim] <= maxadvance) {
1016  compute_bc();
1017  }
1018 
1019  for (mesh_int_t indX = 0; indX < List.size(); indX++) {
1020  SF_real p = T_A[indX];
1021  SF_real q;
1022 
1023  if (List[indX] == 0) continue;
1024 
1025  q = compute_coherence(indX);
1026 
1027  T_A[indX] = q;
1028  num_changes[indX] = num_changes[indX] + 1;
1029 
1030  if (q > maxadvance) continue;
1031 
1032  if (abs(p - q) < param_globals::dream.fim.tol || (num_changes[indX] > param_globals::dream.fim.max_iter) || (q == inf || p == inf)) {
1033  for (int ii = n2n_dsp[indX]; ii < n2n_dsp[indX + 1]; ii++) {
1034  mesh_int_t indXNB = n2n_connect[ii];
1035 
1036  if (List[indXNB] == 1) {
1037  continue;
1038  }
1039 
1040  SF_real pNB = T_A[indXNB];
1041  SF_real qNB;
1042 
1043  qNB = compute_coherence(indXNB);
1044 
1045  bool node_is_valid = add_node_neighbor_to_list(T_R[indXNB], pNB, qNB) && qNB != inf && qNB > user_globals::tm_manager->time;
1046  // This second condition is there to be able to add a node to the list when a new valid activation time
1047  // is found but a reentry would be blocked by the L2 parameter. Normally this condition does not make or brake the
1048  // simulation but would leave individual nodes inactivated, which is not ideal.
1049  bool ignore_L2_if_valid = node_is_valid && qNB > pNB && nReadded2List[indXNB] >= param_globals::dream.fim.max_addpt;
1050 
1051  if (node_is_valid && (nReadded2List[indXNB] < param_globals::dream.fim.max_addpt) || ignore_L2_if_valid) {
1052  if (qNB > pNB) {
1053  nReadded2List[indXNB] = 0;
1054  }
1055  T_A[indXNB] = qNB;
1056  nReadded2List[indXNB]++;
1057  num_changes[indXNB] = 0;
1058  List[indXNB] = 1;
1059  if (param_globals::dream.output.debugNode == indXNB) {
1061  nodeData.idXNB = indX;
1062  nodeData.nbn_T_A = q;
1063  }
1064  }
1065  }
1066 
1067  List[indX] = 0;
1068  if (param_globals::dream.output.debugNode == indX) {
1070  }
1071  }
1072  }
1073 
1074  SF_real actMIN_old = actMIN;
1075  SF_real progress_time;
1076 
1077  update_Ta_in_active_list();
1078 
1079  if (actMIN > actMIN_old) {
1080  progress_time = actMIN - actMIN_old;
1081  } else {
1082  progress_time = 0;
1083  }
1084 
1085  time2stop_eikonal -= progress_time;
1086  niter++;
1087 
1088  } while (time2stop_eikonal > 0 && sum(List) > 0);
1089 
1090  if (sum(List) == 0) {
1092  }
1093 
1094  // copy for igb output
1095  double* atc = AT->ptr();
1096  double* rpt = RT->ptr();
1097  for (mesh_int_t i = 0; i < List.size(); i++) {
1098  if (T_A[i] == inf) {
1099  // for better visualization in meshalyzer
1100  atc[i] = -1;
1101  } else {
1102  atc[i] = T_A[i];
1103  }
1104  rpt[i] = T_R[i];
1105  }
1106  AT->release_ptr(atc);
1107  RT->release_ptr(rpt);
1108 
1109  // treat solver statistics
1110  auto dur = timing(t1, t0);
1111  stats.slvtime_A += dur;
1112  stats.update_iter(niter);
1113  stats.minAT = actMIN;
1114  stats.maxAT = actMAX;
1115  stats.activeList = sum(List);
1117 
1118  // treat node stats
1119  if (param_globals::dream.output.debugNode >= 0) {
1123  }
1124 
1125 } // close iterate list
1126 
1127 SF_real eikonal_solver::update(mesh_int_t& indX, SF_real CVrest_factor, bool isDREAM)
1128 {
1129  switch (MESH_SIZE) {
1130  case 4: return update_impl<4>(indX, CVrest_factor, isDREAM);
1131  case 3: return update_impl<3>(indX, CVrest_factor, isDREAM);
1132  case 2: return update_impl<2>(indX, CVrest_factor, isDREAM);
1133  default:
1134  return T_A[indX]; // fallback
1135  }
1136 }
1137 
1138 template <int N>
1139 SF_real eikonal_solver::update_impl(mesh_int_t& indX, SF_real CVrest_factor, bool CheckValidity)
1140 {
1141  double min = inf;
1142  const double time = user_globals::tm_manager->time;
1143  const sf_mesh& mesh = get_mesh(intra_elec_msh);
1144 
1145  // element-wise update
1146  for (int e_i = n2e_dsp[indX]; e_i < n2e_dsp[indX + 1]; e_i++) { // gather all elements the node belongs to
1147  int Elem_i = n2e_con[e_i];
1148  mesh_int_t indEle = elem_start[Elem_i];
1149  std::array<SF::Point, N> base; // points
1150  std::array<double, N> values; // activation times
1151  std::array<int, N> nodeIDs;
1152 
1153  std::size_t k = 0;
1154  for (std::size_t j = 0; j < N; j++) { // loop over nodes of element e_i
1155  int n_i = e2n_con[indEle + j];
1156  if (n_i != indX) {
1157  base[k].x = mesh.xyz[3 * n_i + 0]; base[k].y = mesh.xyz[3 * n_i + 1]; base[k].z = mesh.xyz[3 * n_i + 2];
1158  values[k] = T_A[n_i];
1159  nodeIDs[k] = n_i;
1160  k++;
1161  } else { // last slot is reserved for the current vertex we are solving for
1162  base[N - 1].x = mesh.xyz[3 * indX + 0]; base[N - 1].y = mesh.xyz[3 * indX + 1]; base[N - 1].z = mesh.xyz[3 * indX + 2];
1163  values[N - 1] = T_A[indX];
1164  nodeIDs[N - 1] = indX;
1165  }
1166  }
1167  // scale slowness metric by CV
1168  double cv = CV_L[Elem_i] * CVrest_factor;
1169  if (cv == 0.0) continue; // avoid 1/(cv*cv)
1170  SF::dmat<double> D = 1.0 / (cv * cv) * S[Elem_i];
1171 
1172  // 1) solve full N-simplex (eikonal run OR if valid for DREAM)
1173  if (!CheckValidity || !is_not_valid_update<N>(nodeIDs, time)) {
1174  LocalSolver<N> solver(D, base, values);
1175  SF_real tmp = solver.solve();
1176  if (min > tmp && tmp > T_R[indX] && compute_H(indX, tmp) > 0.0) {
1177  min = tmp;
1178  }
1179  continue;
1180  }
1181 
1182  // If the full N-simplex was not valid, we have to do additional checks for the DREAM,
1183  // since a subsimplex could be valid if e.g. only one node of a tet/triangle is invalid
1184  // 2) triangles that include the target (only done if MESH_SIZE is 4)
1185  if constexpr (N - 1 == 3) {
1186  // neighbor indices are 0..(N-2); choose pairs (i,j) and add target (N-1)
1187  for (int i = 0; i < (N - 1); ++i) {
1188  for (int j = i + 1; j < (N - 1); ++j) {
1189  // build nodeIDs/points/values for face {i, j, target}
1190  std::array<int, 3> tri_ids{nodeIDs[i], nodeIDs[j], nodeIDs[N - 1]};
1191  if (is_not_valid_update<3>(tri_ids, time)) continue;
1192 
1193  std::array<SF::Point, 3> tri_pts{base[i], base[j], base[N - 1]};
1194  std::array<double, 3> tri_vals{values[i], values[j], values[N - 1]};
1195 
1196  LocalSolver<3> solver(D, tri_pts, tri_vals);
1197  // min = std::min(min, solver.solve());
1198  SF_real tmp = solver.solve();
1199  if (min > tmp && tmp > T_R[indX] && compute_H(indX, tmp) > 0.0) {
1200  min = tmp;
1201  }
1202  }
1203  }
1204  }
1205 
1206  // 3) edges that include the target
1207  for (int i = 0; i < N - 1; i++) {
1208  std::array<int, 2> edge_ids{nodeIDs[i], nodeIDs[N - 1]};
1209  if (is_not_valid_update<2>(edge_ids, time)) continue;
1210 
1211  std::array<SF::Point, 2> edge_pts{base[i], base[N - 1]};
1212  std::array<double, 2> edge_vals{values[i], values[N - 1]};
1213 
1214  LocalSolver<2> solver(D, edge_pts, edge_vals);
1215  SF_real tmp = solver.solve();
1216  if (min > tmp && tmp > T_R[indX] && compute_H(indX, tmp) > 0.0) {
1217  min = tmp;
1218  }
1219  }
1220  }
1221 
1222  return min;
1223 }
1224 
1225 template <int N>
1226 bool eikonal_solver::is_not_valid_update(const std::array<int, N>& nodeIDs, double time)
1227 {
1228  const int target = nodeIDs[N - 1];
1229  const bool failedStim = (stim_status[target] == 2);
1230 
1231  for (int i = 0; i < N - 1; i++) {
1232  const int nb = nodeIDs[i];
1233 
1234  if (T_A[nb] < time) return true;
1235  if (T_A[nb] < T_R[nb]) return true;
1236  if (failedStim && stim_status[nb] == 1) return true;
1237  }
1238 
1239  return false;
1240 }
1241 
1242 SF_real eikonal_solver::compute_H(mesh_int_t& indX, SF_real& tmpTA)
1243 {
1244  // Apply a refractory delay if stimulus previously failed
1245  const double delay = (stim_status[indX] == 2) ? 5.0 : 0.0;
1246 
1247  // Early exit conditions
1248  if (tmpTA == inf ||
1249  (T_R[indX] + delay) == -400.0 ||
1250  std::fabs(tmpTA - TA_old[indX]) < param_globals::dream.fim.tol ||
1251  T_R[indX] > tmpTA) {
1252  return 1.0;
1253  }
1254 
1255  // Compute diastolic interval
1256  const double DI = tmpTA - (T_R[indX] + delay);
1257  D_I[indX] = DI;
1258 
1259  // CV restitution factor
1260  const double exponent = -(DI + kappa_cvrest[indX]) * denom_cvrest[indX];
1261  const double Factor_DI = 1.0 - rho_cvrest[indX] * std::exp(exponent);
1262 
1263  if (Factor_DI <= 0.0) {
1264  return 0.0;
1265  }
1266 
1267  // Apply restitution curve behavior
1268  return (DI <= theta_cvrest[indX]) ? -Factor_DI : Factor_DI;
1269 }
1270 
1271 SF_real eikonal_solver::compute_coherence(mesh_int_t& indX)
1272 {
1273  SF_real scaling = 1.0;
1274  SF_real p = T_A[indX]; // starting guess (previous arrival time)
1275  SF_real q = update(indX, scaling, true); // candidate new arrival time
1276 
1277  for (int niter = 0; niter < param_globals::dream.fim.max_coh; ++niter) {
1278  scaling = compute_H(indX, p); // restitution-based scaling for CV (can be negative mid-iteration)
1279  q = update(indX, std::fabs(scaling), true); // new candidate arrival time; use fabs() to allow intermediate negative scaling
1280 
1281  if (std::fabs(p - q) < param_globals::dream.fim.tol)
1282  break; // converged
1283 
1284  p = q; // continue iterating
1285  }
1286 
1287  // Only accept q if final state is physiologically valid
1288  return (compute_H(indX, q) < 0.0) ? T_A[indX] : q;
1289 }
1290 
1291 void eikonal_solver::compute_bc()
1292 {
1293  bool EmpList = sum(List) == 0;
1294 
1295  if (EmpList) {
1296  for (size_t j = Index_currStim; j < StimulusTimes.size(); j++) {
1297  if ((StimulusPoints[j] == -1) || (StimulusTimes[j] > StimulusTimes[Index_currStim])) {
1298  Index_currStim = j;
1299  break;
1300  }
1301 
1302  mesh_int_t indNode = StimulusPoints[j];
1303  SF_real TimeSt = StimulusTimes[j];
1304 
1305  bool cond2add = add_node_neighbor_to_list(T_R[indNode], T_A[indNode], TimeSt);
1306  if (cond2add && compute_H(indNode, TimeSt) > 0) {
1307  T_A[indNode] = TimeSt;
1308  stim_status[indNode] = 1;
1309  stats.bc_status = true;
1310 
1311  if (param_globals::dream.output.debugNode == indNode) {
1312  nodeData.T_A = TimeSt;
1314  }
1315 
1316  for (int ii = n2n_dsp[indNode]; ii < n2n_dsp[indNode + 1]; ii++) {
1317  mesh_int_t indXNB = n2n_connect[ii];
1318  if (List[indXNB] == 0) {
1319  List[indXNB] = 1;
1320  if (param_globals::dream.output.debugNode == indXNB) {
1322  nodeData.idXNB = indNode;
1323  nodeData.nbn_T_A = TimeSt;
1324  }
1325  }
1326  }
1327  }
1328 
1329  if (cond2add && compute_H(indNode, TimeSt) <= 0) {
1330  stim_status[indNode] = 2;
1331  }
1332  }
1333 
1334  // After NB of initial points are assigned remove initial points from the list if they were added in the previous loop.
1335  for (size_t j = 0; j < StimulusPoints.size(); j++) {
1336  if ((StimulusPoints[j] == -1) && (StimulusTimes[j] > StimulusTimes[Index_currStim])) continue;
1337  if (List[StimulusPoints[j]] == 1) {
1338  List[StimulusPoints[j]] = 0;
1339  if (param_globals::dream.output.debugNode == StimulusPoints[j]) nodeData.update_status(node_stats::out, node_stats::stim);
1340  }
1341  }
1342 
1344  } else {
1345  for (size_t i = Index_currStim; i < StimulusTimes.size(); i++) {
1346  mesh_int_t indNode = StimulusPoints[i];
1347  SF_real TimeSt = StimulusTimes[i];
1348 
1349  if (indNode == -1) continue;
1350 
1351  if (TimeSt <= actMAX) {
1352  bool cond2add = add_node_neighbor_to_list(T_R[indNode], T_A[indNode], TimeSt);
1353  if (cond2add && compute_H(indNode, TimeSt) > 0) {
1354  T_A[indNode] = TimeSt;
1355  stim_status[indNode] = 1;
1356  stats.bc_status = true;
1357 
1358  if (param_globals::dream.output.debugNode == indNode) {
1359  nodeData.T_A = TimeSt;
1361  }
1362 
1363  for (int ii = n2n_dsp[indNode]; ii < n2n_dsp[indNode + 1]; ii++) {
1364  mesh_int_t indXNB = n2n_connect[ii];
1365  if (List[indXNB] == 0) {
1366  List[indXNB] = 1;
1367  if (param_globals::dream.output.debugNode == indXNB) {
1369  nodeData.idXNB = indNode;
1370  nodeData.nbn_T_A = TimeSt;
1371  }
1372  }
1373  }
1374 
1375  for (size_t j = 0; j < StimulusPoints.size(); j++) {
1376  if ((StimulusPoints[j] == -1) && (StimulusTimes[j] > StimulusTimes[Index_currStim])) continue;
1377  if (List[StimulusPoints[j]] == 1) {
1378  List[StimulusPoints[j]] = 0;
1379  if (param_globals::dream.output.debugNode == StimulusPoints[j]) nodeData.update_status(node_stats::out, node_stats::stim);
1380  }
1381  }
1382  }
1383  if (cond2add && compute_H(indNode, TimeSt) <= 0) {
1384  stim_status[indNode] = 2;
1385  }
1386 
1387  } else {
1388  Index_currStim = i;
1389 
1390  break;
1391  }
1392  }
1393  }
1394 
1395 } // end compute stimulus
1396 
1398 {
1399  bool act_is_in_safety_window, empty_list_and_illegal_stimulus, empty_stimulus, stimulus_is_in_safety_window;
1400 
1401  act_is_in_safety_window = (actMIN > param_globals::dream.tau_s) && (actMIN - time > param_globals::dream.tau_s);
1402  empty_stimulus = (StimulusPoints[Index_currStim] == -1);
1403  stimulus_is_in_safety_window = (StimulusTimes[Index_currStim] - time > param_globals::dream.tau_s);
1404  empty_list_and_illegal_stimulus = (sum(List) == 0) && (empty_stimulus || stimulus_is_in_safety_window);
1405 
1406  return act_is_in_safety_window || empty_list_and_illegal_stimulus;
1407 }
1408 
1409 void eikonal_solver::update_Ta_in_active_list()
1410 {
1411  bool First_in_List = 1;
1412 
1413  for (size_t j = 0; j < List.size(); j++) {
1414  if (T_A[j] < 0) continue;
1415  if (List[j] == 1 && First_in_List) {
1416  actMIN = T_A[j];
1417  actMAX = T_A[j];
1418  First_in_List = 0;
1419  continue;
1420  }
1421  if (List[j] == 1) {
1422  if (T_A[j] < actMIN) actMIN = T_A[j];
1423  if (T_A[j] > actMAX) actMAX = T_A[j];
1424  }
1425  }
1426 }
1427 
1429 {
1430  for (size_t j = 0; j < List.size(); j++) {
1431  if (T_A[j] < user_globals::tm_manager->time) {
1432  TA_old[j] = T_A[j];
1433  stim_status[j] = 0;
1434  nReadded2List[j] = 0;
1435 
1436  if (List[j] == 1) List[j] = 0;
1437  }
1438  }
1439 }
1440 
1441 bool eikonal_solver::add_node_neighbor_to_list(SF_real& RT, SF_real& oldTA, SF_real& newTA)
1442 {
1443  // Condition (A): RT < newTA < oldTA
1444  // Condition (B): oldTA < RT < newTA
1445  return ((RT < newTA) && (newTA < oldTA)) ||
1446  ((oldTA < RT) && (RT < newTA));
1447 }
1448 
1450 {
1451  SF_real* old_ptr = Vmv_old.ptr();
1452  SF_real* new_ptr = Vmv.ptr();
1453 
1454  const double thresh = param_globals::dream.repol_time_thresh;
1455 
1456  for (int ind_nodes = 0; ind_nodes < num_pts; ind_nodes++) {
1457  if (old_ptr[ind_nodes] >= thresh && new_ptr[ind_nodes] < thresh) {
1458  T_R[ind_nodes] = time;
1459  }
1460  }
1461 
1462  Vmv_old.release_ptr(old_ptr);
1463  Vmv.release_ptr(new_ptr);
1464 }
1465 
1467 {
1468  double t1, t0;
1469  get_time(t0);
1470 
1471  #ifdef _OPENMP
1472  int max_threads = omp_get_max_threads();
1473  omp_set_num_threads(1); // with the current setup of this function, it is better to run it in serial.
1474  #endif
1475 
1476  limpet::MULTI_IF* miif = ion.miif;
1477 
1478  const double time = user_globals::tm_manager->time,
1480 
1481  for (int i = 0; i < miif->N_IIF; i++) {
1482  if (!miif->N_Nodes[i]) continue;
1483  limpet::IonIfBase* pIF = ion.miif->IIF[i];
1484  limpet::IonIfBase* IIF_old = pIF->get_type().make_ion_if(pIF->get_target(),
1485  pIF->get_num_node(),
1486  ion.miif->plugtypes[i]);
1487  IIF_old->copy_SVs_from(*pIF, false);
1488 
1489  int current = 0;
1490  do {
1491  int ind_gb = (miif->NodeLists[i][current]);
1492  // Global index of current node;
1493  // save states at the moment
1494  double Vm_old = miif->ldata[i][limpet::Vm][current];
1495  double Iion_old = miif->ldata[i][limpet::Iion][current];
1496  double prev_R = T_R[ind_gb];
1497 
1498  bool cond_2upd = T_R[ind_gb] <= T_A[ind_gb] && T_A[ind_gb] != inf && Vm_old > param_globals::dream.repol_time_thresh;
1499 
1500  if (cond_2upd) {
1501  double elapsed_time = 0;
1502  double prev_Vm = miif->ldata[i][limpet::Vm][current];
1503 
1504  do {
1505  elapsed_time += dt;
1506  pIF->compute(current, current + 1, miif->ldata[i]);
1507  miif->ldata[i][limpet::Vm][current] -= miif->ldata[i][limpet::Iion][current] * param_globals::dt;
1508  if (miif->ldata[i][limpet::Vm][current] < param_globals::dream.repol_time_thresh) {
1509  T_R[ind_gb] = time + elapsed_time;
1510  break;
1511  }
1512  } while (elapsed_time < 600);
1513 
1514  // Restore old states
1515  miif->ldata[i][limpet::Vm][current] = Vm_old;
1516  miif->ldata[i][limpet::Iion][current] = Iion_old;
1517  }
1518  current++;
1519  } while (current < miif->N_Nodes[i]);
1520  pIF->copy_SVs_from(*IIF_old, false);
1521  }
1522 
1523  #ifdef _OPENMP
1524  omp_set_num_threads(max_threads); // restore max threads for parabolic solver
1525  #endif
1526 
1527  // treat solver statistics
1528  auto dur = timing(t1, t0);
1529  stats.slvtime_D += dur;
1530 }
1531 
1533 {
1534  double t0, t1;
1535  get_time(t0);
1536 
1537  SF_real* c = Idiff->ptr();
1538  SF_real* v = vm.ptr();
1539 
1540  const sf_mesh& mesh = get_mesh(intra_elec_msh);
1541  const SF::vector<mesh_int_t>& alg_nod = mesh.pl.algebraic_nodes();
1542  int rank = get_rank();
1543 
1544  for (size_t j = 0; j < alg_nod.size(); j++) {
1545  mesh_int_t loc_nodal_idx = alg_nod[j];
1546  mesh_int_t loc_petsc_idx = local_nodal_to_local_petsc(mesh, rank, loc_nodal_idx);
1547 
1548  double TA = T_A[loc_nodal_idx];
1549  if (!(time >= TA && (TA + 5) >= time && List[loc_nodal_idx] == 0))
1550  continue;
1551 
1552  double dT = time - TA;
1553  auto& node = diff_cur[loc_nodal_idx];
1554 
1555  switch (node.model) {
1556  case GAUSS: {
1557  double term1 = (dT - node.beta_1) / node.gamma_1;
1558  double term2 = (dT - node.beta_2) / node.gamma_2;
1559  double term3 = (dT - node.beta_3) / node.gamma_3;
1560  c[loc_petsc_idx] = node.alpha_1 * exp(-term1 * term1) + node.alpha_2 * exp(-term2 * term2) + node.alpha_3 * exp(-term3 * term3);
1561  break;
1562  }
1563  default: {
1564  double e_on = (dT >= 0.0) ? 1.0 : 0.0;
1565  double e_off = (v[loc_petsc_idx] < node.V_th) ? 1.0 : 0.0;
1566  c[loc_petsc_idx] = node.A_F / node.tau_F * exp(dT / node.tau_F) * e_on * e_off;
1567  break;
1568  }
1569  }
1570  }
1571 
1572  Idiff->release_ptr(c);
1573  vm.release_ptr(v);
1574 
1575  stats.slvtime_B += timing(t1, t0);
1576 }
1577 
1578 void eikonal_solver::save_eikonal_state(const char* tsav_ext)
1579 {
1580  if (get_rank() == 0) {
1581  FILE* file_writestate;
1582  char buffer_writestate[1024];
1583  snprintf(buffer_writestate, sizeof buffer_writestate, "%s.%s.roe.dat", param_globals::write_statef, tsav_ext);
1584  file_writestate = fopen(buffer_writestate, "w");
1585  for (size_t jjj = 0; jjj < List.size(); jjj++) {
1586  fprintf(file_writestate, "%d %d %d %f %f %f %f \n", List[jjj], num_changes[jjj], nReadded2List[jjj], T_A[jjj], T_R[jjj], TA_old[jjj], D_I[jjj]);
1587  }
1588 
1589  fclose(file_writestate);
1590  }
1591 }
1592 
1593 void eikonal_solver::load_state_file()
1594 {
1595  set_dir(INPUT);
1596  FILE* file_startstate;
1597  char buffer_startstate[strlen(param_globals::start_statef) + 10];
1598 
1599  snprintf(buffer_startstate, sizeof buffer_startstate, "%s.dat", param_globals::start_statef);
1600  file_startstate = fopen(buffer_startstate, "r");
1601 
1602  if (file_startstate == NULL) {
1603  log_msg(NULL, 5, 0, "Not able to open state file: %s", buffer_startstate);
1604  } else if (param_globals::output_level) {
1605  log_msg(NULL, 0, 0, "Open state file for eikonal model: %s", buffer_startstate);
1606  }
1607 
1608  int ListVal, numChangesVal, numChanges2Val;
1609  float T_AVal, T_RVal, TA_oldVal, D_IVal, PCLVal;
1610  int index = 0;
1611 
1612  while (fscanf(file_startstate, "%d %d %d %f %f %f %f", &ListVal, &numChangesVal, &numChanges2Val, &T_AVal, &T_RVal, &TA_oldVal, &D_IVal) == 7) {
1613  List[index] = ListVal;
1614  num_changes[index] = numChangesVal;
1615  nReadded2List[index] = numChanges2Val;
1616  T_A[index] = T_AVal;
1617  T_R[index] = T_RVal;
1618  TA_old[index] = TA_oldVal;
1619  D_I[index] = D_IVal;
1620  ++index;
1621  }
1622  if (param_globals::output_level) log_msg(NULL, 0, 0, "Number of nodes in active list: %i", sum(List));
1623 
1624  fclose(file_startstate);
1625 }
1626 
1628 {
1629  logger = f_open(filename, "w");
1630 
1631  const char* h1 = " ------ ---------- ---------- ------- ------- | List logic ----- -------- | Neighbor node ---- |";
1632  const char* h2 = " cycle AT old AT RT DI | Status Entry Exit | ID AT |";
1633 
1634  if (logger == NULL)
1635  log_msg(NULL, 3, 0, "%s error: Could not open file %s in %s. Turning off logging.\n",
1636  __func__, filename);
1637  else {
1638  log_msg(logger, 0, 0, "%s", h1);
1639  log_msg(logger, 0, 0, "%s", h2);
1640  }
1641 }
1642 
1643 void node_stats::log_stats(double time, bool cflg)
1644 {
1645  if (!this->logger) return;
1646 
1647  char abuf[256];
1648  char bbuf[256];
1649  char cbuf[256];
1650 
1651  // create nicer output in logger for inf, -inf, nan
1652  std::ostringstream oss_TA, oss_TA_, oss_TR, oss_DI, oss_nbnTA;
1653  oss_TA << this->T_A;
1654  oss_TA_ << this->T_A_;
1655  oss_TR << this->T_R;
1656  oss_DI << this->D_I;
1657  oss_nbnTA << this->nbn_T_A;
1658 
1659  if (this->idXNB == std::numeric_limits<Int>::min()) {
1660  snprintf(cbuf, sizeof cbuf, "%7s %10s", "-", "-");
1661  } else {
1662  snprintf(cbuf, sizeof cbuf, "%7d %10s", this->idXNB, oss_nbnTA.str().c_str());
1663  }
1664 
1665  snprintf(abuf, sizeof abuf, "%6d %10s %10s %7s %7s", this->cycle, oss_TA.str().c_str(), oss_TA_.str().c_str(), oss_TR.str().c_str(), oss_DI.str().c_str());
1666  snprintf(bbuf, sizeof bbuf, "%7s %8s %8s", this->status, this->reasonIn, this->reasonOut);
1667 
1668  unsigned char flag = cflg ? ECHO : 0;
1669  log_msg(this->logger, 0, flag | FLUSH | NONL, "%9.3f %s | %s | %s |\n", time, abuf, bbuf, cbuf);
1670 
1671  this->reasonIn = "-";
1672  this->reasonOut = "-";
1673  this->T_A_ = this->T_A;
1674  this->T_A = std::numeric_limits<double>::quiet_NaN();
1675  this->T_R = std::numeric_limits<double>::quiet_NaN();
1676  this->D_I = std::numeric_limits<double>::quiet_NaN();
1678  this->nbn_T_A = std::numeric_limits<double>::quiet_NaN();
1679  this->cycle++;
1680 }
1681 
1683 {
1684  // directly convert enums to strings for logging
1685  const char* stat_str;
1686  const char* reas_str;
1687  switch (s) {
1688  case node_stats::in: stat_str = "in"; break;
1689  case node_stats::out: stat_str = "out"; break;
1690  }
1691 
1692  switch (r) {
1693  case node_stats::none: reas_str = "-"; break;
1694  case node_stats::nbn: reas_str = "nbn"; break;
1695  case node_stats::conv: reas_str = "conv"; break;
1696  case node_stats::stim: reas_str = "stim"; break;
1697  }
1698 
1699  this->status = stat_str;
1700  if (s == in) {
1701  this->reasonIn = reas_str;
1702  } else {
1703  this->reasonOut = reas_str;
1704  }
1705 }
1706 
1707 template<int MESH_SIZE>
1709  const SF::Point& x1 = points[0];
1710  const SF::Point& x2 = points[1];
1711  const SF::Point& x3 = points[2];
1712  const SF::Point& x4 = points[3];
1713 
1714  const double& u1 = values[0];
1715  const double& u2 = values[1];
1716  const double& u3 = values[2];
1717 
1718  if constexpr (MESH_SIZE == 2) {
1719  return tsitsiklis_update_line({x1,x2}, D, u1);
1720 
1721  } else if constexpr (MESH_SIZE == 3) {
1722  return tsitsiklis_update_triangle({x1,x2,x3}, D, {u1,u2});
1723 
1724  } else if constexpr (MESH_SIZE == 4) {
1725  double u_tet = tsitsiklis_update_tetra({x1,x2,x3,x4}, D, {u1,u2,u3});
1726  if (isnan(u_tet)) {
1727  u_tet = std::numeric_limits<double>::infinity();
1728  }
1729  // face calculations (contains edge update as fallback)
1730  double u_face1 = tsitsiklis_update_triangle({x1, x2, x4}, D, {u1, u2});
1731  double u_face2 = tsitsiklis_update_triangle({x1, x3, x4}, D, {u1, u3});
1732  double u_face3 = tsitsiklis_update_triangle({x2, x3, x4}, D, {u2, u3});
1733 
1734  double u_tri = std::min({u_face1, u_face2, u_face3});
1735  return std::min(u_tet, u_tri);
1736  }
1737 }
1738 
1739 template <int MESH_SIZE>
1740 double LocalSolver<MESH_SIZE>::tsitsiklis_update_line(const std::array<SF::Point, 2>& base,
1741  const SF::dmat<double>& D,
1742  const double& value)
1743 {
1744  // Compute the difference vector: a1 = x2 - x1
1745  SF::Point a1 = base[1] - base[0];
1746  // Return updated value at x2: u1 + norm
1747  return value + std::sqrt(SF::inner_prod(a1, D * a1));
1748 }
1749 
1750 template <int MESH_SIZE>
1751 double LocalSolver<MESH_SIZE>::tsitsiklis_update_triangle(const std::array<SF::Point, 3>& base,
1752  const SF::dmat<double>& D,
1753  const std::array<double, 2>& values)
1754 {
1755  const SF::Point& x1 = base[0];
1756  const SF::Point& x2 = base[1];
1757  const SF::Point& x3 = base[2];
1758  const double& u1 = values[0];
1759  const double& u2 = values[1];
1760  double result = std::numeric_limits<double>::infinity();
1761 
1762  SF::Point z1 = x1 - x2;
1763  SF::Point z2 = x2 - x3;
1764  double k = u1 - u2;
1765 
1766  // Squared Mahalanobis norms
1767  const SF::Point Dz1 = D * z1;
1768  const SF::Point Dz2 = D * z2;
1769  double p11 = SF::inner_prod(z1, Dz1);
1770  double p12 = SF::inner_prod(z1, Dz2);
1771  double p22 = SF::inner_prod(z2, Dz2);
1772 
1773  double denominator = p11 - k * k;
1774  double sqrt_val = (p11 * p22 - p12 * p12) / denominator;
1775 
1776  if (denominator > 1e-12) { // avoid dividing by zero or near zero -> k very small, likely due to collapsed triangle/coinciding points
1777  const double sqrt_val = (p11 * p22 - p12 * p12) / denominator;
1778  if (sqrt_val >= 0.0) { // only real solutions are considered
1779  const double rhs = k * std::sqrt(sqrt_val);
1780  double alpha1 = -(p12 + rhs) / p11;
1781  double alpha2 = -(p12 - rhs) / p11;
1782 
1783  alpha1 = std::clamp(alpha1, 0.0, 1.0);
1784  alpha2 = std::clamp(alpha2, 0.0, 1.0);
1785 
1786  for (double alpha : {alpha1, alpha2}) {
1787  SF::Point x_interp = x1 * alpha + x2 * (1.0 - alpha);
1788  SF::Point dist = x3 - x_interp;
1789  double norm_D = std::sqrt(SF::inner_prod(dist, D * dist));
1790  double u3 = alpha * u1 + (1.0 - alpha) * u2 + norm_D;
1791  result = std::min(result, u3);
1792  }
1793  }
1794  }
1795 
1796  // Fallback: point-based update if square root was invalid or denominator is too small
1797  double u_edge1 = tsitsiklis_update_line({x1,x3}, D, u1);
1798  double u_edge2 = tsitsiklis_update_line({x2,x3}, D, u2);
1799 
1800  return std::min({result, u_edge1, u_edge2});
1801 }
1802 
1803 template <int MESH_SIZE>
1804 double LocalSolver<MESH_SIZE>::tsitsiklis_update_tetra(const std::array<SF::Point, 4>& base,
1805  const SF::dmat<double>& D,
1806  const std::array<double, 3>& values)
1807 {
1808  const SF::Point& x1 = base[0];
1809  const SF::Point& x2 = base[1];
1810  const SF::Point& x3 = base[2];
1811  const SF::Point& x4 = base[3];
1812 
1813  const double& u1 = values[0];
1814  const double& u2 = values[1];
1815  const double& u3 = values[2];
1816 
1817  // edge vectors
1818  const SF::Point y1 = x3 - x1;
1819  const SF::Point y2 = x3 - x2;
1820  const SF::Point y3 = x4 - x3;
1821 
1822  const double k1 = u1 - u3;
1823  const double k2 = u2 - u3;
1824 
1825  // Matrix products (squared norms and dot products under metric D)
1826  const SF::Point Dy1 = D * y1;
1827  const SF::Point Dy2 = D * y2;
1828  const SF::Point Dy3 = D * y3;
1829  const double r11 = SF::inner_prod(y1, Dy1);
1830  const double r12 = SF::inner_prod(y1, Dy2);
1831  const double r13 = SF::inner_prod(y1, Dy3);
1832  const double r21 = r12;
1833  const double r22 = SF::inner_prod(y2, Dy2);
1834  const double r23 = SF::inner_prod(y2, Dy3);
1835  const double r31 = r13;
1836  const double r32 = r23;
1837 
1838  const double A1 = k2 * r11 - k1 * r12;
1839  const double A2 = k2 * r21 - k1 * r22;
1840  const double B = k2 * r31 - k1 * r32;
1841  const double k = k1 - (A1 / A2) * k2;
1842  const SF::Point z1 = y1 - (A1 / A2) * y2;
1843  const SF::Point z2 = y3 - (B / A2) * y2;
1844 
1845  // compute quadratic equation
1846  const SF::Point Dz1 = D * z1;
1847  const SF::Point Dz2 = D * z2;
1848  const double p11 = SF::inner_prod(z1, Dz1);
1849  const double p12 = SF::inner_prod(z1, Dz2);
1850  const double p22 = SF::inner_prod(z2, Dz2);
1851  const double denominator = p11 - k*k;
1852  const double sqrt_val = (p11 * p22 - (p12 * p12)) / denominator;
1853  const double rhs = k * std::sqrt(sqrt_val);
1854 
1855  double alpha1 = -(p12 + rhs) / p11;
1856  double alpha2 = -(B + alpha1 * A1) / A2;
1857 
1858  // handle degenerate cases
1859  const double EPS = 1e-16;
1860  if ((std::abs(A1) < EPS) && (std::abs(A2) < EPS)) {
1861  alpha1 = (r12 * r23 - r13 * r22) / (r11 * r22 - (r12 * r12));
1862  alpha2 = (r12 * r13 - r11 * r23) / (r11 * r22 - (r12 * r12));
1863  } else if ((std::abs(A1) < EPS) && (std::abs(A2) > EPS)) {
1864  alpha1 = 0;
1865  alpha2 = -B / A2;
1866  } else if ((std::abs(A1) > EPS) && (std::abs(A2) < EPS)) {
1867  alpha1 = -B / A1;
1868  alpha2 = 0;
1869  }
1870 
1871  double alpha3 = 1 - alpha1 - alpha2;
1872  const SF::Point dist = x4 - (alpha1 * x1 + alpha2 * x2 + alpha3 * x3);
1873  // barycentric coordinate should be inside the tetrahedron
1874  if (alpha1 < -EPS || alpha2 < -EPS || alpha3 < -EPS ||
1875  alpha1 > 1.0+EPS || alpha2 > 1.0+EPS || alpha3 > 1.0+EPS) {
1876  return std::numeric_limits<double>::infinity();
1877  } else {
1878  return alpha1 * u1 + alpha2 * u2 + alpha3 * u3 + std::sqrt(SF::inner_prod(dist, D * dist));
1879  }
1880 }
1881 
1882 } // namespace opencarp
void output(vector< int > nodes, IGBheader *h, char *ofname, enum_format of, int t0, int t1, int stride, bool explode, float scale)
Definition: IGBextract.cc:208
int mesh_int_t
Definition: SF_container.h:46
double SF_real
Use the general double as real type.
Definition: SF_globals.h:38
Basic utility structs and functions, mostly IO related.
#define FLUSH
Definition: basics.h:311
#define ECHO
Definition: basics.h:308
#define NONL
Definition: basics.h:312
virtual void write(const char *filename) const =0
virtual S * ptr()=0
virtual void release_ptr(S *&p)=0
virtual void add_scaled(const abstract_vector< T, S > &vec, S k)=0
overlapping_layout< T > pl
nodal parallel layout
Definition: SF_container.h:429
vector< T > dsp
connectivity starting index of each element
Definition: SF_container.h:416
vector< S > she
sheet direction
Definition: SF_container.h:421
vector< elem_t > type
element type
Definition: SF_container.h:418
vector< T > con
Definition: SF_container.h:412
size_t l_numpts
local number of points
Definition: SF_container.h:401
Container for a PETSc VecScatter.
size_t size() const
The current size of the vector.
Definition: SF_vector.h:104
void resize(size_t n)
Resize a vector.
Definition: SF_vector.h:209
const T * end() const
Pointer to the vector's end.
Definition: SF_vector.h:128
void assign(InputIterator s, InputIterator e)
Assign a memory range.
Definition: SF_vector.h:161
void reserve(size_t n)
Definition: SF_vector.h:241
const T * begin() const
Pointer to the vector's start.
Definition: SF_vector.h:116
T * data()
Pointer to the vector's start.
Definition: SF_vector.h:91
T & push_back(T val)
Definition: SF_vector.h:283
Represents the ionic model and plug-in (IMP) data structure.
Definition: ION_IF.h:139
const IonType & get_type() const
Gets this IMP's model type.
Definition: ION_IF.cc:144
virtual void copy_SVs_from(IonIfBase &other, bool alloc)=0
Copies the state variables of an IMP.
Target get_target() const
Definition: ION_IF.h:339
int get_num_node() const
Gets the number of nodes handled by this IMP.
Definition: ION_IF.cc:148
void compute(int start, int end, GlobalData_t **data)
Perform ionic model computation for 1 time step.
Definition: ION_IF.cc:270
virtual IonIfBase * make_ion_if(Target target, int num_node, const std::vector< std::reference_wrapper< IonType >> &plugins) const =0
Generate an IonIf object from this type.
std::vector< IonIfBase * > IIF
array of IIF's
Definition: MULTI_ION_IF.h:202
opencarp::sf_vec * gdata[NUM_IMP_DATA_TYPES]
data used by all IMPs
Definition: MULTI_ION_IF.h:216
std::vector< IonTypeList > plugtypes
plugins types for each region
Definition: MULTI_ION_IF.h:215
void dump_state(char *, float, opencarp::mesh_t gid, bool, unsigned int)
GlobalData_t *** ldata
data local to each IMP
Definition: MULTI_ION_IF.h:205
int N_IIF
how many different IIF's
Definition: MULTI_ION_IF.h:211
int * N_Nodes
#nodes for each IMP
Definition: MULTI_ION_IF.h:200
int ** NodeLists
local partitioned node lists for each IMP stored
Definition: MULTI_ION_IF.h:201
int timer_idx
the timer index received from the timer manager
Definition: physics_types.h:66
FILE_SPEC logger
The logger of the physic, each physic should have one.
Definition: physics_types.h:64
const char * name
The name of the physic, each physic should have one.
Definition: physics_types.h:62
std::string timer_unit(const int timer_id)
figure out units of a signal linked to a given timer
SF::vector< stimulus > stimuli
the electrical stimuli
parabolic_solver parab_solver
Solver for the parabolic bidomain equation.
MaterialType mtype[2]
the material types of intra_grid and extra_grid grids.
void destroy()
Currently we only need to close the file logger.
double timer_val(const int timer_id)
figure out current value of a signal linked to a given timer
sf_vec * phie_dummy
no elliptic solver needed, but we need a dummy for phie to use parabolic solver
eikonal_solver eik_solver
Solver for the eikonal equation.
LAT_detector lat
the activation time detector
gvec_data gvec
datastruct holding global IMP state variable output
generic_timing_stats IO_stats
grid_t
An electrics grid identifier to distinguish between intra and extra grids.
igb_output_manager output_manager_cycle
void initialize()
Initialize the Eikonal class.
igb_output_manager output_manager_time
class handling the igb output
limpet::MULTI_IF * miif
Definition: ionics.h:66
void compute_step()
Definition: ionics.cc:35
void initialize()
Definition: ionics.cc:60
void destroy()
Definition: ionics.cc:52
int check_quiescence(double tm, double dt)
check for quiescence
Definition: electrics.cc:1731
void output_initial_activations()
output one nodal vector of initial activation time
Definition: electrics.cc:1840
void init(sf_vec &vm, sf_vec &phie, int offset, enum physic_t=elec_phys)
initializes all datastructs after electric solver setup
Definition: electrics.cc:1556
int check_acts(double tm)
check activations at sim time tm
Definition: electrics.cc:1676
void FIM()
Standard fast iterative method to solve eikonal equation with active list approach.
void update_repolarization_times_from_rd(sf_vec &Vmv, sf_vec &Vmv_old, double time)
Updates node repolarization times based on transmembrane voltage crossing.
SF::vector< SF_real > T_R
void init_imp_region_properties()
Initializes diffusion current models and CV restitution parameters per mesh node.
SF::vector< mesh_int_t > n2e_dsp
SF::vector< SF_real > T_A
SF::vector< SF_real > TA_old
SF::vector< diffusion_current > diff_cur
void init()
Initialize vectors and variables in the eikonal_solver class.
SF::vector< mesh_int_t > e2n_con
bool determine_model_to_run(double &time)
Determine the next model to run in the alternation between RD and Eikonal.
SF::vector< mesh_int_t > stim_status
SF::vector< mesh_int_t > elem_start
SF::vector< mesh_int_t > StimulusPoints
SF::vector< SF_real > rho_cvrest
std::vector< double > CV_L
void save_eikonal_state(const char *tsav_ext)
Save the current state of variables related to the Eikonal simulation to a file to initialize a futur...
SF::vector< SF_real > denom_cvrest
void compute_diffusion_current(const double &time, sf_vec &vm)
Computes the stimulus-driven diffusion current at mesh nodes.
std::vector< mesh_int_t > n2n_connect
void set_stimuli(SF::vector< stimulus > &stimuli)
Simple setter for stimulus vector.
SF::vector< mesh_int_t > e2n_cnt
SF::vector< mesh_int_t > n2e_con
void clean_list()
Clean the list of nodes by resetting their status and tracking changes based on the time step of the ...
SF::vector< SF_real > D_I
SF::vector< mesh_int_t > nReadded2List
SF::vector< SF_real > theta_cvrest
SF::vector< mesh_int_t > num_changes
std::vector< mesh_int_t > n2n_dsp
SF::vector< SF_real > StimulusTimes
SF::vector< SF_real > kappa_cvrest
SF::vector< mesh_int_t > n2e_cnt
void cycFIM()
Implementation of the cyclical fast iterative method used in step A of the DREAM model.
void update_repolarization_times(const Ionics &ion)
Estimates initial repolarization times (T_R) in Step D of DREAM.
eikonal_solver_stats stats
std::vector< SF::dmat< double > > S
void write_data()
write registered data to disk
Definition: sim_utils.cc:1480
void close_files_and_cleanup()
close file descriptors
Definition: sim_utils.cc:1527
void register_output(sf_vec *inp_data, const mesh_t inp_meshid, const int dpn, const char *name, const char *units, const SF::vector< mesh_int_t > *idx=NULL, bool elem_data=false)
Register a data vector for output.
Definition: sim_utils.cc:1447
sf_mat * rhs_parab
rhs matrix to solve parabolic
Definition: electrics.h:119
lin_solver_stats stats
Definition: electrics.h:129
void rebuild_matrices(MaterialType *mtype, limpet::MULTI_IF &miif, FILE_SPEC logger)
Definition: electrics.cc:1208
void solve(sf_vec &phie_i)
Definition: electrics.cc:1321
sf_mat * mass_i
lumped for parabolic problem
Definition: electrics.h:118
sf_mat * lhs_parab
lhs matrix (CN) to solve parabolic
Definition: electrics.h:120
sf_vec * Vmv
global Vm vector
Definition: electrics.h:104
sf_vec * old_vm
older Vm needed for 2nd order dT
Definition: electrics.h:110
int write_trace()
write traces to file
Definition: signals.h:701
stim_t type
type of stimulus
Definition: stimulate.h:136
int npls
number of stimulus pulses
Definition: stimulate.h:119
double pcl
pacing cycle length
Definition: stimulate.h:120
double start
start time of protocol
Definition: stimulate.h:118
sig::time_trace wave
wave form of stimulus pulse
Definition: stimulate.h:96
stim_protocol ptcl
applied stimulation protocol used
Definition: stimulate.h:166
stim_pulse pulse
stimulus wave form
Definition: stimulate.h:165
void translate(int id)
convert legacy definitions to new format
Definition: stimulate.cc:100
bool is_active() const
Return whether stim is active.
Definition: stimulate.cc:185
void setup(int idx)
Setup from a param stimulus index.
Definition: stimulate.cc:161
stim_physics phys
physics of stimulus
Definition: stimulate.h:167
std::string name
label stimulus
Definition: stimulate.h:164
double time_step
global reference time step
Definition: timer_utils.h:78
int add_eq_timer(double istart, double iend, int ntrig, double iintv, double idur, const char *iname, const char *poolname=nullptr)
Add a equidistant step timer to the array of timers.
Definition: timer_utils.cc:78
double time
current time
Definition: timer_utils.h:76
Diffusion Reaction Eikonal Alternant Model (DREAM) based on the electrics physics class.
void transpose_connectivity(const vector< T > &a_cnt, const vector< T > &a_con, vector< T > &b_cnt, vector< T > &b_con)
Transpose CRS matrix graph A into B.
double inner_prod(const Point &a, const Point &b)
Definition: SF_container.h:90
T sum(const vector< T > &vec)
Compute sum of a vector's entries.
Definition: SF_vector.h:340
void count(const vector< T > &data, vector< S > &cnt)
Count number of occurrences of indices.
Definition: SF_vector.h:332
void outer_prod(const Point &a, const Point &b, const double s, double *buff, const bool add=false)
Definition: SF_container.h:95
T local_nodal_to_local_petsc(const meshdata< T, S > &mesh, int rank, T local_nodal)
size_t root_count_ascii_lines(std::string file, MPI_Comm comm)
count the lines in a ascii file
void init_vector(SF::abstract_vector< T, S > **vec)
Definition: SF_init.h:99
V clamp(const V val, const W start, const W end)
Clamp a value into an interval [start, end].
Definition: kdpart.hpp:132
void cnt_from_dsp(const std::vector< T > &dsp, std::vector< T > &cnt)
Compute counts from displacements.
Definition: kdpart.hpp:149
void dsp_from_cnt(const std::vector< T > &cnt, std::vector< T > &dsp)
Compute displacements from counts.
Definition: kdpart.hpp:140
constexpr T min(T a, T b)
Definition: ion_type.h:33
void dump_trace(MULTI_IF *MIIF, limpet::Real time)
void open_trace(MULTI_IF *MIIF, int n_traceNodes, int *traceNodes, int *label, opencarp::sf_mesh *imesh)
Set up ionic model traces at some global node numbers.
timer_manager * tm_manager
a manager for the various physics timers
Definition: main.cc:58
bool using_legacy_stimuli
flag storing whether legacy stimuli are used
Definition: main.cc:64
int stimidx_from_timeridx(const SF::vector< stimulus > &stimuli, const int timer_id)
determine link between timer and stimulus
Definition: electrics.cc:805
@ iotm_chkpt_list
Definition: timer_utils.h:44
@ iotm_console
Definition: timer_utils.h:44
@ iotm_trace
Definition: timer_utils.h:44
@ iotm_chkpt_intv
Definition: timer_utils.h:44
SF::scattering * get_scattering(const int from, const int to, const SF::SF_nbr nbr, const int dpn)
Get a scattering from the global scatter registry.
sf_mesh & get_mesh(const mesh_t gt)
Get a mesh by specifying the gridID.
Definition: sf_interface.cc:33
SF::scattering * register_scattering(const int from, const int to, const SF::SF_nbr nbr, const int dpn)
Register a scattering between to grids, or between algebraic and nodal representation of data on the ...
Definition: sf_interface.cc:65
SF::scattering * get_permutation(const int mesh_id, const int perm_id, const int dpn)
Get the PETSC to canonical permutation scattering for a given mesh and number of dpn.
SF::meshdata< mesh_int_t, mesh_real_t > sf_mesh
Definition: sf_interface.h:47
void apply_stim_to_vector(const stimulus &s, sf_vec &vec, bool add)
Definition: electrics.cc:470
int set_dir(IO_t dest)
Definition: sim_utils.cc:483
vec3< V > cross(const vec3< V > &a, const vec3< V > &b)
Definition: vect.h:144
int get_rank(MPI_Comm comm=PETSC_COMM_WORLD)
Definition: basics.h:276
V dist(const vec3< V > &p1, const vec3< V > &p2)
Definition: vect.h:114
@ Vm_clmp
Definition: stimulate.h:77
const char * get_mesh_type_name(mesh_t t)
get a char* to the name of a mesh type
Definition: sf_interface.cc:46
void region_mask(mesh_t meshspec, SF::vector< RegionSpecs > &regspec, SF::vector< int > &regionIDs, bool mask_elem, const char *reglist)
classify elements/points as belonging to a region
Definition: ionics.cc:362
void init_stim_info(void)
uses potential for stimulation
Definition: stimulate.cc:49
FILE_SPEC f_open(const char *fname, const char *mode)
Open a FILE_SPEC.
Definition: basics.cc:135
SF::scattering * register_permutation(const int mesh_id, const int perm_id, const int dpn)
Register a permutation between two orderings for a mesh.
void setup_dataout(const int dataout, std::string dataout_vtx, mesh_t grid, SF::vector< mesh_int_t > *&restr, bool async)
Definition: electrics.cc:635
@ OUTPUT
Definition: sim_utils.h:53
void init_sv_gvec(gvec_data &GVs, limpet::MULTI_IF *miif, sf_vec &tmpl, igb_output_manager &output_manager)
Definition: ionics.cc:566
void assemble_sv_gvec(gvec_data &gvecs, limpet::MULTI_IF *miif)
Definition: ionics.cc:637
char * dupstr(const char *old_str)
Definition: basics.cc:44
void log_msg(FILE_SPEC out, int level, unsigned char flag, const char *fmt,...)
Definition: basics.cc:72
mesh_t
The enum identifying the different meshes we might want to load.
Definition: sf_interface.h:58
@ extra_elec_msh
Definition: sf_interface.h:60
@ intra_elec_msh
Definition: sf_interface.h:59
void get_time(double &tm)
Definition: basics.h:436
bool mesh_is_registered(const mesh_t gt)
check wheter a SF mesh is set
Definition: sf_interface.cc:59
SF::abstract_vector< SF_int, SF_real > sf_vec
Definition: sf_interface.h:49
int get_size(MPI_Comm comm=PETSC_COMM_WORLD)
Definition: basics.h:290
const char * get_tsav_ext(double time)
Definition: electrics.cc:890
V timing(V &t2, const V &t1)
Definition: basics.h:448
void f_close(FILE_SPEC &f)
Close a FILE_SPEC.
Definition: basics.cc:162
@ ElecMat
Definition: fem_types.h:39
#define PETSC_TO_CANONICAL
Permute algebraic data from PETSC to canonical ordering.
Definition: sf_interface.h:74
#define ALG_TO_NODAL
Scatter algebraic to nodal.
Definition: sf_interface.h:72
#define ELEM_PETSC_TO_CANONICAL
Permute algebraic element data from PETSC to canonical ordering.
Definition: sf_interface.h:76
#define EXP_POSTPROCESS
Definition: sim_utils.h:161
Electrical stimulation functions.
Point and vector struct.
Definition: SF_container.h:65
double y
Definition: SF_container.h:67
double z
Definition: SF_container.h:68
double x
Definition: SF_container.h:66
description of materal properties in a mesh
Definition: fem_types.h:110
SF::vector< RegionSpecs > regions
array with region params
Definition: fem_types.h:115
SF::vector< double > el_scale
optionally provided per-element params scale
Definition: fem_types.h:116
region based variations of arbitrary material parameters
Definition: fem_types.h:93
physMaterial * material
material parameter description
Definition: fem_types.h:98
int nsubregs
#subregions forming this region
Definition: fem_types.h:96
int * subregtags
FEM tags forming this region.
Definition: fem_types.h:97
char * regname
name of region
Definition: fem_types.h:94
int regID
region ID
Definition: fem_types.h:95
double slvtime_A
total time in Step A
Definition: timers.h:45
void log_stats(double time, bool cflg)
Definition: timers.cc:130
double minAT
minimum activation time in current solve
Definition: timers.h:40
double maxAT
maximum activation time in current solve
Definition: timers.h:42
void init_logger(const char *filename)
Definition: timers.cc:114
int activeList
number of nodes currently in list
Definition: timers.h:38
void update_iter(const int curiter)
Definition: timers.cc:162
double slvtime_B
total time in Step B
Definition: timers.h:47
double slvtime_D
total time in Step D
Definition: timers.h:49
bool bc_status
boundary conditions were applied?
Definition: timers.h:53
void update_cli(double time, bool cflg)
Definition: timers.cc:168
File descriptor struct.
Definition: basics.h:133
void log_stats(double tm, bool cflg)
Definition: timers.cc:93
void init_logger(const char *filename)
Definition: timers.cc:77
int calls
# calls for this interval, this is incremented externally
Definition: timers.h:70
double tot_time
total time, this is incremented externally
Definition: timers.h:72
void log_stats(double tm, bool cflg)
Definition: timers.cc:27
const char * reasonOut
reason for list entry
SF_real T_R
repolarization time
void init_logger(const char *filename)
void log_stats(double tm, bool cflg)
SF_real D_I
diastolic interval
mesh_int_t idXNB
neighboring node index responsible for list entry
const char * reasonIn
reason for list entry
SF_real T_A_
previous activation time
SF_real T_A
current activation time
SF_real nbn_T_A
activation time of neighboring node
mesh_int_t cycle
DREAM cycle.
mesh_int_t idX
node index
void update_status(enum status s, enum reason r)