From 387fc084d488ba2622db37bb71204ef21803008a Mon Sep 17 00:00:00 2001 From: shankar-1729 Date: Mon, 30 Sep 2024 14:22:55 -0400 Subject: [PATCH 1/4] Cleanup --- Source/Evolve.cpp | 21 ++--- Source/FlavoredNeutrinoContainerInit.cpp | 108 +++++------------------ Source/NuLibTableHelpers.H | 8 -- Source/ReadEosTable.cpp | 40 +-------- Source/ReadInput_RhoTempYe.cpp | 11 +-- Source/ReadNuLibTable.cpp | 6 +- 6 files changed, 35 insertions(+), 159 deletions(-) diff --git a/Source/Evolve.cpp b/Source/Evolve.cpp index 31d2395..e639e95 100644 --- a/Source/Evolve.cpp +++ b/Source/Evolve.cpp @@ -168,34 +168,25 @@ void interpolate_rhs_from_mesh(FlavoredNeutrinoContainer& neutrinos_rhs, const M yes_nulib, helperVarsReal_nulib, helperVarsInt_nulib); - - //--------------------------- + +//The following commented loop can be used to print information about each particle in case debug is needed in future. +/* const int lev = 0; - #ifdef _OPENMP #pragma omp parallel #endif for (FNParIter pti(neutrinos_rhs, lev); pti.isValid(); ++pti) { const int np = pti.numParticles(); - //printf("(Evolve.cpp) number of particles: np = %d \n", np); FlavoredNeutrinoContainer::ParticleType* pstruct = &(pti.GetArrayOfStructs()[0]); amrex::ParallelFor (np, [=] AMREX_GPU_DEVICE (int i) { FlavoredNeutrinoContainer::ParticleType& p = pstruct[i]; - - //printf("(Inside Evolve.cpp)i =%d, Vphase = %g \n", i, p.rdata(PIdx::Vphase)); - /*p.pos(0) = p.rdata(PIdx::x); - p.pos(1) = p.rdata(PIdx::y); - p.pos(2) = p.rdata(PIdx::z); - - p.rdata(PIdx::x) = p.pos(0); - p.rdata(PIdx::y) = p.pos(1); - p.rdata(PIdx::z) = p.pos(2);*/ - + //printf("(Inside Evolve.cpp) Partile i = %d, Vphase = %g \n", i, p.rdata(PIdx::Vphase)); }); } - //-------------------------- +*/ + amrex::MeshToParticle(neutrinos_rhs, state, 0, diff --git a/Source/FlavoredNeutrinoContainerInit.cpp b/Source/FlavoredNeutrinoContainerInit.cpp index adbcd81..f05e233 100644 --- a/Source/FlavoredNeutrinoContainerInit.cpp +++ b/Source/FlavoredNeutrinoContainerInit.cpp @@ -290,7 +290,6 @@ InitParticles(const TestParams* parms) if(parms->IMFP_method == 1){ p.rdata(PIdx::Vphase) = dx[0]*dx[1]*dx[2]*4*MathConst::pi*(pow(p.rdata(PIdx::pupt)+parms->delta_E/2,3)-pow(p.rdata(PIdx::pupt)-parms->delta_E/2,3))/(3*ndirs_per_loc*parms->nppc[0]*parms->nppc[1]*parms->nppc[2]); - //printf("(Inside FlavoredNeutrinoContainerInit.cpp) Vphase = %g \n", p.rdata(PIdx::Vphase)); } //=====================// @@ -377,8 +376,6 @@ CreateParticlesAtBoundary(const TestParams* parms, const Real current_dt) const auto dx = Geom(lev).CellSizeArray(); const auto plo = Geom(lev).ProbLoArray(); const auto& a_bounds = Geom(lev).ProbDomain(); - - //printf("plo = [%f, %f, %f] \n", plo[0], plo[1], plo[2]); const int nlocs_per_cell = AMREX_D_TERM( parms->nppc[0], *parms->nppc[1], @@ -391,12 +388,8 @@ CreateParticlesAtBoundary(const TestParams* parms, const Real current_dt) // determine the number of directions per location int ndirs_per_loc = particle_data.size(); - //amrex::Print() << "Using " << ndirs_per_loc << " directions." << std::endl; const Real scale_fac = dx[0]*dx[1]*dx[2]/nlocs_per_cell; - //FIXME: We need to use outflow boundary condition, not periodic boundary condition. Put an assert(!periodic) here. - - // Loop over multifabs // #ifdef _OPENMP #pragma omp parallel @@ -415,8 +408,6 @@ CreateParticlesAtBoundary(const TestParams* parms, const Real current_dt) const auto lo = amrex::lbound(tile_box); const auto hi = amrex::ubound(tile_box); - //printf("tile_box = [%d, %d, %d] x [%d, %d, %d] \n", lo.x, lo.y, lo.z, hi.x, hi.y, hi.z); - Gpu::ManagedVector counts(tile_box.numPts(), 0); //PODVector > counts(n, 0) unsigned int* pcount = counts.dataPtr(); @@ -424,7 +415,8 @@ CreateParticlesAtBoundary(const TestParams* parms, const Real current_dt) Gpu::ManagedVector offsets(tile_box.numPts()); unsigned int* poffset = offsets.dataPtr(); - const int buffer = 0; //TODO: TODO: Set this appropriately. + //TODO: This can be used to emit particles not exactly at the boundary, but at n cells away from the boundary (n = buffer). + const int buffer = 0; // Determine how many particles to add to the particle tile per cell //This loop runs over all the particles in a given box. @@ -479,8 +471,7 @@ CreateParticlesAtBoundary(const TestParams* parms, const Real current_dt) } if (!create_particle_this_cell) continue; - //printf("CREATE PARTRICLE AT: i = %d, j = %d, k = %d \n", i, j, k); - + int ix = i - lo.x; int iy = j - lo.y; int iz = k - lo.z; @@ -496,7 +487,6 @@ CreateParticlesAtBoundary(const TestParams* parms, const Real current_dt) }); // Determine total number of particles to add to the particle tile - //Gpu::inclusive_scan(counts.begin(), counts.end(), offsets.begin()); //This sets the value of "offsets" Gpu::exclusive_scan(counts.begin(), counts.end(), offsets.begin()); //This sets the value of "offsets" int num_to_add = offsets[tile_box.numPts()-1] + counts[tile_box.numPts()-1]; @@ -521,9 +511,6 @@ CreateParticlesAtBoundary(const TestParams* parms, const Real current_dt) offsets[i] += old_size; } - //printf("num_to_add = %d, old_size = %lu, new_size = %lu \n", num_to_add, old_size, new_size); - //printf("Particle ID = %lu \n", ParticleType::NextID()); - //Returns the next particle ID for this processor. // Particle IDs start at 1 and are never reused. The pair, consisting of the ID and the CPU on which the particle is "born", is a globally unique identifier for a particle. //The maximum of this value across all processors must be checkpointed and then restored on restart so that we don't reuse particle IDs. @@ -559,11 +546,6 @@ CreateParticlesAtBoundary(const TestParams* parms, const Real current_dt) get_position_unit_cell(r, parms->nppc, i_loc); - //Real x = plo[0] + (i + r[0])*dx[0]; - //Real x = plo[0] for i_plus direction i.e VC, (y,z) remain same CC. - //Real x = plo[0] + (i+1)*dx[0] for i_minus direction i.e. VC, (y,z) remain same CC. - //Real y = plo[1] + (j + r[1])*dx[1]; - //Real z = plo[2] + (k + r[2])*dx[2]; Real x, y, z; bool create_particle_this_cell = false; @@ -626,14 +608,10 @@ CreateParticlesAtBoundary(const TestParams* parms, const Real current_dt) break; } - //printf("x = %f, y = %f, z = %f \n", x, y, z); - if (!create_particle_this_cell) continue; - //printf("CREATE PARTRICLE AT: i = %d, j = %d, k = %d \n", i, j, k); for(int i_direction=0; i_directionperturbation_type == 0){ - // random perturbations to the off-diagonals - /*Real rand; - symmetric_uniform(&rand, engine); - p.rdata(PIdx::N01_Re) = parms->perturbation_amplitude*rand * (p.rdata(PIdx::N00_Re ) - p.rdata(PIdx::N11_Re )); - symmetric_uniform(&rand, engine); - p.rdata(PIdx::N01_Im) = parms->perturbation_amplitude*rand * (p.rdata(PIdx::N00_Re ) - p.rdata(PIdx::N11_Re )); - symmetric_uniform(&rand, engine); - p.rdata(PIdx::N01_Rebar) = parms->perturbation_amplitude*rand * (p.rdata(PIdx::N00_Rebar) - p.rdata(PIdx::N11_Rebar)); - symmetric_uniform(&rand, engine); - p.rdata(PIdx::N01_Imbar) = parms->perturbation_amplitude*rand * (p.rdata(PIdx::N00_Rebar) - p.rdata(PIdx::N11_Rebar));*/ - p.rdata(PIdx::N01_Re) = - p.rdata(PIdx::N11_Re); - p.rdata(PIdx::N01_Im) = - p.rdata(PIdx::N11_Re); - p.rdata(PIdx::N01_Rebar) = - p.rdata(PIdx::N11_Rebar); - p.rdata(PIdx::N01_Imbar) = - p.rdata(PIdx::N11_Rebar); + //Set off-diagonal terms to zero //TODO: This should be reviewed once. + p.rdata(PIdx::N01_Re) = 0.0; + p.rdata(PIdx::N01_Im) = 0.0; + p.rdata(PIdx::N01_Rebar) = 0.0; + p.rdata(PIdx::N01_Imbar) = 0.0; #if NUM_FLAVORS==3 - /*symmetric_uniform(&rand, engine); - p.rdata(PIdx::N02_Re) = parms->perturbation_amplitude*rand * (p.rdata(PIdx::N00_Re ) - p.rdata(PIdx::N22_Re )); - symmetric_uniform(&rand, engine); - p.rdata(PIdx::N02_Im) = parms->perturbation_amplitude*rand * (p.rdata(PIdx::N00_Re ) - p.rdata(PIdx::N22_Re )); - symmetric_uniform(&rand, engine); - p.rdata(PIdx::N12_Re) = parms->perturbation_amplitude*rand * (p.rdata(PIdx::N11_Re ) - p.rdata(PIdx::N22_Re )); - symmetric_uniform(&rand, engine); - p.rdata(PIdx::N12_Im) = parms->perturbation_amplitude*rand * (p.rdata(PIdx::N11_Re ) - p.rdata(PIdx::N22_Re )); - symmetric_uniform(&rand, engine); - p.rdata(PIdx::N02_Rebar) = parms->perturbation_amplitude*rand * (p.rdata(PIdx::N00_Rebar) - p.rdata(PIdx::N22_Rebar)); - symmetric_uniform(&rand, engine); - p.rdata(PIdx::N02_Imbar) = parms->perturbation_amplitude*rand * (p.rdata(PIdx::N00_Rebar) - p.rdata(PIdx::N22_Rebar)); - symmetric_uniform(&rand, engine); - p.rdata(PIdx::N12_Rebar) = parms->perturbation_amplitude*rand * (p.rdata(PIdx::N11_Rebar) - p.rdata(PIdx::N22_Rebar)); - symmetric_uniform(&rand, engine); - p.rdata(PIdx::N12_Imbar) = parms->perturbation_amplitude*rand * (p.rdata(PIdx::N11_Rebar) - p.rdata(PIdx::N22_Rebar));*/ - p.rdata(PIdx::N02_Re) = - p.rdata(PIdx::N22_Re); - p.rdata(PIdx::N02_Im) = - p.rdata(PIdx::N22_Re); - p.rdata(PIdx::N12_Re) = - p.rdata(PIdx::N22_Re); - p.rdata(PIdx::N12_Im) = - p.rdata(PIdx::N22_Re); - p.rdata(PIdx::N02_Rebar) = - p.rdata(PIdx::N22_Rebar); - p.rdata(PIdx::N02_Imbar) = - p.rdata(PIdx::N22_Rebar); - p.rdata(PIdx::N12_Rebar) = - p.rdata(PIdx::N22_Rebar); - p.rdata(PIdx::N12_Imbar) = - p.rdata(PIdx::N22_Rebar); + p.rdata(PIdx::N02_Re) = 0.0; + p.rdata(PIdx::N02_Im) = 0.0; + p.rdata(PIdx::N12_Re) = 0.0; + p.rdata(PIdx::N12_Im) = 0.0; + p.rdata(PIdx::N02_Rebar) = 0.0; + p.rdata(PIdx::N02_Imbar) = 0.0; + p.rdata(PIdx::N12_Rebar) = 0.0; + p.rdata(PIdx::N12_Imbar) = 0.0; #endif - } - if(parms->perturbation_type == 1){ - // Perturb real part of e-mu component only sinusoidally in z - /*Real nu_k = (2.*M_PI) / parms->perturbation_wavelength_cm; - p.rdata(PIdx::N01_Re) = parms->perturbation_amplitude*sin(nu_k*p.pos(2)) * (p.rdata(PIdx::N00_Re ) - p.rdata(PIdx::N11_Re )); - p.rdata(PIdx::N01_Rebar) = parms->perturbation_amplitude*sin(nu_k*p.pos(2)) * (p.rdata(PIdx::N00_Rebar) - p.rdata(PIdx::N11_Rebar));*/ - p.rdata(PIdx::N01_Re) = - p.rdata(PIdx::N11_Re); - p.rdata(PIdx::N01_Rebar) = - p.rdata(PIdx::N11_Rebar); - } } // loop over direction } // loop over location }); // loop over grid cells - //printf("Finished creating particles at boundary. \n"); } // loop over multifabs } // CreateParticlesAtBoundary() diff --git a/Source/NuLibTableHelpers.H b/Source/NuLibTableHelpers.H index cc41bc1..e40ae53 100644 --- a/Source/NuLibTableHelpers.H +++ b/Source/NuLibTableHelpers.H @@ -72,14 +72,6 @@ get_interp_spots_nulib(const double x, const double y, const double z, double &d idx[6] = NTABLES_NULIB*(ix + nrho*((iy-1) + ntemp*((iz-1) + nye*(idx_species + nspecies*idx_group)))); idx[7] = NTABLES_NULIB*((ix-1) + nrho*((iy-1) + ntemp*((iz-1) + nye*(idx_species + nspecies*idx_group)))); - //idx[0] = NTABLES_NULIB*(ix + nrho*(iy + ntemp*iz)); - //idx[1] = NTABLES_NULIB*((ix-1) + nrho*(iy + ntemp*iz)); - //idx[2] = NTABLES_NULIB*(ix + nrho*((iy-1) + ntemp*iz)); - //idx[3] = NTABLES_NULIB*(ix + nrho*(iy + ntemp*(iz-1))); - //idx[4] = NTABLES_NULIB*((ix-1) + nrho*((iy-1) + ntemp*iz)); - //idx[5] = NTABLES_NULIB*((ix-1) + nrho*(iy + ntemp*(iz-1))); - //idx[6] = NTABLES_NULIB*(ix + nrho*((iy-1) + ntemp*(iz-1))); - //idx[7] = NTABLES_NULIB*((ix-1) + nrho*((iy-1) + ntemp*(iz-1))); // set up aux vars for interpolation delx = logrho_nulib[ix] - x; diff --git a/Source/ReadEosTable.cpp b/Source/ReadEosTable.cpp index eba72b9..aafc61d 100644 --- a/Source/ReadEosTable.cpp +++ b/Source/ReadEosTable.cpp @@ -54,17 +54,10 @@ namespace nuc_eos_private { void ReadEosTable(const std::string nuceos_table_name) { using namespace nuc_eos_private; - //std::string nuceos_table_name = "/home/sshanka/000_UTK_projects/Emu/Exec/SFHo.h5"; amrex::Print() << "(ReadEosTable.cpp) Using table: " << nuceos_table_name << std::endl; //TODO: int my_reader_process = 0; //reader_process; - /*if (my_reader_process < 0 || my_reader_process >= CCTK_nProcs(cctkGH)) - { - CCTK_VWarn(CCTK_WARN_COMPLAIN, __LINE__, __FILE__, CCTK_THORNSTRING, - "Requested IO process %d out of range. Reverting to process 0.", my_reader_process); - my_reader_process = 0; - }*/ const int read_table_on_single_process = 1; //const int doIO = !read_table_on_single_process || CCTK_MyProc(cctkGH) == my_reader_process; //TODO: @@ -187,16 +180,11 @@ void ReadEosTable(const std::string nuceos_table_name) { // free memory of temporary array myManagedArena.deallocate(alltables_temp, nrho_ * ntemp_ * nye_ * NTABLES); - // convert units, convert logs to natural log + // convert logs to natural log // The latter is great, because exp() is way faster than pow() - // pressure - //energy_shift_ = energy_shift_ * EPSGF; //Old code. - //energy_shift_ = energy_shift_; //Let's not convert units yet. - + for(int i=0;i dx = geom.CellSizeArray(); - //const auto plo = geom.ProbLoArray(); - //const auto dxi = geom.InvCellSizeArray(); - //const Real inv_cell_volume = dxi[0]*dxi[1]*dxi[2]; - - //const int shape_factor_order_x = geom.Domain().length(0) > 1 ? SHAPE_FACTOR_ORDER : 0; - //const int shape_factor_order_y = geom.Domain().length(1) > 1 ? SHAPE_FACTOR_ORDER : 0; - //const int shape_factor_order_z = geom.Domain().length(2) > 1 ? SHAPE_FACTOR_ORDER : 0; - + //always access mf comp index as (GIdx::rho - start_comp) //Example: Amrex tutorials -> ExampleCodes/MPMD/Case-2/main.cpp. @@ -35,8 +28,6 @@ void set_rho_T_Ye(MultiFab& state, const Geometry& geom) amrex::Real y = (j+0.5) * dx[1]; amrex::Real z = (k+0.5) * dx[2]; - //printf("Inside MFIter: x=%f, y=%f, z=%f\n", x, y, z); - //TODO: Find the global (i, j, k) from the amrex domain. call them (ig, jg, kg). //TODO: Then get the values from GPU-array for (ig, jg, kg) and set them to corresponding MultiFabs here. mf_array(i, j, k, GIdx::rho - start_comp) = -404.0; //FIXME: diff --git a/Source/ReadNuLibTable.cpp b/Source/ReadNuLibTable.cpp index 6947ad3..619b482 100644 --- a/Source/ReadNuLibTable.cpp +++ b/Source/ReadNuLibTable.cpp @@ -1,4 +1,4 @@ -#include + #include #include @@ -7,6 +7,10 @@ #include "NuLibTable.H" +#ifdef AMREX_USE_MPI +printf("AMREX_USE_MPI is defined\n"); +#endif + // mini NoMPI #define HAVE_CAPABILITY_MPI //FIXME: This should be defined only when USE_MPI = TRUE #ifdef HAVE_CAPABILITY_MPI From 2e3a8b3ed3512ebd56390ca12e302ac495b03887 Mon Sep 17 00:00:00 2001 From: shankar-1729 Date: Tue, 1 Oct 2024 11:29:17 -0400 Subject: [PATCH 2/4] more cleanup, enable compiling Emu with and without MPI --- Source/ReadEosTable.cpp | 6 +++++- Source/ReadNuLibTable.cpp | 26 ++------------------------ Source/main.cpp | 4 ---- 3 files changed, 7 insertions(+), 29 deletions(-) diff --git a/Source/ReadEosTable.cpp b/Source/ReadEosTable.cpp index aafc61d..9058170 100644 --- a/Source/ReadEosTable.cpp +++ b/Source/ReadEosTable.cpp @@ -7,8 +7,12 @@ #include "EosTable.H" +#ifdef AMREX_USE_MPI // mini NoMPI -#define HAVE_CAPABILITY_MPI //FIXME: This should be defined only when USE_MPI = TRUE +#define HAVE_CAPABILITY_MPI +#endif + +//#define HAVE_CAPABILITY_MPI #ifdef HAVE_CAPABILITY_MPI #include #define BCAST(buffer, size) MPI_Bcast(buffer, size, MPI_BYTE, my_reader_process, MPI_COMM_WORLD) diff --git a/Source/ReadNuLibTable.cpp b/Source/ReadNuLibTable.cpp index 619b482..ef57bc6 100644 --- a/Source/ReadNuLibTable.cpp +++ b/Source/ReadNuLibTable.cpp @@ -8,11 +8,10 @@ #include "NuLibTable.H" #ifdef AMREX_USE_MPI -printf("AMREX_USE_MPI is defined\n"); +// mini NoMPI +#define HAVE_CAPABILITY_MPI #endif -// mini NoMPI -#define HAVE_CAPABILITY_MPI //FIXME: This should be defined only when USE_MPI = TRUE #ifdef HAVE_CAPABILITY_MPI #include #define BCAST(buffer, size) MPI_Bcast(buffer, size, MPI_BYTE, my_reader_process, MPI_COMM_WORLD) @@ -56,21 +55,13 @@ namespace nulib_private { int *helperVarsInt_nulib; } -//TODO: Pass the /path/to/table here in the function argument void ReadNuLibTable(const std::string nulib_table_name) { using namespace nulib_private; - //std::string nulib_table_name = "/mnt/scratch/tables/NuLib/NuLib_SFHo.h5"; amrex::Print() << "(ReadNuLibTable.cpp) Using table: " << nulib_table_name << std::endl; //TODO: int my_reader_process = 0; //reader_process; - /*if (my_reader_process < 0 || my_reader_process >= CCTK_nProcs(cctkGH)) - { - CCTK_VWarn(CCTK_WARN_COMPLAIN, __LINE__, __FILE__, CCTK_THORNSTRING, - "Requested IO process %d out of range. Reverting to process 0.", my_reader_process); - my_reader_process = 0; - }*/ const int read_table_on_single_process = 1; //const int doIO = !read_table_on_single_process || CCTK_MyProc(cctkGH) == my_reader_process; //TODO: @@ -195,9 +186,7 @@ void ReadNuLibTable(const std::string nulib_table_name) { for(int k = 0; k domain_lo_bc_types(AMREX_SPACEDIM, BCType::int_dir); Vector domain_hi_bc_types(AMREX_SPACEDIM, BCType::int_dir); - //Vector domain_lo_bc_types(AMREX_SPACEDIM, BCType::foextrap); - //Vector domain_hi_bc_types(AMREX_SPACEDIM, BCType::foextrap); // Define the index space of the domain @@ -107,8 +105,6 @@ void evolve_flavor(const TestParams* parms) const IntVect ngrow(1 + (1+shape_factor_order_vec)/2); for(int i=0; incell[i] >= ngrow[i]); - //printf("ngrow = [%d, %d, %d] \n", ngrow[0], ngrow[1], ngrow[2]); - // We want 1 component (this is one real scalar field on the domain) const int ncomp = GIdx::ncomp; From 45b999300e4f07ce6f9b30d83b66b6de849f4a02 Mon Sep 17 00:00:00 2001 From: shankar-1729 Date: Tue, 1 Oct 2024 16:02:58 -0400 Subject: [PATCH 3/4] Just use AMREX_USE_MPI instead of creating another precompiler definition --- Source/ReadEosTable.cpp | 8 ++++---- Source/ReadNuLibTable.cpp | 8 ++++---- 2 files changed, 8 insertions(+), 8 deletions(-) diff --git a/Source/ReadEosTable.cpp b/Source/ReadEosTable.cpp index 9058170..9fc9416 100644 --- a/Source/ReadEosTable.cpp +++ b/Source/ReadEosTable.cpp @@ -7,13 +7,13 @@ #include "EosTable.H" -#ifdef AMREX_USE_MPI +//#ifdef AMREX_USE_MPI // mini NoMPI -#define HAVE_CAPABILITY_MPI -#endif +//#define HAVE_CAPABILITY_MPI +//#endif //#define HAVE_CAPABILITY_MPI -#ifdef HAVE_CAPABILITY_MPI +#ifdef AMREX_USE_MPI #include #define BCAST(buffer, size) MPI_Bcast(buffer, size, MPI_BYTE, my_reader_process, MPI_COMM_WORLD) #else diff --git a/Source/ReadNuLibTable.cpp b/Source/ReadNuLibTable.cpp index ef57bc6..77ec93b 100644 --- a/Source/ReadNuLibTable.cpp +++ b/Source/ReadNuLibTable.cpp @@ -7,12 +7,12 @@ #include "NuLibTable.H" -#ifdef AMREX_USE_MPI +//#ifdef AMREX_USE_MPI // mini NoMPI -#define HAVE_CAPABILITY_MPI -#endif +//#define HAVE_CAPABILITY_MPI +//#endif -#ifdef HAVE_CAPABILITY_MPI +#ifdef AMREX_USE_MPI #include #define BCAST(buffer, size) MPI_Bcast(buffer, size, MPI_BYTE, my_reader_process, MPI_COMM_WORLD) #else From 4eb046325c1591eff3aa990156da09f300d1e370 Mon Sep 17 00:00:00 2001 From: shankar-1729 Date: Tue, 1 Oct 2024 16:05:58 -0400 Subject: [PATCH 4/4] cleanup --- Source/ReadEosTable.cpp | 6 ------ Source/ReadNuLibTable.cpp | 5 ----- 2 files changed, 11 deletions(-) diff --git a/Source/ReadEosTable.cpp b/Source/ReadEosTable.cpp index 9fc9416..1db3765 100644 --- a/Source/ReadEosTable.cpp +++ b/Source/ReadEosTable.cpp @@ -7,12 +7,6 @@ #include "EosTable.H" -//#ifdef AMREX_USE_MPI -// mini NoMPI -//#define HAVE_CAPABILITY_MPI -//#endif - -//#define HAVE_CAPABILITY_MPI #ifdef AMREX_USE_MPI #include #define BCAST(buffer, size) MPI_Bcast(buffer, size, MPI_BYTE, my_reader_process, MPI_COMM_WORLD) diff --git a/Source/ReadNuLibTable.cpp b/Source/ReadNuLibTable.cpp index 77ec93b..bbed857 100644 --- a/Source/ReadNuLibTable.cpp +++ b/Source/ReadNuLibTable.cpp @@ -7,11 +7,6 @@ #include "NuLibTable.H" -//#ifdef AMREX_USE_MPI -// mini NoMPI -//#define HAVE_CAPABILITY_MPI -//#endif - #ifdef AMREX_USE_MPI #include #define BCAST(buffer, size) MPI_Bcast(buffer, size, MPI_BYTE, my_reader_process, MPI_COMM_WORLD)