diff --git a/coreneuron/apps/corenrn_parameters.cpp b/coreneuron/apps/corenrn_parameters.cpp index b9b6dbce4..fbaba08a8 100644 --- a/coreneuron/apps/corenrn_parameters.cpp +++ b/coreneuron/apps/corenrn_parameters.cpp @@ -89,10 +89,6 @@ corenrn_parameters::corenrn_parameters(){ ->check(CLI::Range(0., 1e9)); sub_config -> add_option("-l, --celsius", this->celsius, "Temperature in degC. The default value is set in defaults.dat or else is 34.0.", true) ->check(CLI::Range(-1000., 1000.)); - sub_config -> add_option("-x, --extracon", this->extracon, "Number of extra random connections in each thread to other duplicate models.") - ->check(CLI::Range(0, 10'000'000)); - sub_config -> add_option("-z, --multiple", this->multiple, "Model duplication factor. Model size is normal size * multiple") - ->check(CLI::Range(1, 10'000'000)); sub_config -> add_option("--mindelay", this->mindelay, "Maximum integration interval (likely reduced by minimum NetCon delay).", true) ->check(CLI::Range(0., 1e9)); sub_config -> add_option("--report-buffer-size", this->report_buff_size, "Size in MB of the report buffer.") @@ -162,8 +158,6 @@ std::ostream& operator<<(std::ostream& os, const corenrn_parameters& corenrn_par << "--prcellgid=" << corenrn_param.prcellgid << std::endl << "--forwardskip=" << corenrn_param.forwardskip << std::endl << "--celsius=" << corenrn_param.celsius << std::endl - << "--extracon=" << corenrn_param.extracon << std::endl - << "--multiple=" << corenrn_param.multiple << std::endl << "--mindelay=" << corenrn_param.mindelay << std::endl << "--report-buffer-size=" << corenrn_param.report_buff_size << std::endl << std::endl diff --git a/coreneuron/apps/corenrn_parameters.hpp b/coreneuron/apps/corenrn_parameters.hpp index 6c60aea15..8d018f6a8 100644 --- a/coreneuron/apps/corenrn_parameters.hpp +++ b/coreneuron/apps/corenrn_parameters.hpp @@ -75,8 +75,6 @@ struct corenrn_parameters { unsigned spkcompress=0; /// Spike Compression unsigned cell_interleave_permute=0; /// Cell interleaving permutation unsigned nwarp=0; /// Number of warps to balance for cell_interleave_permute == 2 - unsigned multiple=1; /// Model duplication factor - unsigned extracon=0; /// Number of extra random connections in each thread to other duplicate models. unsigned report_buff_size=report_buff_size_default; ///Size in MB of the report buffer. int seed=-1; /// Initialization seed for random number generator (int) diff --git a/coreneuron/apps/main1.cpp b/coreneuron/apps/main1.cpp index 0f6c3bea0..66b4ba122 100644 --- a/coreneuron/apps/main1.cpp +++ b/coreneuron/apps/main1.cpp @@ -242,9 +242,6 @@ void nrn_init_and_load_data(int argc, use_solve_interleave = true; } - // pass by flag so existing tests do not need a changed nrn_setup prototype. - nrn_setup_multiple = corenrn_param.multiple; - nrn_setup_extracon = corenrn_param.extracon; // multisend options use_multisend_ = corenrn_param.multisend ? 1 : 0; n_multisend_interval = corenrn_param.ms_subint; @@ -478,15 +475,10 @@ extern "C" int run_solve_core(int argc, char** argv) { } if (!corenrn_param.reportfilepath.empty()) { - if (corenrn_param.multiple > 1) { - if (nrnmpi_myid == 0) - printf("\n WARNING! : Can't enable reports with model duplications feature! \n"); - } else { - configs = create_report_configurations(corenrn_param.reportfilepath.c_str(), - corenrn_param.outpath.c_str(), - spikes_population_name); - reports_needs_finalize = configs.size(); - } + configs = create_report_configurations(corenrn_param.reportfilepath.c_str(), + corenrn_param.outpath.c_str(), + spikes_population_name); + reports_needs_finalize = configs.size(); } // initializationa and loading functions moved to separate diff --git a/coreneuron/io/nrn_checkpoint.cpp b/coreneuron/io/nrn_checkpoint.cpp index fc995030a..e0a2c9ef7 100644 --- a/coreneuron/io/nrn_checkpoint.cpp +++ b/coreneuron/io/nrn_checkpoint.cpp @@ -372,7 +372,7 @@ static void write_phase2(NrnThread& nt, FileHandlerWrap& fh) { } } - int nnetcon = nt.n_netcon - nrn_setup_extracon; + int nnetcon = nt.n_netcon; int* output_vindex = new int[nt.n_presyn]; double* output_threshold = new double[nt.ncell]; diff --git a/coreneuron/io/nrn_setup.cpp b/coreneuron/io/nrn_setup.cpp index f629f469e..7ce3b7b22 100644 --- a/coreneuron/io/nrn_setup.cpp +++ b/coreneuron/io/nrn_setup.cpp @@ -161,33 +161,6 @@ int (*nrn2core_all_spike_vectors_return_)(std::vector& spikevec, std::ve // stored in the nt.presyns array and nt.netcons array respectively namespace coreneuron { extern corenrn_parameters corenrn_param; -int nrn_setup_multiple = 1; /* default */ -int nrn_setup_extracon = 0; /* default */ - -// nrn_setup_extracon extra connections per NrnThread. -// i.e. nrn_setup_extracon * nrn_setup_multiple * nrn_nthread -// extra connections on this process. -// The targets of the connections on a NrnThread are randomly selected -// (with replacement) from the set of ProbAMPANMDA_EMS on the thread. -// (This synapse type is not strictly appropriate to be used as -// a generalized synapse with multiple input streams since some of its -// range variables store quantities that should be stream specific -// and therefore should be stored in the NetCon weight vector. But it -// might be good enough for our purposes. In any case, we'd like to avoid -// creating new POINT_PROCESS instances with all the extra complexities -// involved in adjusting the data arrays.) -// The nrn_setup_extracon value is used to allocate the appropriae -// amount of extra space for NrnThread.netcons and NrnThread.weights -// -// The most difficult problem is to augment the rank wide inputpresyn_ list. -// We wish to randomly choose source gids for the extracon NetCons from the -// set of gids not in "multiple" instance of the model the NrnThread is a -// member of. We need to take into account the possibilty of multiple -// NrnThread in multiple "multiple" instances having extra NetCon with the -// same source gid. That some of the source gids may be already be -// associated with already existing PreSyn on this rank is a minor wrinkle. -// This is done between phase1 and phase2 during the call to -// determine_inputpresyn(). #ifdef _OPENMP static OMP_Mutex mut; @@ -208,17 +181,12 @@ std::vector netcon_in_presyn_order_; std::vector netcon_srcgid; /* read files.dat file and distribute cellgroups to all mpi ranks */ -void nrn_read_filesdat(int& ngrp, int*& grp, int multiple, int*& imult, const char* filesdat) { +void nrn_read_filesdat(int& ngrp, int*& grp, const char* filesdat) { patstimtype = nrn_get_mechtype("PatternStim"); if (corenrn_embedded) { ngrp = corenrn_embedded_nthread; - nrn_assert(multiple == 1); grp = new int[ngrp + 1]; - imult = new int[ngrp + 1]; (*nrn2core_group_ids_)(grp); - for (int i = 0; i <= ngrp; ++i) { - imult[i] = 0; - } return; } @@ -251,25 +219,17 @@ void nrn_read_filesdat(int& ngrp, int*& grp, int multiple, int*& imult, const ch } ngrp = 0; - grp = new int[iNumFiles * multiple / nrnmpi_numprocs + 1]; - imult = new int[iNumFiles * multiple / nrnmpi_numprocs + 1]; + grp = new int[iNumFiles / nrnmpi_numprocs + 1]; // irerate over gids in files.dat - for (int iNum = 0; iNum < iNumFiles * multiple; ++iNum) { + for (int iNum = 0; iNum < iNumFiles; ++iNum) { int iFile; nrn_assert(fscanf(fp, "%d\n", &iFile) == 1); if ((iNum % nrnmpi_numprocs) == nrnmpi_myid) { grp[ngrp] = iFile; - imult[ngrp] = iNum / iNumFiles; ngrp++; } - if ((iNum + 1) % iNumFiles == 0) { - // re-read file for each multiple (skipping the two header lines) - rewind(fp); - nrn_assert(fscanf(fp, "%*s\n") == 0); - nrn_assert(fscanf(fp, "%*d\n") == 0); - } } fclose(fp); @@ -448,11 +408,9 @@ void nrn_setup(const char* filesdat, int ngroup; int* gidgroups; - int* imult; - nrn_read_filesdat(ngroup, gidgroups, nrn_setup_multiple, imult, filesdat); + nrn_read_filesdat(ngroup, gidgroups, filesdat); UserParams userParams(ngroup, gidgroups, - imult, datpath, strlen(restore_path) == 0 ? datpath : restore_path); @@ -497,7 +455,6 @@ void nrn_setup(const char* filesdat, // gap junctions if (nrn_have_gaps) { - assert(nrn_setup_multiple == 1); nrn_partrans::transfer_thread_data_ = new nrn_partrans::TransferThreadData[nrn_nthread]; nrn_partrans::setup_info_ = new nrn_partrans::SetupInfo[userParams.ngroup]; if (!corenrn_embedded) { @@ -522,9 +479,9 @@ void nrn_setup(const char* filesdat, NrnThread& nt = *n; { #ifdef _OPENMP - p1.populate(nt, 0, mut); + p1.populate(nt, mut); #else - p1.populate(nt, 0); + p1.populate(nt); #endif } }); @@ -565,7 +522,6 @@ void nrn_setup(const char* filesdat, model_size(); delete[] userParams.gidgroups; - delete[] userParams.imult; if (nrnmpi_myid == 0 && !corenrn_param.is_quiet()) { printf(" Setup Done : %.2lf seconds \n", nrn_wtime() - time); @@ -593,7 +549,6 @@ void setup_ThreadData(NrnThread& nt) { } void read_phasegap(NrnThread& nt, UserParams& userParams) { - nrn_assert(userParams.imult[nt.id] == 0); nrn_partrans::SetupInfo& si = nrn_partrans::setup_info_[nt.id]; si.ntar = 0; si.nsrc = 0; @@ -903,9 +858,9 @@ void read_phase1(NrnThread& nt, UserParams& userParams) { { // Protect gid2in, gid2out and neg_gid2out #ifdef _OPENMP - p1.populate(nt, userParams.imult[nt.id], mut); + p1.populate(nt, mut); #else - p1.populate(nt, userParams.imult[nt.id]); + p1.populate(nt); #endif } } diff --git a/coreneuron/io/output_spikes.hpp b/coreneuron/io/output_spikes.hpp index 85bfdbc70..cef223a63 100644 --- a/coreneuron/io/output_spikes.hpp +++ b/coreneuron/io/output_spikes.hpp @@ -29,6 +29,7 @@ THE POSSIBILITY OF SUCH DAMAGE. #ifndef output_spikes_h #define output_spikes_h +#include #include #include namespace coreneuron { diff --git a/coreneuron/io/phase1.cpp b/coreneuron/io/phase1.cpp index 422ceb3d1..e99738835 100644 --- a/coreneuron/io/phase1.cpp +++ b/coreneuron/io/phase1.cpp @@ -43,93 +43,19 @@ void Phase1::read_direct(int thread_id) { delete[] netcon_srcgid; } -void Phase1::shift_gids(int imult) { - // maxgid is the maxgid to have the different multiple in the same gid space. - int maxgid = 0x7fffffff / nrn_setup_multiple; - // this value is the beginning of the new cluster of gids. - // the correct cluster is choose with imult. - int offset_gids = imult * maxgid; // offset for each gid - - // offset the (non-negative) gids according to multiple - // make sure everything fits into gid space. - for (auto& gid: this->output_gids) { - if (gid >= 0) { - nrn_assert(gid < maxgid); - gid += offset_gids; - } - } - - for (auto& srcgid: this->netcon_srcgids) { - if (srcgid >= 0) { - nrn_assert(srcgid < maxgid); - srcgid += offset_gids; - } - } -} - -void Phase1::add_extracon(NrnThread& nt, int imult) { - int maxgid = 0x7fffffff / nrn_setup_multiple; - if (nrn_setup_extracon <= 0) { - return; - } - - // very simplistic - // Use this threads positive source gids - zz in nt.netcon order as the - // source gids for extracon. - // The edge cases are: - // The 0th duplicate uses uses source gids for the last duplicate. - // If there are fewer positive source gids than extracon, then keep - // rotating through the nt.netcon . - // If there are no positive source gids, use a source gid of -1. - // Would not be difficult to modify so that random positive source was - // used, and/or random connect to another duplicate. - // Note that we increment the nt.n_netcon at the end of this function. - int sidoffset = 0; // how much to increment the corresponding positive gid - // like ring connectivity - if (imult > 0) { - sidoffset = -maxgid; - } else if (nrn_setup_multiple > 1) { - sidoffset = (nrn_setup_multiple - 1) * maxgid; - } - // set up the extracon srcgid_ - int* nc_srcgid = netcon_srcgid[nt.id]; - int j = 0; // rotate through the n_netcon netcon_srcgid - for (int i = 0; i < nrn_setup_extracon; ++i) { - int sid = -1; - for (int k = 0; k < nt.n_netcon; ++k) { - // potentially rotate j through the entire n_netcon but no further - sid = nc_srcgid[j]; - j = (j + 1) % nt.n_netcon; - if (sid >= 0) { - break; - } - } - if (sid < 0) { // only connect to real cells. - sid = -1; - } else { - sid += sidoffset; - } - nc_srcgid[nt.n_netcon + i] = sid; - } - // finally increment the n_netcon - nt.n_netcon += nrn_setup_extracon; -} - #ifdef _OPENMP -void Phase1::populate(NrnThread& nt, int imult, OMP_Mutex& mut) { +void Phase1::populate(NrnThread& nt, OMP_Mutex& mut) { #else -void Phase1::populate(NrnThread& nt, int imult) { +void Phase1::populate(NrnThread& nt) { #endif nt.n_presyn = this->output_gids.size(); nt.n_netcon = this->netcon_srcgids.size(); - shift_gids(imult); - - netcon_srcgid[nt.id] = new int[nt.n_netcon + nrn_setup_extracon]; + netcon_srcgid[nt.id] = new int[nt.n_netcon]; std::copy(this->netcon_srcgids.begin(), this->netcon_srcgids.end(), netcon_srcgid[nt.id]); - nt.netcons = new NetCon[nt.n_netcon + nrn_setup_extracon]; + nt.netcons = new NetCon[nt.n_netcon]; nt.presyns_helper = (PreSynHelper*)ecalloc_align(nt.n_presyn, sizeof(PreSynHelper)); nt.presyns = new PreSyn[nt.n_presyn]; @@ -177,8 +103,6 @@ void Phase1::populate(NrnThread& nt, int imult) { ++ps; } - - add_extracon(nt, imult); } } // namespace coreneuron diff --git a/coreneuron/io/phase1.hpp b/coreneuron/io/phase1.hpp index 65a9034ba..ef0d8d798 100644 --- a/coreneuron/io/phase1.hpp +++ b/coreneuron/io/phase1.hpp @@ -14,15 +14,12 @@ class Phase1 { void read_file(FileHandler& F); void read_direct(int thread_id); #ifdef _OPENMP - void populate(NrnThread& nt, int imult, OMP_Mutex& mut); + void populate(NrnThread& nt, OMP_Mutex& mut); #else - void populate(NrnThread& nt, int imult); + void populate(NrnThread& nt); #endif private: - void shift_gids(int imult); - void add_extracon(NrnThread& nt, int imult); - std::vector output_gids; std::vector netcon_srcgids; }; diff --git a/coreneuron/io/phase2.cpp b/coreneuron/io/phase2.cpp index 445d612a5..fa2f15f87 100644 --- a/coreneuron/io/phase2.cpp +++ b/coreneuron/io/phase2.cpp @@ -159,8 +159,8 @@ void Phase2::read_file(FileHandler& F, const NrnThread& nt) { } output_vindex = F.read_vector(nt.n_presyn); output_threshold = F.read_vector(n_real_output); - pnttype = F.read_vector(nt.n_netcon - nrn_setup_extracon); - pntindex = F.read_vector(nt.n_netcon - nrn_setup_extracon); + pnttype = F.read_vector(nt.n_netcon); + pntindex = F.read_vector(nt.n_netcon); weights = F.read_vector(n_weight); delay = F.read_vector(nt.n_netcon); num_point_process = F.read_int(); @@ -310,7 +310,7 @@ void Phase2::read_direct(int thread_id, const NrnThread& nt) { output_threshold = std::vector(output_threshold_, output_threshold_ + n_real_output); delete[] output_threshold_; - int n_netcon = nt.n_netcon - nrn_setup_extracon; + int n_netcon = nt.n_netcon; pnttype = std::vector(pnttype_, pnttype_ + n_netcon); delete[] pnttype_; @@ -690,77 +690,31 @@ void Phase2::set_dependencies(const NrnThread& nt, const std::vector& free(mech_deps); } -void Phase2::handle_extracon(NrnThread& nt, int n_netcon, const std::vector& pnt_offset) { - int extracon_target_nweight = 0; - if (nrn_setup_extracon > 0) { - // Fill in the extracon target_ and active_. - // Simplistic. - // Rotate through the pntindex and use only pnttype for ProbAMPANMDA_EMS - // (which happens to have a weight vector length of 5.) - // Edge case: if there is no such synapse, let the target_ be nullptr - // and the netcon be inactive. - // Same pattern as algorithm for extracon netcon_srcgid above in phase1. - int extracon_target_type = nrn_get_mechtype("ProbAMPANMDA_EMS"); - assert(extracon_target_type > 0); - extracon_target_nweight = corenrn.get_pnt_receive_size()[extracon_target_type]; - int j = 0; - for (int i = 0; i < nrn_setup_extracon; ++i) { - bool extracon_find = false; - for (int k = 0; k < n_netcon; ++k) { - if (pnttype[j] == extracon_target_type) { - extracon_find = true; - break; - } - j = (j + 1) % n_netcon; - } - NetCon& nc = nt.netcons[i + n_netcon]; - nc.active_ = extracon_find ? 1 : 0; - if (extracon_find) { - nc.target_ = nt.pntprocs + (pnt_offset[extracon_target_type] + pntindex[j]); - } else { - nc.target_ = nullptr; - } +void Phase2::handle_weights(NrnThread& nt, int n_netcon) { + nt.n_weight = weights.size(); + // weights in netcons order in groups defined by Point_process target type. + nt.weights = (double*)ecalloc_align(nt.n_weight, sizeof(double)); + std::copy(weights.begin(), weights.end(), nt.weights); + + int iw = 0; + for (int i = 0; i < n_netcon; ++i) { + NetCon& nc = nt.netcons[i]; + nc.u.weight_index_ = iw; + if (pnttype[i] != 0) { + iw += corenrn.get_pnt_receive_size()[pnttype[i]]; + } else { + iw += 1; } } - - { - nt.n_weight = weights.size(); - int nweight = nt.n_weight; - // weights in netcons order in groups defined by Point_process target type. - nt.n_weight += nrn_setup_extracon * extracon_target_nweight; - nt.weights = (double*)ecalloc_align(nt.n_weight, sizeof(double)); - std::copy(weights.begin(), weights.end(), nt.weights); - - int iw = 0; - for (int i = 0; i < n_netcon; ++i) { - NetCon& nc = nt.netcons[i]; - nc.u.weight_index_ = iw; - if (pnttype[i] != 0) { - iw += corenrn.get_pnt_receive_size()[pnttype[i]]; - } else { - iw += 1; - } - } - assert(iw == nweight); + assert(iw == nt.n_weight); #if CHKPNTDEBUG - ntc.delay = new double[n_netcon]; - memcpy(ntc.delay, delay, n_netcon * sizeof(double)); + ntc.delay = new double[n_netcon]; + memcpy(ntc.delay, delay, n_netcon * sizeof(double)); #endif - for (int i = 0; i < n_netcon; ++i) { - NetCon& nc = nt.netcons[i]; - nc.delay_ = delay[i]; - } - - if (nrn_setup_extracon > 0) { - // simplistic. delay is 1 and weight is 0.001 - for (int i = 0; i < nrn_setup_extracon; ++i) { - NetCon& nc = nt.netcons[n_netcon + i]; - nc.delay_ = 1.0; - nc.u.weight_index_ = nweight + i * extracon_target_nweight; - nt.weights[nc.u.weight_index_] = 2.0; // this value 2.0 is extracted from .dat files - } - } + for (int i = 0; i < n_netcon; ++i) { + NetCon& nc = nt.netcons[i]; + nc.delay_ = delay[i]; } } @@ -852,7 +806,6 @@ void Phase2::set_vec_play(NrnThread& nt) { } void Phase2::populate(NrnThread& nt, const UserParams& userParams) { - nrn_assert(userParams.imult[nt.id] >= 0); // avoid imult unused warning NrnThreadChkpnt& ntc = nrnthread_chkpnt[nt.id]; ntc.file_id = userParams.gidgroups[nt.id]; @@ -1203,9 +1156,7 @@ void Phase2::populate(NrnThread& nt, const UserParams& userParams) { nt._net_send_buffer_size = nt.ncell; nt._net_send_buffer = (int*)ecalloc_align(nt._net_send_buffer_size, sizeof(int)); - // do extracon later as the target and weight info - // is not directly in the file - int nnetcon = nt.n_netcon - nrn_setup_extracon; + int nnetcon = nt.n_netcon; // it may happen that Point_process structures will be made unnecessary // by factoring into NetCon. @@ -1227,7 +1178,7 @@ void Phase2::populate(NrnThread& nt, const UserParams& userParams) { } } - handle_extracon(nt, nnetcon, pnt_offset); + handle_weights(nt, nnetcon); get_info_from_bbcore(nt, memb_func); diff --git a/coreneuron/io/phase2.hpp b/coreneuron/io/phase2.hpp index e299d4995..d9c464020 100644 --- a/coreneuron/io/phase2.hpp +++ b/coreneuron/io/phase2.hpp @@ -70,7 +70,7 @@ class Phase2 { void fill_before_after_lists(NrnThread& nt, const std::vector& memb_func); void pdata_relocation(const NrnThread& nt, const std::vector& memb_func); void set_dependencies(const NrnThread& nt, const std::vector& memb_func); - void handle_extracon(NrnThread& nt, int n_netcon, const std::vector& pnt_offset); + void handle_weights(NrnThread& nt, int n_netcon); void get_info_from_bbcore(NrnThread& nt, const std::vector& memb_func); void set_vec_play(NrnThread& nt); diff --git a/coreneuron/io/user_params.hpp b/coreneuron/io/user_params.hpp index f8d938fb4..e285d6086 100644 --- a/coreneuron/io/user_params.hpp +++ b/coreneuron/io/user_params.hpp @@ -6,11 +6,10 @@ namespace coreneuron { /// Before it was globals variables, group them to give them as a single argument. /// They have for the most part, nothing related to each other. struct UserParams { - UserParams(int ngroup_, int* gidgroups_, int* imult_, + UserParams(int ngroup_, int* gidgroups_, const char* path_, const char* restore_path_) : ngroup(ngroup_) , gidgroups(gidgroups_) - , imult(imult_) , path(path_) , restore_path(restore_path_) , file_reader(ngroup_) @@ -21,9 +20,6 @@ struct UserParams { const int ngroup; /// Array of cell group numbers (indices) const int* const gidgroups; - /// Array of duplicate indices. Normally, with nrn_setup_multiple=1, - // they are ngroup values of 0. - const int* const imult; /// path to dataset file const char* const path; /// Dataset path from where simulation is being restored diff --git a/coreneuron/nrniv/nrniv_decl.h b/coreneuron/nrniv/nrniv_decl.h index 3f49d03ee..2d053962f 100644 --- a/coreneuron/nrniv/nrniv_decl.h +++ b/coreneuron/nrniv/nrniv_decl.h @@ -64,8 +64,6 @@ extern void nrn_setup(const char* filesdat, double* mindelay = nullptr); extern double* stdindex2ptr(int mtype, int index, NrnThread&); extern void delete_trajectory_requests(NrnThread&); -extern int nrn_setup_multiple; -extern int nrn_setup_extracon; extern void nrn_cleanup(); extern void nrn_cleanup_ion_map(); extern void BBS_netpar_solve(double); diff --git a/coreneuron/utils/memory.h b/coreneuron/utils/memory.h index 94e1e3d18..f82922614 100644 --- a/coreneuron/utils/memory.h +++ b/coreneuron/utils/memory.h @@ -29,6 +29,7 @@ THE POSSIBILITY OF SUCH DAMAGE. #ifndef _H_MEMORY_ #define _H_MEMORY_ +#include #include #include "coreneuron/utils/nrn_assert.h" diff --git a/tests/integration/CMakeLists.txt b/tests/integration/CMakeLists.txt index 5477382a5..6a2b10fbc 100644 --- a/tests/integration/CMakeLists.txt +++ b/tests/integration/CMakeLists.txt @@ -20,7 +20,6 @@ set(TEST_CASES_WITH_ARGS "ring_binqueue!${RING_COMMON_ARGS} ${GPU_ARGS} --outpath ${CMAKE_CURRENT_BINARY_DIR}/ring_binqueue --binqueue" "ring_multisend!${RING_COMMON_ARGS} ${GPU_ARGS} --outpath ${CMAKE_CURRENT_BINARY_DIR}/ring_multisend --multisend" "ring_spike_buffer!${RING_COMMON_ARGS} ${GPU_ARGS} --outpath ${CMAKE_CURRENT_BINARY_DIR}/ring_spike_buffer --spikebuf 1" - "ring_duplicate!${RING_COMMON_ARGS} ${GPU_ARGS} --outpath ${CMAKE_CURRENT_BINARY_DIR}/ring_duplicate --multiple 3" "ring_permute1!${RING_COMMON_ARGS} ${GPU_ARGS} --outpath ${CMAKE_CURRENT_BINARY_DIR}/ring_permute1 ${PERMUTE1_ARGS}" "ring_permute2!${RING_COMMON_ARGS} ${GPU_ARGS} --outpath ${CMAKE_CURRENT_BINARY_DIR}/ring_permute2 ${PERMUTE2_ARGS}" "ring_gap!${RING_GAP_COMMON_ARGS} ${GPU_ARGS} --outpath ${CMAKE_CURRENT_BINARY_DIR}/ring_gap" @@ -51,7 +50,7 @@ foreach(data_dir "ring" "ring_gap") endforeach() # base tests : ring, ring with gap and ring duplication -foreach(data_dir "ring" "ring_gap" "ring_duplicate") +foreach(data_dir "ring" "ring_gap") file(COPY "${CMAKE_CURRENT_SOURCE_DIR}/${data_dir}/out.dat.ref" DESTINATION diff --git a/tests/integration/ring_duplicate/out.dat.ref b/tests/integration/ring_duplicate/out.dat.ref deleted file mode 100644 index 54b75e194..000000000 --- a/tests/integration/ring_duplicate/out.dat.ref +++ /dev/null @@ -1,111 +0,0 @@ -2.65 0 -2.65 715827882 -2.65 1431655764 -5.3 1 -5.3 715827883 -5.3 1431655765 -7.95 2 -7.95 715827884 -7.95 1431655766 -10.6 3 -10.6 715827885 -10.6 1431655767 -13.25 4 -13.25 715827886 -13.25 1431655768 -15.9 5 -15.9 715827887 -15.9 1431655769 -18.55 6 -18.55 715827888 -18.55 1431655770 -21.2 7 -21.2 715827889 -21.2 1431655771 -23.85 8 -23.85 715827890 -23.85 1431655772 -26.5 9 -26.5 715827891 -26.5 1431655773 -29.15 10 -29.15 715827892 -29.15 1431655774 -31.8 11 -31.8 715827893 -31.8 1431655775 -34.45 12 -34.45 715827894 -34.45 1431655776 -37.1 13 -37.1 715827895 -37.1 1431655777 -39.75 14 -39.75 715827896 -39.75 1431655778 -42.4 15 -42.4 715827897 -42.4 1431655779 -45.05 16 -45.05 715827898 -45.05 1431655780 -47.7 17 -47.7 715827899 -47.7 1431655781 -50.35 18 -50.35 715827900 -50.35 1431655782 -53 19 -53 715827901 -53 1431655783 -55.65 0 -55.65 715827882 -55.65 1431655764 -58.3 1 -58.3 715827883 -58.3 1431655765 -60.95 2 -60.95 715827884 -60.95 1431655766 -63.6 3 -63.6 715827885 -63.6 1431655767 -66.25 4 -66.25 715827886 -66.25 1431655768 -68.9 5 -68.9 715827887 -68.9 1431655769 -71.55 6 -71.55 715827888 -71.55 1431655770 -74.2 7 -74.2 715827889 -74.2 1431655771 -76.85 8 -76.85 715827890 -76.85 1431655772 -79.5 9 -79.5 715827891 -79.5 1431655773 -82.15 10 -82.15 715827892 -82.15 1431655774 -84.8 11 -84.8 715827893 -84.8 1431655775 -87.45 12 -87.45 715827894 -87.45 1431655776 -90.1 13 -90.1 715827895 -90.1 1431655777 -92.75 14 -92.75 715827896 -92.75 1431655778 -95.4 15 -95.4 715827897 -95.4 1431655779 -98.05 16 -98.05 715827898 -98.05 1431655780 diff --git a/tests/unit/cmdline_interface/test_cmdline_interface.cpp b/tests/unit/cmdline_interface/test_cmdline_interface.cpp index e32c61be0..005d72724 100644 --- a/tests/unit/cmdline_interface/test_cmdline_interface.cpp +++ b/tests/unit/cmdline_interface/test_cmdline_interface.cpp @@ -90,12 +90,6 @@ BOOST_AUTO_TEST_CASE(cmdline_interface) { "--celsius", "25.12", - "--extracon", - "1000", - - "--multiple", - "3", - "--mindelay", "0.1", @@ -141,10 +135,6 @@ BOOST_AUTO_TEST_CASE(cmdline_interface) { BOOST_CHECK(corenrn_param_test.nwarp == 8); - BOOST_CHECK(corenrn_param_test.extracon == 1000); - - BOOST_CHECK(corenrn_param_test.multiple == 3); - BOOST_CHECK(corenrn_param_test.multisend == true); BOOST_CHECK(corenrn_param_test.mindelay == 0.1);