CoreNEURON
main1.cpp
Go to the documentation of this file.
1 /*
2 # =============================================================================
3 # Copyright (c) 2016 - 2022 Blue Brain Project/EPFL
4 #
5 # See top-level LICENSE file for details.
6 # =============================================================================.
7 */
8 
9 /**
10  * @file main1.cpp
11  * @date 26 Oct 2014
12  * @brief File containing main driver routine for CoreNeuron
13  */
14 
15 #include <cstring>
16 #include <climits>
17 #include <dlfcn.h>
18 #include <memory>
19 #include <vector>
20 
23 #include "coreneuron/nrnconf.h"
26 #include "coreneuron/mpi/nrnmpi.h"
48 
49 extern "C" {
50 const char* corenrn_version() {
52 }
53 
54 // the CORENEURON_USE_LEGACY_UNITS determined by CORENRN_ENABLE_LEGACY_UNITS
56  return CORENEURON_USE_LEGACY_UNITS;
57 }
58 
60 
61 /**
62  * If "export OMP_NUM_THREADS=n" is not set then omp by default sets
63  * the number of threads equal to the number of cores on this node.
64  * If there are a number of mpi processes on this node as well, things
65  * can go very slowly as there are so many more threads than cores.
66  * Assume the NEURON users pc.nthread() is well chosen if
67  * OMP_NUM_THREADS is not set.
68  */
69 void set_openmp_threads(int nthread) {
70 #if defined(_OPENMP)
71  if (!getenv("OMP_NUM_THREADS")) {
72  omp_set_num_threads(nthread);
73  }
74 #endif
75 }
76 
77 /**
78  * Convert char* containing arguments from neuron to char* argv[] for
79  * coreneuron command line argument parser.
80  */
81 char* prepare_args(int& argc, char**& argv, int use_mpi, const char* mpi_lib, const char* arg) {
82  // first construct all arguments as string
83  std::string args(arg);
84  args.insert(0, " coreneuron ");
85  args.append(" --skip-mpi-finalize ");
86  if (use_mpi) {
87  args.append(" --mpi ");
88  }
89 
90  // if neuron has passed name of MPI library then add it to CLI
91  std::string corenrn_mpi_lib{mpi_lib};
92  if (!corenrn_mpi_lib.empty()) {
93  args.append(" --mpi-lib ");
94  corenrn_mpi_lib += " ";
95  args.append(corenrn_mpi_lib);
96  }
97 
98  // we can't modify string with strtok, make copy
99  char* first = strdup(args.c_str());
100  const char* sep = " ";
101 
102  // first count the no of argument
103  char* token = strtok(first, sep);
104  argc = 0;
105  while (token) {
106  token = strtok(nullptr, sep);
107  argc++;
108  }
109  free(first);
110 
111  // now build char*argv
112  argv = new char*[argc];
113  first = strdup(args.c_str());
114  token = strtok(first, sep);
115  for (int i = 0; token; i++) {
116  argv[i] = token;
117  token = strtok(nullptr, sep);
118  }
119 
120  // return actual data to be freed
121  return first;
122 }
123 }
124 
125 namespace coreneuron {
126 void call_prcellstate_for_prcellgid(int prcellgid, int compute_gpu, int is_init);
127 
128 // bsize = 0 then per step transfer
129 // bsize > 1 then full trajectory save into arrays.
132  for (int tid = 0; tid < nrn_nthread; ++tid) {
133  NrnThread& nt = nrn_threads[tid];
134  int n_pr;
135  int n_trajec;
136  int* types;
137  int* indices;
138  void** vpr;
139  double** varrays;
140  double** pvars;
141 
142  // bsize is passed by reference, the return value will determine if
143  // per step return or entire trajectory return.
144  (*nrn2core_get_trajectory_requests_)(
145  tid, bsize, n_pr, vpr, n_trajec, types, indices, pvars, varrays);
147  if (n_trajec) {
149  nt.trajec_requests = tr;
150  tr->bsize = bsize;
151  tr->n_pr = n_pr;
152  tr->n_trajec = n_trajec;
153  tr->vsize = 0;
154  tr->vpr = vpr;
155  tr->gather = new double*[n_trajec];
156  tr->varrays = varrays;
157  tr->scatter = pvars;
158  for (int i = 0; i < n_trajec; ++i) {
159  tr->gather[i] = stdindex2ptr(types[i], indices[i], nt);
160  }
161  delete[] types;
162  delete[] indices;
163  }
164  }
165  }
166 }
167 
169  char* argv[],
170  CheckPoints& checkPoints,
171  bool is_mapping_needed,
172  bool run_setup_cleanup) {
173 #if defined(NRN_FEEXCEPT)
174  nrn_feenableexcept();
175 #endif
176 
177  /// profiler like tau/vtune : do not measure from begining
179 
180  // memory footprint after mpi initialisation
181  if (!corenrn_param.is_quiet()) {
182  report_mem_usage("After MPI_Init");
183  }
184 
185  // initialise default coreneuron parameters
186  initnrn();
187 
188  // set global variables
189  // precedence is: set by user, globals.dat, 34.0
191 
192 #if CORENEURON_ENABLE_GPU
194  fprintf(stderr,
195  "compiled with CORENEURON_ENABLE_GPU does not allow the combination of "
196  "--cell-permute=2 and "
197  "missing --gpu\n");
198  exit(1);
199  }
201  fprintf(stderr,
202  "compiled with OpenACC/CUDA does not allow the combination of --cuda-interface and "
203  "missing --gpu\n");
204  exit(1);
205  }
206 #endif
207 
208 // if multi-threading enabled, make sure mpi library supports it
209 #if NRNMPI
212  }
213 #endif
214 
215  // full path of files.dat file
216  std::string filesdat(corenrn_param.datpath + "/" + corenrn_param.filesdat);
217 
218  // read the global variable names and set their values from globals.dat
220 
221  // set global variables for start time, timestep and temperature
222  if (!corenrn_embedded) {
223  t = checkPoints.restore_time();
224  }
225 
226  if (corenrn_param.dt != -1000.) { // command line arg highest precedence
227  dt = corenrn_param.dt;
228  } else if (dt == -1000.) { // not on command line and no dt in globals.dat
229  dt = 0.025; // lowest precedence
230  }
231 
232  corenrn_param.dt = dt;
233 
234  rev_dt = (int) (1. / dt);
235 
236  if (corenrn_param.celsius != -1000.) { // command line arg highest precedence
238  } else if (celsius == -1000.) { // not on command line and no celsius in globals.dat
239  celsius = 34.0; // lowest precedence
240  }
241 
243 
244  // create net_cvode instance
245  mk_netcvode();
246 
247  // One part done before call to nrn_setup. Other part after.
248 
249  if (!corenrn_param.patternstim.empty()) {
251  }
252 
253  if (!corenrn_param.is_quiet()) {
254  report_mem_usage("Before nrn_setup");
255  }
256 
257  // set if need to interleave cells
261 
263  if (nrnmpi_myid == 0) {
264  printf(
265  " WARNING : GPU execution requires --cell-permute type 1 or 2. Setting it to 1.\n");
266  }
268  use_solve_interleave = true;
269  }
270 
271  // multisend options
274  use_phase2_ = (corenrn_param.ms_phases == 2) ? 1 : 0;
275 
276  // reading *.dat files and setting up the data structures, setting mindelay
277  nrn_setup(filesdat.c_str(),
278  is_mapping_needed,
279  checkPoints,
280  run_setup_cleanup,
281  corenrn_param.datpath.c_str(),
282  checkPoints.get_restore_path().c_str(),
284 
285  // Allgather spike compression and bin queuing.
287  int spkcompress = corenrn_param.spkcompress;
288  nrnmpi_spike_compress(spkcompress, (spkcompress ? true : false), use_multisend_);
289 
290  if (!corenrn_param.is_quiet()) {
291  report_mem_usage("After nrn_setup ");
292  }
293 
294  // Invoke PatternStim
295  if (!corenrn_param.patternstim.empty()) {
297  }
298 
299  /// Setting the timeout
300  nrn_set_timeout(200.);
301 
302  // show all configuration parameters for current run
303  if (nrnmpi_myid == 0 && !corenrn_param.is_quiet()) {
304  std::cout << corenrn_param << std::endl;
305  std::cout << " Start time (t) = " << t << std::endl << std::endl;
306  }
307 
308  // allocate buffer for mpi communication
310 
311  if (!corenrn_param.is_quiet()) {
312  report_mem_usage("After mk_spikevec_buffer");
313  }
314 
315  // In direct mode there are likely trajectory record requests
316  // to allow processing in NEURON after simulation by CoreNEURON
317  if (corenrn_embedded) {
318  // arg is additional vector size required (how many items will be
319  // written to the double*) but NEURON can instead
320  // specify that returns will be on a per time step basis.
322 
323  // In direct mode, CoreNEURON has exactly the behavior of
324  // ParallelContext.psolve(tstop). Ie a sequence of such calls
325  // without an intervening h.finitialize() continues from the end
326  // of the previous call. I.e., all initial state, including
327  // the event queue has been set up in NEURON. And, at the end
328  // all final state, including the event queue will be sent back
329  // to NEURON. Here there is some first time only
330  // initialization and queue transfer.
332  clear_spike_vectors(); // PreSyn send already recorded by NEURON
333  (*nrn2core_part2_clean_)();
334  }
335 
336  if (corenrn_param.gpu) {
337  // Copy nrnthreads to device only after all the data are passed from NEURON and the
338  // nrnthreads on CPU are properly set up
340  }
341 
342  if (corenrn_embedded) {
343  // Run nrn_init of mechanisms only to allocate any extra data needed on the GPU after
344  // nrnthreads are properly set up on the GPU
346  }
347 
348  if (corenrn_param.gpu) {
349  if (nrn_have_gaps) {
351  }
352  }
353 
354  // call prcellstate for prcellgid
356 }
357 
358 void call_prcellstate_for_prcellgid(int prcellgid, int compute_gpu, int is_init) {
359  char prcellname[1024];
360 #ifdef ENABLE_CUDA
361  const char* prprefix = "cu";
362 #else
363  const char* prprefix = "acc";
364 #endif
365 
366  if (prcellgid >= 0) {
367  if (compute_gpu) {
368  if (is_init)
369  sprintf(prcellname, "%s_gpu_init", prprefix);
370  else
371  sprintf(prcellname, "%s_gpu_t%f", prprefix, t);
372  } else {
373  if (is_init)
374  strcpy(prcellname, "cpu_init");
375  else
376  sprintf(prcellname, "cpu_t%f", t);
377  }
379  prcellstate(prcellgid, prcellname);
380  }
381 }
382 
383 /* perform forwardskip and call prcellstate for prcellgid */
384 void handle_forward_skip(double forwardskip, int prcellgid) {
385  double savedt = dt;
386  double savet = t;
387 
388  dt = forwardskip * 0.1;
389  t = -1e9;
390  dt2thread(-1.);
391 
392  for (int step = 0; step < 10; ++step) {
394  }
395 
396  if (prcellgid >= 0) {
397  prcellstate(prcellgid, "fs");
398  }
399 
400  dt = savedt;
401  t = savet;
402  dt2thread(-1.);
403 
404  // clear spikes generated during forward skip (with negative time)
406 }
407 
408 std::string cnrn_version() {
409  return version::to_string();
410 }
411 
412 
413 static void trajectory_return() {
415  for (int tid = 0; tid < nrn_nthread; ++tid) {
416  NrnThread& nt = nrn_threads[tid];
418  if (tr && tr->varrays) {
419  (*nrn2core_trajectory_return_)(tid, tr->n_pr, tr->bsize, tr->vsize, tr->vpr, nt._t);
420  }
421  }
422  }
423 }
424 
425 std::unique_ptr<ReportHandler> create_report_handler(const ReportConfiguration& config,
426  const SpikesInfo& spikes_info) {
427  std::unique_ptr<ReportHandler> report_handler;
428  if (config.format == "Bin") {
429  report_handler = std::make_unique<BinaryReportHandler>();
430  } else if (config.format == "SONATA") {
431  report_handler = std::make_unique<SonataReportHandler>(spikes_info);
432  } else {
433  if (nrnmpi_myid == 0) {
434  printf(" WARNING : Report name '%s' has unknown format: '%s'.\n",
435  config.name.data(),
436  config.format.data());
437  }
438  return nullptr;
439  }
440  return report_handler;
441 }
442 
443 } // namespace coreneuron
444 
445 /// The following high-level functions are marked as "extern C"
446 /// for compat with C, namely Neuron mod files.
447 /// They split the previous solve_core so that intermediate init of external mechanisms can occur.
448 /// See mech/corenrnmech.cpp for the new all-in-one solve_core (not compiled into the coreneuron
449 /// lib since with nrnivmodl-core we have 'future' external mechanisms)
450 
451 using namespace coreneuron;
452 
453 #if NRNMPI && defined(CORENEURON_ENABLE_MPI_DYNAMIC)
454 static void* load_dynamic_mpi(const std::string& libname) {
455  dlerror();
456  void* handle = dlopen(libname.c_str(), RTLD_NOW | RTLD_GLOBAL);
457  const char* error = dlerror();
458  if (error) {
459  std::string err_msg = std::string("Could not open dynamic MPI library: ") + error + "\n";
460  throw std::runtime_error(err_msg);
461  }
462  return handle;
463 }
464 #endif
465 
466 extern "C" void mk_mech_init(int argc, char** argv) {
467  // reset all parameters to their default values
469 
470  // read command line parameters and parameter config files
471  corenrn_param.parse(argc, argv);
472 
473 #if NRNMPI
475 #ifdef CORENEURON_ENABLE_MPI_DYNAMIC
476  // coreneuron rely on neuron to detect mpi library distribution and
477  // the name of the library itself. Make sure the library name is specified
478  // via CLI option.
479  if (corenrn_param.mpi_lib.empty()) {
480  throw std::runtime_error(
481  "For dynamic MPI support you must pass '--mpi-lib "
482  "/path/libcorenrnmpi_<name>.<suffix>` argument!\n");
483  }
484 
485  // neuron can call coreneuron multiple times and hence we do not
486  // want to initialize/load mpi library multiple times
487  static bool mpi_lib_loaded = false;
488  if (!mpi_lib_loaded) {
489  auto mpi_handle = load_dynamic_mpi(corenrn_param.mpi_lib);
490  mpi_manager().resolve_symbols(mpi_handle);
491  mpi_lib_loaded = true;
492  }
493 #endif
494  auto ret = nrnmpi_init(&argc, &argv, corenrn_param.is_quiet());
495  nrnmpi_numprocs = ret.numprocs;
496  nrnmpi_myid = ret.myid;
497  }
498 #endif
499 
500 #ifdef CORENEURON_ENABLE_GPU
501  if (corenrn_param.gpu) {
502  init_gpu();
507  }
508 #endif
509 
510  if (!corenrn_param.writeParametersFilepath.empty()) {
511  std::ofstream out(corenrn_param.writeParametersFilepath, std::ios::trunc);
512  out << corenrn_param.config_to_str(false, false);
513  out.close();
514  }
515 
516  // reads mechanism information from bbcore_mech.dat
517  mk_mech((corenrn_param.datpath).c_str());
518 }
519 
520 extern "C" int run_solve_core(int argc, char** argv) {
522 
523  std::vector<ReportConfiguration> configs;
524  std::vector<std::unique_ptr<ReportHandler>> report_handlers;
525  SpikesInfo spikes_info;
526  bool reports_needs_finalize = false;
527 
528  if (!corenrn_param.is_quiet()) {
529  report_mem_usage("After mk_mech");
530  }
531 
532  // Create outpath if it does not exist
533  if (nrnmpi_myid == 0) {
534  mkdir_p(corenrn_param.outpath.c_str());
535  }
536 
537  if (!corenrn_param.reportfilepath.empty()) {
540  spikes_info);
541  reports_needs_finalize = !configs.empty();
542  }
543 
545 
546  // initializationa and loading functions moved to separate
547  {
548  Instrumentor::phase p("load-model");
549  nrn_init_and_load_data(argc, argv, checkPoints, !configs.empty());
550  }
551 
552  std::string output_dir = corenrn_param.outpath;
553 
554  if (nrnmpi_myid == 0) {
555  mkdir_p(output_dir.c_str());
556  }
557 #if NRNMPI
559  nrnmpi_barrier();
560  }
561 #endif
562  bool compute_gpu = corenrn_param.gpu;
563 
564  nrn_pragma_acc(update device(celsius, secondorder, pi) if (compute_gpu))
565  nrn_pragma_omp(target update to(celsius, secondorder, pi) if (compute_gpu))
566  {
567  double v = corenrn_param.voltage;
568  double dt = corenrn_param.dt;
569  double delay = corenrn_param.mindelay;
570  double tstop = corenrn_param.tstop;
571 
572  if (tstop < t && nrnmpi_myid == 0) {
573  printf("Error: Stop time (%lf) < Start time (%lf), restoring from checkpoint? \n",
574  tstop,
575  t);
576  abort();
577  }
578 
579  // TODO : if some ranks are empty then restore will go in deadlock
580  // phase (as some ranks won't have restored anything and hence return
581  // false in checkpoint_initialize
582  if (!corenrn_embedded && !checkPoints.initialize()) {
583  nrn_finitialize(v != 1000., v);
584  }
585 
586  if (!corenrn_param.is_quiet()) {
587  report_mem_usage("After nrn_finitialize");
588  }
589 
590  // register all reports into reportinglib
591  double min_report_dt = INT_MAX;
592  for (size_t i = 0; i < configs.size(); i++) {
593  std::unique_ptr<ReportHandler> report_handler = create_report_handler(configs[i],
594  spikes_info);
595  if (report_handler) {
596  report_handler->create_report(configs[i], dt, tstop, delay);
597  report_handlers.push_back(std::move(report_handler));
598  }
599  if (configs[i].report_dt < min_report_dt) {
600  min_report_dt = configs[i].report_dt;
601  }
602  }
603  // Set the buffer size if is not the default value. Otherwise use report.conf on
604  // register_report
607  }
608 
609  if (!configs.empty()) {
610  setup_report_engine(min_report_dt, delay);
611  configs.clear();
612  }
613 
614  // call prcellstate for prcellgid
616 
617  // handle forwardskip
618  if (corenrn_param.forwardskip > 0.0) {
619  Instrumentor::phase p("handle-forward-skip");
621  }
622 
623  /// Solver execution
625  Instrumentor::phase_begin("simulation");
627  Instrumentor::phase_end("simulation");
629 
630  // update cpu copy of NrnThread from GPU
632 
633  // direct mode and full trajectory gathering on CoreNEURON, send back.
634  if (corenrn_embedded) {
636  }
637 
638  // Report global cell statistics
639  if (!corenrn_param.is_quiet()) {
641  }
642 
643  // prcellstate after end of solver
645  }
646 
647  // write spike information to outpath
648  {
649  Instrumentor::phase p("output-spike");
650  output_spikes(output_dir.c_str(), spikes_info);
651  }
652 
653  // copy weights back to NEURON NetCon
655  // first update weights from gpu
657 
658  // store weight pointers
659  std::vector<double*> weights(nrn_nthread, nullptr);
660 
661  // could be one thread more (empty) than in NEURON but does not matter
662  for (int i = 0; i < nrn_nthread; ++i) {
664  }
665  (*nrn2core_all_weights_return_)(weights);
666  }
667 
669 
670  {
671  Instrumentor::phase p("checkpoint");
672  checkPoints.write_checkpoint(nrn_threads, nrn_nthread);
673  }
674 
675  // must be done after checkpoint (to avoid deleting events)
676  if (reports_needs_finalize) {
677  finalize_report();
678  }
679 
680  // cleanup threads on GPU
681  if (corenrn_param.gpu) {
683  if (nrn_have_gaps) {
685  }
690  }
691 
692  // Cleaning the memory
693  nrn_cleanup();
694 
695  // tau needs to resume profile
697 
698 // mpi finalize
699 #if NRNMPI
701  nrnmpi_finalize();
702  }
703 #endif
704 
705  Instrumentor::phase_end("main");
706 
707  return 0;
708 }
coreneuron::report_cell_stats
void report_cell_stats()
Reports global cell statistics of the simulation.
Definition: nrn_stats.cpp:30
coreneuron::corenrn_parameters_data::outpath
std::string outpath
Directory path where .dat files.
Definition: corenrn_parameters.hpp:87
coreneuron::cellorder_nwarp
int cellorder_nwarp
Definition: balance.cpp:24
coreneuron::handle_forward_skip
void handle_forward_skip(double forwardskip, int prcellgid)
Definition: main1.cpp:384
coreneuron::delete_trajectory_requests
void delete_trajectory_requests(NrnThread &nt)
Definition: nrn_setup.cpp:899
coreneuron::corenrn_parameters_data::skip_mpi_finalize
bool skip_mpi_finalize
Enable MPI flag.
Definition: corenrn_parameters.hpp:60
coreneuron::corenrn_parameters_data::datpath
std::string datpath
Apply patternstim using the specified spike file.
Definition: corenrn_parameters.hpp:86
coreneuron::mpi_manager
mpi_manager_t & mpi_manager()
Definition: nrnmpi.h:51
coreneuron::corenrn_parameters_data::ms_phases
unsigned ms_phases
Gid of cell for prcellstate.
Definition: corenrn_parameters.hpp:50
coreneuron::CheckPoints
Definition: nrn_checkpoint.hpp:17
coreneuron::setup_nrnthreads_on_device
void setup_nrnthreads_on_device(NrnThread *threads, int nthreads)
Definition: nrn_acc_manager.cpp:466
coreneuron::corenrn_parameters_data::nwarp
unsigned nwarp
Cell interleaving permutation.
Definition: corenrn_parameters.hpp:54
coreneuron::corenrn_parameters_data::celsius
double celsius
I/O timestep to use in msec for reports.
Definition: corenrn_parameters.hpp:79
multisend.hpp
prepare_args
char * prepare_args(int &argc, char **&argv, int use_mpi, const char *mpi_lib, const char *arg)
Convert char* containing arguments from neuron to char* argv[] for coreneuron command line argument p...
Definition: main1.cpp:81
coreneuron::nrn_use_bin_queue_
bool nrn_use_bin_queue_
Flag to use the bin queue.
Definition: netcvode.cpp:39
nrnran123.h
coreneuron::corenrn_parameters::is_quiet
bool is_quiet()
Definition: corenrn_parameters.hpp:109
coreneuron::corenrn_parameters_data::cell_interleave_permute
unsigned cell_interleave_permute
Spike Compression.
Definition: corenrn_parameters.hpp:53
coreneuron::corenrn_parameters_data::writeParametersFilepath
std::string writeParametersFilepath
Enable checkpoint and specify directory to store related files.
Definition: corenrn_parameters.hpp:92
coreneuron::nrn_nthread
int nrn_nthread
Definition: multicore.cpp:55
coreneuron::corenrn_parameters::parse
void parse(int argc, char *argv[])
Destructor defined in .cpp where CLI11 types are complete.
Definition: corenrn_parameters.cpp:184
utils.hpp
coreneuron::rev_dt
int rev_dt
Definition: register_mech.cpp:23
prcellstate.hpp
coreneuron::delete_nrnthreads_on_device
void delete_nrnthreads_on_device(NrnThread *threads, int nthreads)
Cleanup device memory that is being tracked by the OpenACC runtime.
Definition: nrn_acc_manager.cpp:1151
coreneuron::nrnmpi_finalize
mpi_function< cnrn_make_integral_constant_t(nrnmpi_finalize_impl)> nrnmpi_finalize
Definition: nrnmpidec.cpp:16
nrn2core_direct.h
coreneuron::TrajectoryRequests::vsize
int vsize
Definition: multicore.hpp:65
coreneuron::nrnmpi_barrier
mpi_function< cnrn_make_integral_constant_t(nrnmpi_barrier_impl)> nrnmpi_barrier
Definition: nrnmpidec.cpp:42
coreneuron::nrnmpi_numprocs
int nrnmpi_numprocs
Definition: nrnmpi_def_cinc.cpp:10
coreneuron::dt2thread
void dt2thread(double adt)
Definition: fadvance_core.cpp:70
coreneuron::NrnThread::_t
double _t
Definition: multicore.hpp:76
coreneuron::corenrn_parameters_data::report_buff_size_default
static constexpr int report_buff_size_default
Definition: corenrn_parameters.hpp:46
coreneuron::Instrumentor::stop_profile
static void stop_profile()
Definition: profiler_interface.h:304
coreneuron::mpi_manager_t::resolve_symbols
void resolve_symbols(void *dlsym_handle)
Definition: resolve.cpp:7
coreneuron::update_nrnthreads_on_host
void update_nrnthreads_on_host(NrnThread *threads, int nthreads)
Definition: nrn_acc_manager.cpp:1012
coreneuron::nrn_partrans::copy_gap_indices_to_device
void copy_gap_indices_to_device()
Definition: partrans.cpp:133
coreneuron::corenrn_parameters_data::threading
bool threading
Use Multisend spike exchange instead of Allgather.
Definition: corenrn_parameters.hpp:62
output_spikes.hpp
coreneuron::TrajectoryRequests::n_trajec
int n_trajec
Definition: multicore.hpp:63
coreneuron::Instrumentor::start_profile
static void start_profile()
Definition: profiler_interface.h:300
nrn_acc_manager.hpp
coreneuron::init_gpu
void init_gpu()
coreneuron::nrnran123_destroy_global_state_on_device
void nrnran123_destroy_global_state_on_device()
Definition: nrnran123.cpp:154
report_handler.hpp
coreneuron::BBS_netpar_solve
void BBS_netpar_solve(double tstop)
Definition: netpar.cpp:604
set_openmp_threads
void set_openmp_threads(int nthread)
If "export OMP_NUM_THREADS=n" is not set then omp by default sets the number of threads equal to the ...
Definition: main1.cpp:69
coreneuron::corenrn_parameters_data::prcellgid
int prcellgid
Internal buffer used on every rank for spikes.
Definition: corenrn_parameters.hpp:49
nrn_pragma_omp
nrn_pragma_acc(routine seq) nrn_pragma_omp(declare target) philox4x32_ctr_t coreneuron_random123_philox4x32_helper(coreneuron nrn_pragma_omp(end declare target) namespace coreneuron
Provide a helper function in global namespace that is declared target for OpenMP offloading to functi...
Definition: nrnran123.h:69
coreneuron::ReportConfiguration::name
std::string name
Definition: nrnreport.hpp:86
coreneuron::cnrn_target_delete
void cnrn_target_delete(std::string_view file, int line, T *h_ptr, std::size_t len=1)
Definition: offload.hpp:132
nrn_stats.h
Function declarations for the cell statistics.
coreneuron::call_prcellstate_for_prcellgid
void call_prcellstate_for_prcellgid(int prcellgid, int compute_gpu, int is_init)
Definition: main1.cpp:358
coreneuron::stdindex2ptr
double * stdindex2ptr(int mtype, int index, NrnThread &nt)
Definition: nrn_setup.cpp:636
coreneuron::corenrn_parameters::reset
void reset()
Runs the CLI11_PARSE macro.
Definition: corenrn_parameters.cpp:179
coreneuron::Instrumentor::phase_begin
static void phase_begin(const char *name)
Definition: profiler_interface.h:308
coreneuron::corenrn_parameters_data::report_buff_size
unsigned report_buff_size
Number of gpus to use per node.
Definition: corenrn_parameters.hpp:56
coreneuron::initnrn
void initnrn()
Definition: register_mech.cpp:102
coreneuron::corenrn_parameters_data::gpu
bool gpu
Enable pthread/openmp.
Definition: corenrn_parameters.hpp:63
coreneuron::interleave_permute_type
int interleave_permute_type
Definition: cellorder.cpp:28
coreneuron::trajectory_return
static void trajectory_return()
Definition: main1.cpp:413
coreneuron::update_weights_from_gpu
void update_weights_from_gpu(NrnThread *threads, int nthreads)
Copy weights from GPU to CPU.
Definition: nrn_acc_manager.cpp:1112
coreneuron::direct_mode_initialize
void direct_mode_initialize()
All state from NEURON necessary to continue a run.
Definition: nrn2core_data_init.cpp:50
profiler_interface.h
coreneuron::use_multisend_
bool use_multisend_
Definition: multisend.cpp:53
coreneuron::nrn_set_timeout
int nrn_set_timeout(int timeout)
Definition: netpar.cpp:598
coreneuron::CheckPoints::restore_time
double restore_time() const
todo : need to broadcast this rather than all reading a double
Definition: nrn_checkpoint.cpp:46
coreneuron::nrn_set_extra_thread0_vdata
void nrn_set_extra_thread0_vdata()
Definition: patternstim.cpp:48
coreneuron::corenrn_parameters_data::binqueue
bool binqueue
Enable CUDA interface (default is the OpenACC interface). Branch of the code is executed through CUDA...
Definition: corenrn_parameters.hpp:67
coreneuron
THIS FILE IS AUTO GENERATED DONT MODIFY IT.
Definition: corenrn_parameters.cpp:12
coreneuron::corenrn_parameters_data::voltage
double voltage
Temperature in degC.
Definition: corenrn_parameters.hpp:80
coreneuron::NrnThread::trajec_requests
TrajectoryRequests * trajec_requests
Definition: multicore.hpp:146
fast_imem.hpp
coreneuron::nrn_fixed_step_minimal
void nrn_fixed_step_minimal()
Definition: fadvance_core.cpp:91
coreneuron::corenrn_parameters_data::forwardskip
double forwardskip
Initial voltage used for nrn_finitialize(1, v_init).
Definition: corenrn_parameters.hpp:81
coreneuron::corenrn_parameters_data::reportfilepath
std::string reportfilepath
Restore simulation from provided checkpoint directory.
Definition: corenrn_parameters.hpp:90
coreneuron::nrnmpi_check_threading_support
mpi_function< cnrn_make_integral_constant_t(nrnmpi_check_threading_support_impl)> nrnmpi_check_threading_support
Definition: nrnmpidec.cpp:19
coreneuron::core2nrn_data_return
void core2nrn_data_return()
copy data back to NEURON.
Definition: core2nrn_data_return.cpp:217
coreneuron::t
double t
Definition: register_mech.cpp:22
corenrn_parameters.hpp
mkdir_p
int mkdir_p(const char *path)
Creates directory if doesn't exisit (similar to mkdir -p)
Definition: file_utils.cpp:20
coreneuron::i
int i
Definition: cellorder.cpp:485
coreneuron::corenrn_parameters_data::patternstim
std::string patternstim
Maximum integration interval (likely reduced by minimum NetCon delay).
Definition: corenrn_parameters.hpp:85
coreneuron::corenrn_parameters_data::spikebuf
unsigned spikebuf
Definition: corenrn_parameters.hpp:48
coreneuron::nrn_setup
void nrn_setup(const char *filesdat, bool is_mapping_needed, CheckPoints &checkPoints, bool run_setup_cleanup, const char *datpath, const char *restore_path, double *mindelay)
Definition: nrn_setup.cpp:401
coreneuron::corenrn_parameters_data::tstop
double tstop
Verbosity-level.
Definition: corenrn_parameters.hpp:75
nrn_setup.hpp
coreneuron::ReportConfiguration
Definition: nrnreport.hpp:85
coreneuron::cnrn_target_copyin
T * cnrn_target_copyin(std::string_view file, int line, const T *h_ptr, std::size_t len=1)
Definition: offload.hpp:110
coreneuron::update
void update(NrnThread *_nt)
Definition: fadvance_core.cpp:201
nrniv_decl.h
coreneuron::dt
double dt
Definition: register_mech.cpp:22
coreneuron::setup_report_engine
void setup_report_engine(double dt_report, double mindelay)
in the current implementation, we call flush during every spike exchange interval.
Definition: nrnreport.cpp:53
mk_mech_init
void mk_mech_init(int argc, char **argv)
initialize standard mechanisms from coreneuron
Definition: main1.cpp:466
coreneuron::mk_netcvode
void mk_netcvode()
Definition: netcvode.cpp:41
i
#define i
Definition: md1redef.h:19
coreneuron::clear_spike_vectors
void clear_spike_vectors()
Definition: output_spikes.cpp:296
coreneuron::nrnmpi_spike_compress
int nrnmpi_spike_compress(int nspike, bool gid_compress, int xchng_meth)
Definition: netpar.cpp:753
coreneuron::corenrn_parameters_data::filesdat
std::string filesdat
Directory where spikes will be written.
Definition: corenrn_parameters.hpp:88
coreneuron::TrajectoryRequests::scatter
double ** scatter
Definition: multicore.hpp:59
register_mech.hpp
coreneuron::n_multisend_interval
int n_multisend_interval
Definition: multisend.cpp:55
coreneuron::create_report_configurations
std::vector< ReportConfiguration > create_report_configurations(const std::string &filename, const std::string &output_dir, SpikesInfo &spikes_info)
Definition: report_configuration_parser.cpp:106
coreneuron::set_report_buffer_size
void set_report_buffer_size(int n)
Definition: nrnreport.cpp:69
coreneuron::corenrn_parameters_data::restorepath
std::string restorepath
Name of file containing list of gids dat files read in.
Definition: corenrn_parameters.hpp:89
coreneuron::bbcore_write_version
const char * bbcore_write_version
Definition: nrnoc_aux.cpp:24
coreneuron::nrn_init_and_load_data
void nrn_init_and_load_data(int argc, char *argv[], CheckPoints &checkPoints, bool is_mapping_needed, bool run_setup_cleanup)
Definition: main1.cpp:168
coreneuron::NrnThread
Definition: multicore.hpp:75
coreneuron::TrajectoryRequests::varrays
double ** varrays
Definition: multicore.hpp:60
coreneuron::finalize_report
void finalize_report()
Definition: nrnreport.cpp:79
coreneuron::Instrumentor::phase
Definition: profiler_interface.h:289
coreneuron::corenrn_parameters_data::cuda_interface
bool cuda_interface
Enable GPU computation.
Definition: corenrn_parameters.hpp:64
partrans.hpp
coreneuron::corenrn_param
corenrn_parameters corenrn_param
Printing method.
Definition: corenrn_parameters.cpp:268
coreneuron::TrajectoryRequests::vpr
void ** vpr
Definition: multicore.hpp:58
coreneuron::get_nrn_trajectory_requests
void get_nrn_trajectory_requests(int bsize)
Definition: main1.cpp:130
coreneuron::corenrn_parameters_data::multisend
bool multisend
Skip MPI finalization.
Definition: corenrn_parameters.hpp:61
coreneuron::nrn_threads
NrnThread * nrn_threads
Definition: multicore.cpp:56
coreneuron::CheckPoints::get_restore_path
std::string get_restore_path() const
Definition: nrn_checkpoint.hpp:23
coreneuron::TrajectoryRequests
Definition: multicore.hpp:57
run_solve_core
int run_solve_core(int argc, char **argv)
Definition: main1.cpp:520
core2nrn_data_return.hpp
coreneuron::corenrn_parameters_data::checkpointpath
std::string checkpointpath
Reports configuration file.
Definition: corenrn_parameters.hpp:91
nrn2core_part2_clean_
void(* nrn2core_part2_clean_)()
Definition: main1.cpp:59
nrn2core_trajectory_return_
void(* nrn2core_trajectory_return_)(int tid, int n_pr, int bsize, int vecsz, void **vpr, double t)
Definition: nrn_setup.cpp:69
nrnconf.h
coreneuron::allocate_data_in_mechanism_nrn_init
void allocate_data_in_mechanism_nrn_init()
Definition: finitialize.cpp:21
coreneuron::nrnran123_initialise_global_state_on_device
void nrnran123_initialise_global_state_on_device()
Definition: nrnran123.cpp:146
nrnreport.hpp
coreneuron::TrajectoryRequests::n_pr
int n_pr
Definition: multicore.hpp:62
coreneuron::prcellstate
int prcellstate(int gid, const char *suffix)
Definition: prcellstate.cpp:271
coreneuron::corenrn_parameters_data::seed
int seed
Size in MB of the report buffer.
Definition: corenrn_parameters.hpp:57
coreneuron::nrnmpi_init
mpi_function< cnrn_make_integral_constant_t(nrnmpi_init_impl)> nrnmpi_init
Definition: nrnmpidec.cpp:15
weights
#define weights
Definition: md1redef.h:42
coreneuron::TrajectoryRequests::bsize
int bsize
Definition: multicore.hpp:64
coreneuron::NrnThread::weights
double * weights
Definition: multicore.hpp:88
coreneuron::nrn_mkPatternStim
void nrn_mkPatternStim(const char *fname, double tstop)
Definition: patternstim.cpp:60
coreneuron::corenrn_parameters_data::spkcompress
unsigned spkcompress
Number of multisend interval. 1 or 2.
Definition: corenrn_parameters.hpp:52
coreneuron::mk_mech
static void mk_mech()
Definition: mk_mech.cpp:68
nrn_checkpoint.hpp
coreneuron::nrn_cleanup
void nrn_cleanup()
Definition: nrn_setup.cpp:714
coreneuron::SpikesInfo
Definition: nrnreport.hpp:42
coreneuron::use_solve_interleave
bool use_solve_interleave
Definition: solve_core.cpp:13
multicore.hpp
corenrn_embedded
bool corenrn_embedded
--> Coreneuron
Definition: nrn_setup.cpp:46
coreneuron::celsius
double celsius
Definition: register_mech.cpp:22
coreneuron::version::to_string
static std::string to_string()
return version string (version + git id) as a string
Definition: config.h:34
coreneuron::corenrn_parameters_data::mpi_enable
bool mpi_enable
Initialization seed for random number generator (int)
Definition: corenrn_parameters.hpp:59
coreneuron::secondorder
int secondorder
Definition: register_mech.cpp:21
coreneuron::corenrn_parameters_data::dt
double dt
Stop time of simulation in msec.
Definition: corenrn_parameters.hpp:76
config.h
Version information.
v
#define v
Definition: md1redef.h:11
binary_report_handler.hpp
coreneuron::set_globals
void set_globals(const char *path, bool cli_global_seed, int cli_global_seed_value)
Definition: global_vars.cpp:43
coreneuron::ReportHandler::create_report
virtual void create_report(ReportConfiguration &config, double dt, double tstop, double delay)
Definition: report_handler.cpp:36
coreneuron::nrn_have_gaps
bool nrn_have_gaps
variables defined in coreneuron library
Definition: partrans.cpp:21
coreneuron::corenrn_parameters::config_to_str
std::string config_to_str(bool default_also=false, bool write_description=false) const
Return a string summarising the current parameter values.
Definition: corenrn_parameters.cpp:175
memory_utils.h
Function prototypes for the functions providing information about simulator memory usage.
coreneuron::nrnmpi_myid
int nrnmpi_myid
Definition: nrnmpi_def_cinc.cpp:11
coreneuron::output_spikes
void output_spikes(const char *outpath, const SpikesInfo &spikes_info)
Definition: output_spikes.cpp:279
coreneuron::pi
double pi
Definition: register_mech.cpp:22
coreneuron::corenrn_parameters_data::ms_subint
unsigned ms_subint
Number of multisend phases, 1 or 2.
Definition: corenrn_parameters.hpp:51
coreneuron::corenrn_parameters_data::mpi_lib
std::string mpi_lib
Write parameters to this file.
Definition: corenrn_parameters.hpp:93
coreneuron::TrajectoryRequests::gather
double ** gather
Definition: multicore.hpp:61
coreneuron::nrn_pragma_acc
nrn_pragma_acc(routine vector) static void triang_interleaved2(NrnThread *nt
Definition: ivocvect.cpp:30
nrn2core_all_weights_return_
void(* nrn2core_all_weights_return_)(std::vector< double * > &weights)
Definition: nrn_setup.cpp:73
nrn2core_get_trajectory_requests_
void(* nrn2core_get_trajectory_requests_)(int tid, int &bsize, int &n_pr, void **&vpr, int &n_trajec, int *&types, int *&indices, double **&pvars, double **&varrays)
Definition: nrn_setup.cpp:57
coreneuron::create_report_handler
std::unique_ptr< ReportHandler > create_report_handler(const ReportConfiguration &config, const SpikesInfo &spikes_info)
Definition: main1.cpp:425
file_utils.hpp
coreneuron::ReportConfiguration::format
std::string format
Definition: nrnreport.hpp:93
coreneuron::mk_spikevec_buffer
void mk_spikevec_buffer(int sz)
Definition: output_spikes.cpp:50
corenrn_units_use_legacy
bool corenrn_units_use_legacy()
Definition: main1.cpp:55
coreneuron::Instrumentor::phase_end
static void phase_end(const char *name)
Definition: profiler_interface.h:312
sonata_report_handler.hpp
nrnmpi.h
coreneuron::use_phase2_
bool use_phase2_
Definition: multisend.cpp:54
corenrn_version
const char * corenrn_version()
Definition: main1.cpp:50
coreneuron::cnrn_version
std::string cnrn_version()
Definition: main1.cpp:408
coreneuron::nrn_partrans::delete_gap_indices_from_device
void delete_gap_indices_from_device()
Definition: partrans.cpp:161
coreneuron::report_mem_usage
void report_mem_usage(const char *message, bool all_ranks)
Reports current memory usage of the simulator to stdout.
Definition: memory_utils.cpp:79
coreneuron::nrn_finitialize
void nrn_finitialize(int setv, double v)
Definition: finitialize.cpp:40
coreneuron::corenrn_parameters_data::mindelay
double mindelay
Forward skip to TIME.
Definition: corenrn_parameters.hpp:82