diff options
Diffstat (limited to 'Source')
19 files changed, 91 insertions, 91 deletions
diff --git a/Source/Diagnostics/FullDiagnostics.cpp b/Source/Diagnostics/FullDiagnostics.cpp index 933852279..c4529bac8 100644 --- a/Source/Diagnostics/FullDiagnostics.cpp +++ b/Source/Diagnostics/FullDiagnostics.cpp @@ -464,8 +464,8 @@ FullDiagnostics::PrepareFieldDataForOutput () // First, make sure all guard cells are properly filled // Probably overkill/unnecessary, but safe and shouldn't happen often !! auto & warpx = WarpX::GetInstance(); - warpx.FillBoundaryE(warpx.getngE()); - warpx.FillBoundaryB(warpx.getngE()); + warpx.FillBoundaryE(warpx.getngEB()); + warpx.FillBoundaryB(warpx.getngEB()); warpx.UpdateAuxilaryData(); warpx.FillBoundaryAux(warpx.getngUpdateAux()); diff --git a/Source/Diagnostics/ReducedDiags/ParticleExtrema.cpp b/Source/Diagnostics/ReducedDiags/ParticleExtrema.cpp index a7586ba46..304f4c5a1 100644 --- a/Source/Diagnostics/ReducedDiags/ParticleExtrema.cpp +++ b/Source/Diagnostics/ReducedDiags/ParticleExtrema.cpp @@ -398,7 +398,7 @@ void ParticleExtrema::ComputeDiags (int step) const int n_rz_azimuthal_modes = WarpX::n_rz_azimuthal_modes; const int nox = WarpX::nox; const bool galerkin_interpolation = WarpX::galerkin_interpolation; - const amrex::IntVect ngE = warpx.getngE(); + const amrex::IntVect ngEB = warpx.getngEB(); amrex::Vector<amrex::Real> v_galilean = myspc.get_v_galilean(); const auto& time_of_last_gal_shift = warpx.time_of_last_gal_shift; @@ -432,7 +432,7 @@ void ParticleExtrema::ComputeDiags (int step) // define variables in preparation for field gathering amrex::Box box = pti.tilebox(); - box.grow(ngE); + box.grow(ngEB); const Dim3 lo = amrex::lbound(box); const std::array<amrex::Real, 3>& xyzmin = WarpX::LowerCorner(box, galilean_shift, lev); const GpuArray<amrex::Real, 3> xyzmin_arr = {xyzmin[0], xyzmin[1], xyzmin[2]}; diff --git a/Source/FieldSolver/FiniteDifferenceSolver/MacroscopicProperties/MacroscopicProperties.cpp b/Source/FieldSolver/FiniteDifferenceSolver/MacroscopicProperties/MacroscopicProperties.cpp index 8076bdf8f..2a35102cf 100644 --- a/Source/FieldSolver/FiniteDifferenceSolver/MacroscopicProperties/MacroscopicProperties.cpp +++ b/Source/FieldSolver/FiniteDifferenceSolver/MacroscopicProperties/MacroscopicProperties.cpp @@ -123,7 +123,7 @@ MacroscopicProperties::InitData () int lev = 0; amrex::BoxArray ba = warpx.boxArray(lev); amrex::DistributionMapping dmap = warpx.DistributionMap(lev); - const amrex::IntVect ng_EB_alloc = warpx.getngE(); + const amrex::IntVect ng_EB_alloc = warpx.getngEB(); // Define material property multifabs using ba and dmap from WarpX instance // sigma is cell-centered MultiFab m_sigma_mf = std::make_unique<amrex::MultiFab>(ba, dmap, 1, ng_EB_alloc); diff --git a/Source/Parallelization/WarpXRegrid.cpp b/Source/Parallelization/WarpXRegrid.cpp index 7c1371f29..c903c92d6 100644 --- a/Source/Parallelization/WarpXRegrid.cpp +++ b/Source/Parallelization/WarpXRegrid.cpp @@ -213,12 +213,12 @@ WarpX::RemakeLevel (int lev, Real /*time*/, const BoxArray& ba, const Distributi // Get the cell-centered box BoxArray realspace_ba = ba; // Copy box realspace_ba.enclosedCells(); // Make it cell-centered - auto ngE = getngE(); + auto ngEB = getngEB(); auto dx = CellSize(lev); # ifdef WARPX_DIM_RZ if ( fft_periodic_single_box == false ) { - realspace_ba.grow(1, ngE[1]); // add guard cells only in z + realspace_ba.grow(1, ngEB[1]); // add guard cells only in z } AllocLevelSpectralSolverRZ(spectral_solver_fp, lev, @@ -227,7 +227,7 @@ WarpX::RemakeLevel (int lev, Real /*time*/, const BoxArray& ba, const Distributi dx); # else if ( fft_periodic_single_box == false ) { - realspace_ba.grow(ngE); // add guard cells + realspace_ba.grow(ngEB); // add guard cells } bool const pml_flag_false = false; AllocLevelSpectralSolver(spectral_solver_fp, @@ -278,17 +278,17 @@ WarpX::RemakeLevel (int lev, Real /*time*/, const BoxArray& ba, const Distributi BoxArray c_realspace_ba = cba; // Copy box c_realspace_ba.enclosedCells(); // Make it cell-centered - auto ngE = getngE(); + auto ngEB = getngEB(); # ifdef WARPX_DIM_RZ - c_realspace_ba.grow(1, ngE[1]); // add guard cells only in z + c_realspace_ba.grow(1, ngEB[1]); // add guard cells only in z AllocLevelSpectralSolverRZ(spectral_solver_cp, lev, c_realspace_ba, dm, cdx); # else - c_realspace_ba.grow(ngE); + c_realspace_ba.grow(ngEB); bool const pml_flag_false = false; AllocLevelSpectralSolver(spectral_solver_cp, lev, diff --git a/Source/Particles/ElementaryProcess/Ionization.H b/Source/Particles/ElementaryProcess/Ionization.H index 1ed862775..eeac927a9 100644 --- a/Source/Particles/ElementaryProcess/Ionization.H +++ b/Source/Particles/ElementaryProcess/Ionization.H @@ -63,7 +63,7 @@ struct IonizationFilterFunc amrex::Dim3 m_lo; - IonizationFilterFunc (const WarpXParIter& a_pti, int lev, amrex::IntVect ngE, + IonizationFilterFunc (const WarpXParIter& a_pti, int lev, amrex::IntVect ngEB, amrex::FArrayBox const& exfab, amrex::FArrayBox const& eyfab, amrex::FArrayBox const& ezfab, diff --git a/Source/Particles/ElementaryProcess/Ionization.cpp b/Source/Particles/ElementaryProcess/Ionization.cpp index 9ca20889e..5264faf93 100644 --- a/Source/Particles/ElementaryProcess/Ionization.cpp +++ b/Source/Particles/ElementaryProcess/Ionization.cpp @@ -17,7 +17,7 @@ #include <algorithm> #include <array> -IonizationFilterFunc::IonizationFilterFunc (const WarpXParIter& a_pti, int lev, amrex::IntVect ngE, +IonizationFilterFunc::IonizationFilterFunc (const WarpXParIter& a_pti, int lev, amrex::IntVect ngEB, amrex::FArrayBox const& exfab, amrex::FArrayBox const& eyfab, amrex::FArrayBox const& ezfab, @@ -58,7 +58,7 @@ IonizationFilterFunc::IonizationFilterFunc (const WarpXParIter& a_pti, int lev, m_bz_type = bzfab.box().ixType(); amrex::Box box = a_pti.tilebox(); - box.grow(ngE); + box.grow(ngEB); const std::array<amrex::Real,3>& dx = WarpX::CellSize(std::max(lev, 0)); m_dx_arr = {dx[0], dx[1], dx[2]}; diff --git a/Source/Particles/ElementaryProcess/QEDPairGeneration.H b/Source/Particles/ElementaryProcess/QEDPairGeneration.H index 9d86c177d..a125ccc8b 100644 --- a/Source/Particles/ElementaryProcess/QEDPairGeneration.H +++ b/Source/Particles/ElementaryProcess/QEDPairGeneration.H @@ -87,7 +87,7 @@ public: * @param[in] generate_functor functor to be called to determine the properties of the generated pairs * @param[in] a_pti particle iterator to iterate over photons undergoing QED pair generation process * @param[in] lev the mesh-refinement level - * @param[in] ngE number of guard cells allocated for the E and B MultiFabs + * @param[in] ngEB number of guard cells allocated for the E and B MultiFabs * @param[in] exfab constant reference to the FArrayBox of the x component of the electric field * @param[in] eyfab constant reference to the FArrayBox of the y component of the electric field * @param[in] ezfab constant reference to the FArrayBox of the z component of the electric field @@ -98,7 +98,7 @@ public: * @param[in] a_offset offset to apply to the particle indices */ PairGenerationTransformFunc(BreitWheelerGeneratePairs const generate_functor, - const WarpXParIter& a_pti, int lev, amrex::IntVect ngE, + const WarpXParIter& a_pti, int lev, amrex::IntVect ngEB, amrex::FArrayBox const& exfab, amrex::FArrayBox const& eyfab, amrex::FArrayBox const& ezfab, diff --git a/Source/Particles/ElementaryProcess/QEDPairGeneration.cpp b/Source/Particles/ElementaryProcess/QEDPairGeneration.cpp index 9d5876ef3..52134ca81 100644 --- a/Source/Particles/ElementaryProcess/QEDPairGeneration.cpp +++ b/Source/Particles/ElementaryProcess/QEDPairGeneration.cpp @@ -19,7 +19,7 @@ PairGenerationTransformFunc:: PairGenerationTransformFunc (BreitWheelerGeneratePairs const generate_functor, - const WarpXParIter& a_pti, int lev, amrex::IntVect ngE, + const WarpXParIter& a_pti, int lev, amrex::IntVect ngEB, amrex::FArrayBox const& exfab, amrex::FArrayBox const& eyfab, amrex::FArrayBox const& ezfab, @@ -48,7 +48,7 @@ PairGenerationTransformFunc (BreitWheelerGeneratePairs const generate_functor, m_bz_type = bzfab.box().ixType(); amrex::Box box = a_pti.tilebox(); - box.grow(ngE); + box.grow(ngEB); const std::array<amrex::Real,3>& dx = WarpX::CellSize(std::max(lev, 0)); m_dx_arr = {dx[0], dx[1], dx[2]}; diff --git a/Source/Particles/ElementaryProcess/QEDPhotonEmission.H b/Source/Particles/ElementaryProcess/QEDPhotonEmission.H index 464f1ef16..21cd34730 100644 --- a/Source/Particles/ElementaryProcess/QEDPhotonEmission.H +++ b/Source/Particles/ElementaryProcess/QEDPhotonEmission.H @@ -98,7 +98,7 @@ public: * @param[in] emission_functor functor to generate photons and update momentum of the source particles * @param[in] a_pti particle iterator to iterate over electrons or positrons undergoing QED photon emission process * @param[in] lev the mesh-refinement level - * @param[in] ngE number of guard cells allocated for the E and B MultiFabs + * @param[in] ngEB number of guard cells allocated for the E and B MultiFabs * @param[in] exfab constant reference to the FArrayBox of the x component of the electric field * @param[in] eyfab constant reference to the FArrayBox of the y component of the electric field * @param[in] ezfab constant reference to the FArrayBox of the z component of the electric field @@ -112,7 +112,7 @@ public: QuantumSynchrotronGetOpticalDepth opt_depth_functor, int const opt_depth_runtime_comp, QuantumSynchrotronPhotonEmission const emission_functor, - const WarpXParIter& a_pti, int lev, amrex::IntVect ngE, + const WarpXParIter& a_pti, int lev, amrex::IntVect ngEB, amrex::FArrayBox const& exfab, amrex::FArrayBox const& eyfab, amrex::FArrayBox const& ezfab, diff --git a/Source/Particles/ElementaryProcess/QEDPhotonEmission.cpp b/Source/Particles/ElementaryProcess/QEDPhotonEmission.cpp index b2daf4127..368a4ee96 100644 --- a/Source/Particles/ElementaryProcess/QEDPhotonEmission.cpp +++ b/Source/Particles/ElementaryProcess/QEDPhotonEmission.cpp @@ -20,7 +20,7 @@ PhotonEmissionTransformFunc:: PhotonEmissionTransformFunc (QuantumSynchrotronGetOpticalDepth opt_depth_functor, int const opt_depth_runtime_comp, QuantumSynchrotronPhotonEmission const emission_functor, - const WarpXParIter& a_pti, int lev, amrex::IntVect ngE, + const WarpXParIter& a_pti, int lev, amrex::IntVect ngEB, amrex::FArrayBox const& exfab, amrex::FArrayBox const& eyfab, amrex::FArrayBox const& ezfab, @@ -51,7 +51,7 @@ PhotonEmissionTransformFunc (QuantumSynchrotronGetOpticalDepth opt_depth_functor m_bz_type = bzfab.box().ixType(); amrex::Box box = a_pti.tilebox(); - box.grow(ngE); + box.grow(ngEB); const std::array<amrex::Real,3>& dx = WarpX::CellSize(std::max(lev, 0)); m_dx_arr = {dx[0], dx[1], dx[2]}; diff --git a/Source/Particles/PhotonParticleContainer.H b/Source/Particles/PhotonParticleContainer.H index 6ef433900..73f663eec 100644 --- a/Source/Particles/PhotonParticleContainer.H +++ b/Source/Particles/PhotonParticleContainer.H @@ -73,7 +73,7 @@ public: amrex::FArrayBox const * bxfab, amrex::FArrayBox const * byfab, amrex::FArrayBox const * bzfab, - const amrex::IntVect ngE, const int /*e_is_nodal*/, + const amrex::IntVect ngEB, const int /*e_is_nodal*/, const long offset, const long np_to_push, int lev, int gather_lev, diff --git a/Source/Particles/PhotonParticleContainer.cpp b/Source/Particles/PhotonParticleContainer.cpp index 7b08f9430..b78396653 100644 --- a/Source/Particles/PhotonParticleContainer.cpp +++ b/Source/Particles/PhotonParticleContainer.cpp @@ -86,7 +86,7 @@ PhotonParticleContainer::PushPX (WarpXParIter& pti, amrex::FArrayBox const * bxfab, amrex::FArrayBox const * byfab, amrex::FArrayBox const * bzfab, - const amrex::IntVect ngE, const int /*e_is_nodal*/, + const amrex::IntVect ngEB, const int /*e_is_nodal*/, const long offset, const long np_to_push, int lev, int gather_lev, @@ -106,7 +106,7 @@ PhotonParticleContainer::PushPX (WarpXParIter& pti, } // Add guard cells to the box. - box.grow(ngE); + box.grow(ngEB); auto& attribs = pti.GetAttribs(); diff --git a/Source/Particles/PhysicalParticleContainer.H b/Source/Particles/PhysicalParticleContainer.H index ea97afb51..23866c2e4 100644 --- a/Source/Particles/PhysicalParticleContainer.H +++ b/Source/Particles/PhysicalParticleContainer.H @@ -140,7 +140,7 @@ public: amrex::FArrayBox const * bxfab, amrex::FArrayBox const * byfab, amrex::FArrayBox const * bzfab, - const amrex::IntVect ngE, const int /*e_is_nodal*/, + const amrex::IntVect ngEB, const int /*e_is_nodal*/, const long offset, const long np_to_push, int lev, int gather_lev, @@ -174,7 +174,7 @@ public: IonizationFilterFunc getIonizationFunc (const WarpXParIter& pti, int lev, - amrex::IntVect ngE, + amrex::IntVect ngEB, const amrex::FArrayBox& Ex, const amrex::FArrayBox& Ey, const amrex::FArrayBox& Ez, diff --git a/Source/Particles/PhysicalParticleContainer.cpp b/Source/Particles/PhysicalParticleContainer.cpp index 4225e630a..0ff90993a 100644 --- a/Source/Particles/PhysicalParticleContainer.cpp +++ b/Source/Particles/PhysicalParticleContainer.cpp @@ -2433,7 +2433,7 @@ PhysicalParticleContainer::PushPX (WarpXParIter& pti, amrex::FArrayBox const * bxfab, amrex::FArrayBox const * byfab, amrex::FArrayBox const * bzfab, - const amrex::IntVect ngE, const int /*e_is_nodal*/, + const amrex::IntVect ngEB, const int /*e_is_nodal*/, const long offset, const long np_to_push, int lev, int gather_lev, @@ -2460,7 +2460,7 @@ PhysicalParticleContainer::PushPX (WarpXParIter& pti, } // Add guard cells to the box. - box.grow(ngE); + box.grow(ngEB); const auto getPosition = GetParticlePosition(pti, offset); auto setPosition = SetParticlePosition(pti, offset); @@ -2678,7 +2678,7 @@ PhysicalParticleContainer::InitIonizationModule () IonizationFilterFunc PhysicalParticleContainer::getIonizationFunc (const WarpXParIter& pti, int lev, - amrex::IntVect ngE, + amrex::IntVect ngEB, const amrex::FArrayBox& Ex, const amrex::FArrayBox& Ey, const amrex::FArrayBox& Ez, @@ -2688,7 +2688,7 @@ PhysicalParticleContainer::getIonizationFunc (const WarpXParIter& pti, { WARPX_PROFILE("PhysicalParticleContainer::getIonizationFunc()"); - return IonizationFilterFunc(pti, lev, ngE, Ex, Ey, Ez, Bx, By, Bz, + return IonizationFilterFunc(pti, lev, ngEB, Ex, Ey, Ez, Bx, By, Bz, m_v_galilean, ionization_energies.dataPtr(), adk_prefactor.dataPtr(), diff --git a/Source/Particles/RigidInjectedParticleContainer.H b/Source/Particles/RigidInjectedParticleContainer.H index cb13e0258..81b9448d6 100644 --- a/Source/Particles/RigidInjectedParticleContainer.H +++ b/Source/Particles/RigidInjectedParticleContainer.H @@ -87,7 +87,7 @@ public: amrex::FArrayBox const * bxfab, amrex::FArrayBox const * byfab, amrex::FArrayBox const * bzfab, - const amrex::IntVect ngE, const int /*e_is_nodal*/, + const amrex::IntVect ngEB, const int /*e_is_nodal*/, const long offset, const long np_to_push, int lev, int gather_lev, diff --git a/Source/Particles/RigidInjectedParticleContainer.cpp b/Source/Particles/RigidInjectedParticleContainer.cpp index 347acd2b5..bf4394d59 100644 --- a/Source/Particles/RigidInjectedParticleContainer.cpp +++ b/Source/Particles/RigidInjectedParticleContainer.cpp @@ -157,7 +157,7 @@ RigidInjectedParticleContainer::PushPX (WarpXParIter& pti, amrex::FArrayBox const * bxfab, amrex::FArrayBox const * byfab, amrex::FArrayBox const * bzfab, - const amrex::IntVect ngE, const int e_is_nodal, + const amrex::IntVect ngEB, const int e_is_nodal, const long offset, const long np_to_push, int lev, int gather_lev, @@ -217,7 +217,7 @@ RigidInjectedParticleContainer::PushPX (WarpXParIter& pti, const bool do_scale = not done_injecting_lev; const Real v_boost = WarpX::beta_boost*PhysConst::c; PhysicalParticleContainer::PushPX(pti, exfab, eyfab, ezfab, bxfab, byfab, bzfab, - ngE, e_is_nodal, offset, np_to_push, lev, gather_lev, dt, + ngEB, e_is_nodal, offset, np_to_push, lev, gather_lev, dt, ScaleFields(do_scale, dt, zinject_plane_lev_previous, vzbeam_ave_boosted, v_boost), a_dt_type); diff --git a/Source/Python/WarpXWrappers.cpp b/Source/Python/WarpXWrappers.cpp index accecd615..8f49057e4 100644 --- a/Source/Python/WarpXWrappers.cpp +++ b/Source/Python/WarpXWrappers.cpp @@ -662,11 +662,11 @@ namespace } void warpx_FillBoundaryE () { WarpX& warpx = WarpX::GetInstance(); - warpx.FillBoundaryE(warpx.getngE()); + warpx.FillBoundaryE(warpx.getngEB()); } void warpx_FillBoundaryB () { WarpX& warpx = WarpX::GetInstance(); - warpx.FillBoundaryB(warpx.getngE()); + warpx.FillBoundaryB(warpx.getngEB()); } void warpx_SyncRho () { WarpX& warpx = WarpX::GetInstance(); diff --git a/Source/WarpX.H b/Source/WarpX.H index 06c667a2e..3fac6f5b1 100644 --- a/Source/WarpX.H +++ b/Source/WarpX.H @@ -685,7 +685,7 @@ public: void ComputeDivE(amrex::MultiFab& divE, const int lev); - const amrex::IntVect getngE() const { return guard_cells.ng_alloc_EB; } + const amrex::IntVect getngEB() const { return guard_cells.ng_alloc_EB; } const amrex::IntVect getngF() const { return guard_cells.ng_alloc_F; } const amrex::IntVect getngUpdateAux() const { return guard_cells.ng_UpdateAux; } const amrex::IntVect get_ng_depos_J() const {return guard_cells.ng_depos_J;} @@ -991,7 +991,7 @@ private: #endif void AllocLevelMFs (int lev, const amrex::BoxArray& ba, const amrex::DistributionMapping& dm, - const amrex::IntVect& ngE, const amrex::IntVect& ngJ, + const amrex::IntVect& ngEB, const amrex::IntVect& ngJ, const amrex::IntVect& ngRho, const amrex::IntVect& ngF, const amrex::IntVect& ngG, const bool aux_is_nodal); #ifdef WARPX_USE_PSATD diff --git a/Source/WarpX.cpp b/Source/WarpX.cpp index f50f4dc9f..82d990a87 100644 --- a/Source/WarpX.cpp +++ b/Source/WarpX.cpp @@ -1561,7 +1561,7 @@ WarpX::AllocLevelData (int lev, const BoxArray& ba, const DistributionMapping& d void WarpX::AllocLevelMFs (int lev, const BoxArray& ba, const DistributionMapping& dm, - const IntVect& ngE, const IntVect& ngJ, const IntVect& ngRho, + const IntVect& ngEB, const IntVect& ngJ, const IntVect& ngRho, const IntVect& ngF, const IntVect& ngG, const bool aux_is_nodal) { // Declare nodal flags @@ -1661,13 +1661,13 @@ WarpX::AllocLevelMFs (int lev, const BoxArray& ba, const DistributionMapping& dm // std::array<Real,3> dx = CellSize(lev); - Bfield_fp[lev][0] = std::make_unique<MultiFab>(amrex::convert(ba,Bx_nodal_flag),dm,ncomps,ngE,tag("Bfield_fp[x]")); - Bfield_fp[lev][1] = std::make_unique<MultiFab>(amrex::convert(ba,By_nodal_flag),dm,ncomps,ngE,tag("Bfield_fp[y]")); - Bfield_fp[lev][2] = std::make_unique<MultiFab>(amrex::convert(ba,Bz_nodal_flag),dm,ncomps,ngE,tag("Bfield_fp[z]")); + Bfield_fp[lev][0] = std::make_unique<MultiFab>(amrex::convert(ba,Bx_nodal_flag),dm,ncomps,ngEB,tag("Bfield_fp[x]")); + Bfield_fp[lev][1] = std::make_unique<MultiFab>(amrex::convert(ba,By_nodal_flag),dm,ncomps,ngEB,tag("Bfield_fp[y]")); + Bfield_fp[lev][2] = std::make_unique<MultiFab>(amrex::convert(ba,Bz_nodal_flag),dm,ncomps,ngEB,tag("Bfield_fp[z]")); - Efield_fp[lev][0] = std::make_unique<MultiFab>(amrex::convert(ba,Ex_nodal_flag),dm,ncomps,ngE,tag("Efield_fp[x]")); - Efield_fp[lev][1] = std::make_unique<MultiFab>(amrex::convert(ba,Ey_nodal_flag),dm,ncomps,ngE,tag("Efield_fp[y]")); - Efield_fp[lev][2] = std::make_unique<MultiFab>(amrex::convert(ba,Ez_nodal_flag),dm,ncomps,ngE,tag("Efield_fp[z]")); + Efield_fp[lev][0] = std::make_unique<MultiFab>(amrex::convert(ba,Ex_nodal_flag),dm,ncomps,ngEB,tag("Efield_fp[x]")); + Efield_fp[lev][1] = std::make_unique<MultiFab>(amrex::convert(ba,Ey_nodal_flag),dm,ncomps,ngEB,tag("Efield_fp[y]")); + Efield_fp[lev][2] = std::make_unique<MultiFab>(amrex::convert(ba,Ez_nodal_flag),dm,ncomps,ngEB,tag("Efield_fp[z]")); current_fp[lev][0] = std::make_unique<MultiFab>(amrex::convert(ba,jx_nodal_flag),dm,ncomps,ngJ,tag("current_fp[x]")); current_fp[lev][1] = std::make_unique<MultiFab>(amrex::convert(ba,jy_nodal_flag),dm,ncomps,ngJ,tag("current_fp[y]")); @@ -1681,13 +1681,13 @@ WarpX::AllocLevelMFs (int lev, const BoxArray& ba, const DistributionMapping& dm current_fp_nodal[lev][2] = std::make_unique<MultiFab>(nodal_ba, dm, ncomps, ngJ); } - Bfield_avg_fp[lev][0] = std::make_unique<MultiFab>(amrex::convert(ba,Bx_nodal_flag),dm,ncomps,ngE,tag("Bfield_avg_fp[x]")); - Bfield_avg_fp[lev][1] = std::make_unique<MultiFab>(amrex::convert(ba,By_nodal_flag),dm,ncomps,ngE,tag("Bfield_avg_fp[y]")); - Bfield_avg_fp[lev][2] = std::make_unique<MultiFab>(amrex::convert(ba,Bz_nodal_flag),dm,ncomps,ngE,tag("Bfield_avg_fp[z]")); + Bfield_avg_fp[lev][0] = std::make_unique<MultiFab>(amrex::convert(ba,Bx_nodal_flag),dm,ncomps,ngEB,tag("Bfield_avg_fp[x]")); + Bfield_avg_fp[lev][1] = std::make_unique<MultiFab>(amrex::convert(ba,By_nodal_flag),dm,ncomps,ngEB,tag("Bfield_avg_fp[y]")); + Bfield_avg_fp[lev][2] = std::make_unique<MultiFab>(amrex::convert(ba,Bz_nodal_flag),dm,ncomps,ngEB,tag("Bfield_avg_fp[z]")); - Efield_avg_fp[lev][0] = std::make_unique<MultiFab>(amrex::convert(ba,Ex_nodal_flag),dm,ncomps,ngE,tag("Efield_avg_fp[x]")); - Efield_avg_fp[lev][1] = std::make_unique<MultiFab>(amrex::convert(ba,Ey_nodal_flag),dm,ncomps,ngE,tag("Efield_avg_fp[y]")); - Efield_avg_fp[lev][2] = std::make_unique<MultiFab>(amrex::convert(ba,Ez_nodal_flag),dm,ncomps,ngE,tag("Efield_avg_fp[z]")); + Efield_avg_fp[lev][0] = std::make_unique<MultiFab>(amrex::convert(ba,Ex_nodal_flag),dm,ncomps,ngEB,tag("Efield_avg_fp[x]")); + Efield_avg_fp[lev][1] = std::make_unique<MultiFab>(amrex::convert(ba,Ey_nodal_flag),dm,ncomps,ngEB,tag("Efield_avg_fp[y]")); + Efield_avg_fp[lev][2] = std::make_unique<MultiFab>(amrex::convert(ba,Ez_nodal_flag),dm,ncomps,ngEB,tag("Efield_avg_fp[z]")); #ifdef AMREX_USE_EB // EB info are needed only at the finest level @@ -1802,7 +1802,7 @@ WarpX::AllocLevelMFs (int lev, const BoxArray& ba, const DistributionMapping& dm // Define spectral solver # ifdef WARPX_DIM_RZ if ( fft_periodic_single_box == false ) { - realspace_ba.grow(1, ngE[1]); // add guard cells only in z + realspace_ba.grow(1, ngEB[1]); // add guard cells only in z } if (field_boundary_hi[0] == FieldBoundaryType::PML && !do_pml_in_domain) { // Extend region that is solved for to include the guard cells @@ -1816,7 +1816,7 @@ WarpX::AllocLevelMFs (int lev, const BoxArray& ba, const DistributionMapping& dm dx); # else if ( fft_periodic_single_box == false ) { - realspace_ba.grow(ngE); // add guard cells + realspace_ba.grow(ngEB); // add guard cells } bool const pml_flag_false = false; AllocLevelSpectralSolver(spectral_solver_fp, @@ -1840,13 +1840,13 @@ WarpX::AllocLevelMFs (int lev, const BoxArray& ba, const DistributionMapping& dm // Create aux multifabs on Nodal Box Array BoxArray const nba = amrex::convert(ba,IntVect::TheNodeVector()); - Bfield_aux[lev][0] = std::make_unique<MultiFab>(nba,dm,ncomps,ngE,tag("Bfield_aux[x]")); - Bfield_aux[lev][1] = std::make_unique<MultiFab>(nba,dm,ncomps,ngE,tag("Bfield_aux[y]")); - Bfield_aux[lev][2] = std::make_unique<MultiFab>(nba,dm,ncomps,ngE,tag("Bfield_aux[z]")); + Bfield_aux[lev][0] = std::make_unique<MultiFab>(nba,dm,ncomps,ngEB,tag("Bfield_aux[x]")); + Bfield_aux[lev][1] = std::make_unique<MultiFab>(nba,dm,ncomps,ngEB,tag("Bfield_aux[y]")); + Bfield_aux[lev][2] = std::make_unique<MultiFab>(nba,dm,ncomps,ngEB,tag("Bfield_aux[z]")); - Efield_aux[lev][0] = std::make_unique<MultiFab>(nba,dm,ncomps,ngE,tag("Efield_aux[x]")); - Efield_aux[lev][1] = std::make_unique<MultiFab>(nba,dm,ncomps,ngE,tag("Efield_aux[y]")); - Efield_aux[lev][2] = std::make_unique<MultiFab>(nba,dm,ncomps,ngE,tag("Efield_aux[z]")); + Efield_aux[lev][0] = std::make_unique<MultiFab>(nba,dm,ncomps,ngEB,tag("Efield_aux[x]")); + Efield_aux[lev][1] = std::make_unique<MultiFab>(nba,dm,ncomps,ngEB,tag("Efield_aux[y]")); + Efield_aux[lev][2] = std::make_unique<MultiFab>(nba,dm,ncomps,ngEB,tag("Efield_aux[z]")); } else if (lev == 0) { if (!WarpX::fft_do_time_averaging) { // In this case, the aux grid is simply an alias of the fp grid @@ -1867,13 +1867,13 @@ WarpX::AllocLevelMFs (int lev, const BoxArray& ba, const DistributionMapping& dm Bfield_aux[lev][2] = std::make_unique<MultiFab>(*Bfield_avg_fp[lev][2], amrex::make_alias, 0, ncomps); } } else { - Bfield_aux[lev][0] = std::make_unique<MultiFab>(amrex::convert(ba,Bx_nodal_flag),dm,ncomps,ngE,tag("Bfield_aux[x]")); - Bfield_aux[lev][1] = std::make_unique<MultiFab>(amrex::convert(ba,By_nodal_flag),dm,ncomps,ngE,tag("Bfield_aux[y]")); - Bfield_aux[lev][2] = std::make_unique<MultiFab>(amrex::convert(ba,Bz_nodal_flag),dm,ncomps,ngE,tag("Bfield_aux[z]")); + Bfield_aux[lev][0] = std::make_unique<MultiFab>(amrex::convert(ba,Bx_nodal_flag),dm,ncomps,ngEB,tag("Bfield_aux[x]")); + Bfield_aux[lev][1] = std::make_unique<MultiFab>(amrex::convert(ba,By_nodal_flag),dm,ncomps,ngEB,tag("Bfield_aux[y]")); + Bfield_aux[lev][2] = std::make_unique<MultiFab>(amrex::convert(ba,Bz_nodal_flag),dm,ncomps,ngEB,tag("Bfield_aux[z]")); - Efield_aux[lev][0] = std::make_unique<MultiFab>(amrex::convert(ba,Ex_nodal_flag),dm,ncomps,ngE,tag("Efield_aux[x]")); - Efield_aux[lev][1] = std::make_unique<MultiFab>(amrex::convert(ba,Ey_nodal_flag),dm,ncomps,ngE,tag("Efield_aux[y]")); - Efield_aux[lev][2] = std::make_unique<MultiFab>(amrex::convert(ba,Ez_nodal_flag),dm,ncomps,ngE,tag("Efield_aux[z]")); + Efield_aux[lev][0] = std::make_unique<MultiFab>(amrex::convert(ba,Ex_nodal_flag),dm,ncomps,ngEB,tag("Efield_aux[x]")); + Efield_aux[lev][1] = std::make_unique<MultiFab>(amrex::convert(ba,Ey_nodal_flag),dm,ncomps,ngEB,tag("Efield_aux[y]")); + Efield_aux[lev][2] = std::make_unique<MultiFab>(amrex::convert(ba,Ez_nodal_flag),dm,ncomps,ngEB,tag("Efield_aux[z]")); } // @@ -1886,24 +1886,24 @@ WarpX::AllocLevelMFs (int lev, const BoxArray& ba, const DistributionMapping& dm std::array<Real,3> cdx = CellSize(lev-1); // Create the MultiFabs for B - Bfield_cp[lev][0] = std::make_unique<MultiFab>(amrex::convert(cba,Bx_nodal_flag),dm,ncomps,ngE,tag("Bfield_cp[x]")); - Bfield_cp[lev][1] = std::make_unique<MultiFab>(amrex::convert(cba,By_nodal_flag),dm,ncomps,ngE,tag("Bfield_cp[y]")); - Bfield_cp[lev][2] = std::make_unique<MultiFab>(amrex::convert(cba,Bz_nodal_flag),dm,ncomps,ngE,tag("Bfield_cp[z]")); + Bfield_cp[lev][0] = std::make_unique<MultiFab>(amrex::convert(cba,Bx_nodal_flag),dm,ncomps,ngEB,tag("Bfield_cp[x]")); + Bfield_cp[lev][1] = std::make_unique<MultiFab>(amrex::convert(cba,By_nodal_flag),dm,ncomps,ngEB,tag("Bfield_cp[y]")); + Bfield_cp[lev][2] = std::make_unique<MultiFab>(amrex::convert(cba,Bz_nodal_flag),dm,ncomps,ngEB,tag("Bfield_cp[z]")); // Create the MultiFabs for E - Efield_cp[lev][0] = std::make_unique<MultiFab>(amrex::convert(cba,Ex_nodal_flag),dm,ncomps,ngE,tag("Efield_cp[x]")); - Efield_cp[lev][1] = std::make_unique<MultiFab>(amrex::convert(cba,Ey_nodal_flag),dm,ncomps,ngE,tag("Efield_cp[y]")); - Efield_cp[lev][2] = std::make_unique<MultiFab>(amrex::convert(cba,Ez_nodal_flag),dm,ncomps,ngE,tag("Efield_cp[z]")); + Efield_cp[lev][0] = std::make_unique<MultiFab>(amrex::convert(cba,Ex_nodal_flag),dm,ncomps,ngEB,tag("Efield_cp[x]")); + Efield_cp[lev][1] = std::make_unique<MultiFab>(amrex::convert(cba,Ey_nodal_flag),dm,ncomps,ngEB,tag("Efield_cp[y]")); + Efield_cp[lev][2] = std::make_unique<MultiFab>(amrex::convert(cba,Ez_nodal_flag),dm,ncomps,ngEB,tag("Efield_cp[z]")); // Create the MultiFabs for B_avg - Bfield_avg_cp[lev][0] = std::make_unique<MultiFab>(amrex::convert(cba,Bx_nodal_flag),dm,ncomps,ngE,tag("Bfield_avg_cp[x]")); - Bfield_avg_cp[lev][1] = std::make_unique<MultiFab>(amrex::convert(cba,By_nodal_flag),dm,ncomps,ngE,tag("Bfield_avg_cp[y]")); - Bfield_avg_cp[lev][2] = std::make_unique<MultiFab>(amrex::convert(cba,Bz_nodal_flag),dm,ncomps,ngE,tag("Bfield_avg_cp[z]")); + Bfield_avg_cp[lev][0] = std::make_unique<MultiFab>(amrex::convert(cba,Bx_nodal_flag),dm,ncomps,ngEB,tag("Bfield_avg_cp[x]")); + Bfield_avg_cp[lev][1] = std::make_unique<MultiFab>(amrex::convert(cba,By_nodal_flag),dm,ncomps,ngEB,tag("Bfield_avg_cp[y]")); + Bfield_avg_cp[lev][2] = std::make_unique<MultiFab>(amrex::convert(cba,Bz_nodal_flag),dm,ncomps,ngEB,tag("Bfield_avg_cp[z]")); // Create the MultiFabs for E_avg - Efield_avg_cp[lev][0] = std::make_unique<MultiFab>(amrex::convert(cba,Ex_nodal_flag),dm,ncomps,ngE,tag("Efield_avg_cp[x]")); - Efield_avg_cp[lev][1] = std::make_unique<MultiFab>(amrex::convert(cba,Ey_nodal_flag),dm,ncomps,ngE,tag("Efield_avg_cp[y]")); - Efield_avg_cp[lev][2] = std::make_unique<MultiFab>(amrex::convert(cba,Ez_nodal_flag),dm,ncomps,ngE,tag("Efield_avg_cp[z]")); + Efield_avg_cp[lev][0] = std::make_unique<MultiFab>(amrex::convert(cba,Ex_nodal_flag),dm,ncomps,ngEB,tag("Efield_avg_cp[x]")); + Efield_avg_cp[lev][1] = std::make_unique<MultiFab>(amrex::convert(cba,Ey_nodal_flag),dm,ncomps,ngEB,tag("Efield_avg_cp[y]")); + Efield_avg_cp[lev][2] = std::make_unique<MultiFab>(amrex::convert(cba,Ez_nodal_flag),dm,ncomps,ngEB,tag("Efield_avg_cp[z]")); // Create the MultiFabs for the current current_cp[lev][0] = std::make_unique<MultiFab>(amrex::convert(cba,jx_nodal_flag),dm,ncomps,ngJ,tag("current_cp[x]")); @@ -1948,7 +1948,7 @@ WarpX::AllocLevelMFs (int lev, const BoxArray& ba, const DistributionMapping& dm c_realspace_ba.enclosedCells(); // Make it cell-centered // Define spectral solver #ifdef WARPX_DIM_RZ - c_realspace_ba.grow(1, ngE[1]); // add guard cells only in z + c_realspace_ba.grow(1, ngEB[1]); // add guard cells only in z if (field_boundary_hi[0] == FieldBoundaryType::PML && !do_pml_in_domain) { // Extend region that is solved for to include the guard cells // which is where the PML boundary is applied. @@ -1960,7 +1960,7 @@ WarpX::AllocLevelMFs (int lev, const BoxArray& ba, const DistributionMapping& dm dm, cdx); # else - c_realspace_ba.grow(ngE); + c_realspace_ba.grow(ngEB); bool const pml_flag_false = false; AllocLevelSpectralSolver(spectral_solver_cp, lev, @@ -1989,22 +1989,22 @@ WarpX::AllocLevelMFs (int lev, const BoxArray& ba, const DistributionMapping& dm if (n_field_gather_buffer > 0 || mypc->nSpeciesGatherFromMainGrid() > 0) { if (aux_is_nodal) { BoxArray const& cnba = amrex::convert(cba,IntVect::TheNodeVector()); - Bfield_cax[lev][0] = std::make_unique<MultiFab>(cnba,dm,ncomps,ngE,tag("Bfield_cax[x]")); - Bfield_cax[lev][1] = std::make_unique<MultiFab>(cnba,dm,ncomps,ngE,tag("Bfield_cax[y]")); - Bfield_cax[lev][2] = std::make_unique<MultiFab>(cnba,dm,ncomps,ngE,tag("Bfield_cax[z]")); - Efield_cax[lev][0] = std::make_unique<MultiFab>(cnba,dm,ncomps,ngE,tag("Efield_cax[x]")); - Efield_cax[lev][1] = std::make_unique<MultiFab>(cnba,dm,ncomps,ngE,tag("Efield_cax[y]")); - Efield_cax[lev][2] = std::make_unique<MultiFab>(cnba,dm,ncomps,ngE,tag("Efield_cax[z]")); + Bfield_cax[lev][0] = std::make_unique<MultiFab>(cnba,dm,ncomps,ngEB,tag("Bfield_cax[x]")); + Bfield_cax[lev][1] = std::make_unique<MultiFab>(cnba,dm,ncomps,ngEB,tag("Bfield_cax[y]")); + Bfield_cax[lev][2] = std::make_unique<MultiFab>(cnba,dm,ncomps,ngEB,tag("Bfield_cax[z]")); + Efield_cax[lev][0] = std::make_unique<MultiFab>(cnba,dm,ncomps,ngEB,tag("Efield_cax[x]")); + Efield_cax[lev][1] = std::make_unique<MultiFab>(cnba,dm,ncomps,ngEB,tag("Efield_cax[y]")); + Efield_cax[lev][2] = std::make_unique<MultiFab>(cnba,dm,ncomps,ngEB,tag("Efield_cax[z]")); } else { // Create the MultiFabs for B - Bfield_cax[lev][0] = std::make_unique<MultiFab>(amrex::convert(cba,Bx_nodal_flag),dm,ncomps,ngE,tag("Bfield_cax[x]")); - Bfield_cax[lev][1] = std::make_unique<MultiFab>(amrex::convert(cba,By_nodal_flag),dm,ncomps,ngE,tag("Bfield_cax[y]")); - Bfield_cax[lev][2] = std::make_unique<MultiFab>(amrex::convert(cba,Bz_nodal_flag),dm,ncomps,ngE,tag("Bfield_cax[z]")); + Bfield_cax[lev][0] = std::make_unique<MultiFab>(amrex::convert(cba,Bx_nodal_flag),dm,ncomps,ngEB,tag("Bfield_cax[x]")); + Bfield_cax[lev][1] = std::make_unique<MultiFab>(amrex::convert(cba,By_nodal_flag),dm,ncomps,ngEB,tag("Bfield_cax[y]")); + Bfield_cax[lev][2] = std::make_unique<MultiFab>(amrex::convert(cba,Bz_nodal_flag),dm,ncomps,ngEB,tag("Bfield_cax[z]")); // Create the MultiFabs for E - Efield_cax[lev][0] = std::make_unique<MultiFab>(amrex::convert(cba,Ex_nodal_flag),dm,ncomps,ngE,tag("Efield_cax[x]")); - Efield_cax[lev][1] = std::make_unique<MultiFab>(amrex::convert(cba,Ey_nodal_flag),dm,ncomps,ngE,tag("Efield_cax[y]")); - Efield_cax[lev][2] = std::make_unique<MultiFab>(amrex::convert(cba,Ez_nodal_flag),dm,ncomps,ngE,tag("Efield_cax[z]")); + Efield_cax[lev][0] = std::make_unique<MultiFab>(amrex::convert(cba,Ex_nodal_flag),dm,ncomps,ngEB,tag("Efield_cax[x]")); + Efield_cax[lev][1] = std::make_unique<MultiFab>(amrex::convert(cba,Ey_nodal_flag),dm,ncomps,ngEB,tag("Efield_cax[y]")); + Efield_cax[lev][2] = std::make_unique<MultiFab>(amrex::convert(cba,Ez_nodal_flag),dm,ncomps,ngEB,tag("Efield_cax[z]")); } gather_buffer_masks[lev] = std::make_unique<iMultiFab>(ba, dm, ncomps, 1 ); |