aboutsummaryrefslogtreecommitdiff
diff options
context:
space:
mode:
-rw-r--r--Source/BoundaryConditions/PML.cpp4
-rw-r--r--Source/Diagnostics/WarpXOpenPMD.H1
-rw-r--r--Source/Evolve/WarpXEvolveEM.cpp4
-rw-r--r--Source/FieldSolver/SpectralSolver/SpectralFieldData.cpp8
-rw-r--r--Source/FieldSolver/WarpXPushFieldsEM.cpp14
-rw-r--r--Source/Filter/Filter.cpp6
-rw-r--r--Source/Laser/LaserProfiles.H3
-rw-r--r--Source/Particles/ParticleCreation/TransformParticle.H2
-rw-r--r--Source/Particles/PhysicalParticleContainer.H32
-rw-r--r--Source/Particles/PhysicalParticleContainer.cpp20
-rw-r--r--Source/Particles/WarpXParticleContainer.cpp8
-rw-r--r--Source/QED/QedTableParserHelperFunctions.H4
-rw-r--r--Source/WarpX.cpp24
13 files changed, 81 insertions, 49 deletions
diff --git a/Source/BoundaryConditions/PML.cpp b/Source/BoundaryConditions/PML.cpp
index f6d5e05ae..51439430d 100644
--- a/Source/BoundaryConditions/PML.cpp
+++ b/Source/BoundaryConditions/PML.cpp
@@ -752,14 +752,14 @@ PML::CopyJtoPMLs (const std::array<amrex::MultiFab*,3>& j_fp,
void
-PML::ExchangeF (MultiFab* F_fp, MultiFab* F_cp, int do_pml_in_domain)
+PML::ExchangeF (amrex::MultiFab* F_fp, amrex::MultiFab* F_cp, int do_pml_in_domain)
{
ExchangeF(PatchType::fine, F_fp, do_pml_in_domain);
ExchangeF(PatchType::coarse, F_cp, do_pml_in_domain);
}
void
-PML::ExchangeF (PatchType patch_type, MultiFab* Fp, int do_pml_in_domain)
+PML::ExchangeF (PatchType patch_type, amrex::MultiFab* Fp, int do_pml_in_domain)
{
if (patch_type == PatchType::fine && pml_F_fp && Fp) {
Exchange(*pml_F_fp, *Fp, *m_geom, do_pml_in_domain);
diff --git a/Source/Diagnostics/WarpXOpenPMD.H b/Source/Diagnostics/WarpXOpenPMD.H
index b90df6945..c79a12066 100644
--- a/Source/Diagnostics/WarpXOpenPMD.H
+++ b/Source/Diagnostics/WarpXOpenPMD.H
@@ -119,6 +119,7 @@ private:
/** This function saves the plot file
*
* @param[in] pc WarpX particle container
+ * @param[in] name species name
* @param[in] iteration timestep
* @param[in] write_real_comp The real attribute ids, from WarpX
* @param[in] real_comp_names The real attribute names, from WarpX
diff --git a/Source/Evolve/WarpXEvolveEM.cpp b/Source/Evolve/WarpXEvolveEM.cpp
index fe0fb9157..470d12610 100644
--- a/Source/Evolve/WarpXEvolveEM.cpp
+++ b/Source/Evolve/WarpXEvolveEM.cpp
@@ -475,7 +475,7 @@ WarpX::OneStep_sub1 (Real curtime)
}
void
-WarpX::PushParticlesandDepose (Real cur_time)
+WarpX::PushParticlesandDepose (amrex::Real cur_time)
{
// Evolve particles to p^{n+1/2} and x^{n+1}
// Depose current, j^{n+1/2}
@@ -485,7 +485,7 @@ WarpX::PushParticlesandDepose (Real cur_time)
}
void
-WarpX::PushParticlesandDepose (int lev, Real cur_time, DtType a_dt_type)
+WarpX::PushParticlesandDepose (int lev, amrex::Real cur_time, DtType a_dt_type)
{
mypc->Evolve(lev,
*Efield_aux[lev][0],*Efield_aux[lev][1],*Efield_aux[lev][2],
diff --git a/Source/FieldSolver/SpectralSolver/SpectralFieldData.cpp b/Source/FieldSolver/SpectralSolver/SpectralFieldData.cpp
index 8f0853484..edd4df34d 100644
--- a/Source/FieldSolver/SpectralSolver/SpectralFieldData.cpp
+++ b/Source/FieldSolver/SpectralSolver/SpectralFieldData.cpp
@@ -3,10 +3,10 @@
using namespace amrex;
/* \brief Initialize fields in spectral space, and FFT plans */
-SpectralFieldData::SpectralFieldData( const BoxArray& realspace_ba,
- const SpectralKSpace& k_space,
- const DistributionMapping& dm,
- const int n_field_required )
+SpectralFieldData::SpectralFieldData( const amrex::BoxArray& realspace_ba,
+ const SpectralKSpace& k_space,
+ const amrex::DistributionMapping& dm,
+ const int n_field_required )
{
const BoxArray& spectralspace_ba = k_space.spectralspace_ba;
diff --git a/Source/FieldSolver/WarpXPushFieldsEM.cpp b/Source/FieldSolver/WarpXPushFieldsEM.cpp
index 9807665c6..4848b051e 100644
--- a/Source/FieldSolver/WarpXPushFieldsEM.cpp
+++ b/Source/FieldSolver/WarpXPushFieldsEM.cpp
@@ -90,7 +90,7 @@ WarpX::PushPSATD_localFFT (int lev, amrex::Real /* dt */)
#endif
void
-WarpX::EvolveB (Real a_dt)
+WarpX::EvolveB (amrex::Real a_dt)
{
for (int lev = 0; lev <= finest_level; ++lev) {
EvolveB(lev, a_dt);
@@ -98,7 +98,7 @@ WarpX::EvolveB (Real a_dt)
}
void
-WarpX::EvolveB (int lev, Real a_dt)
+WarpX::EvolveB (int lev, amrex::Real a_dt)
{
BL_PROFILE("WarpX::EvolveB()");
EvolveB(lev, PatchType::fine, a_dt);
@@ -303,7 +303,7 @@ WarpX::EvolveB (int lev, PatchType patch_type, amrex::Real a_dt)
}
void
-WarpX::EvolveE (Real a_dt)
+WarpX::EvolveE (amrex::Real a_dt)
{
for (int lev = 0; lev <= finest_level; ++lev)
{
@@ -312,7 +312,7 @@ WarpX::EvolveE (Real a_dt)
}
void
-WarpX::EvolveE (int lev, Real a_dt)
+WarpX::EvolveE (int lev, amrex::Real a_dt)
{
BL_PROFILE("WarpX::EvolveE()");
EvolveE(lev, PatchType::fine, a_dt);
@@ -611,7 +611,7 @@ WarpX::EvolveE (int lev, PatchType patch_type, amrex::Real a_dt)
}
void
-WarpX::EvolveF (Real a_dt, DtType a_dt_type)
+WarpX::EvolveF (amrex::Real a_dt, DtType a_dt_type)
{
if (!do_dive_cleaning) return;
@@ -622,7 +622,7 @@ WarpX::EvolveF (Real a_dt, DtType a_dt_type)
}
void
-WarpX::EvolveF (int lev, Real a_dt, DtType a_dt_type)
+WarpX::EvolveF (int lev, amrex::Real a_dt, DtType a_dt_type)
{
if (!do_dive_cleaning) return;
@@ -631,7 +631,7 @@ WarpX::EvolveF (int lev, Real a_dt, DtType a_dt_type)
}
void
-WarpX::EvolveF (int lev, PatchType patch_type, Real a_dt, DtType a_dt_type)
+WarpX::EvolveF (int lev, PatchType patch_type, amrex::Real a_dt, DtType a_dt_type)
{
if (!do_dive_cleaning) return;
diff --git a/Source/Filter/Filter.cpp b/Source/Filter/Filter.cpp
index 5d3c14c14..93729a0ae 100644
--- a/Source/Filter/Filter.cpp
+++ b/Source/Filter/Filter.cpp
@@ -144,7 +144,7 @@ void Filter::DoFilter (const Box& tbx,
* \param ncomp Number of components on which the filter is applied.
*/
void
-Filter::ApplyStencil (MultiFab& dstmf, const MultiFab& srcmf, int scomp, int dcomp, int ncomp)
+Filter::ApplyStencil (amrex::MultiFab& dstmf, const amrex::MultiFab& srcmf, int scomp, int dcomp, int ncomp)
{
BL_PROFILE("BilinearFilter::ApplyStencil()");
ncomp = std::min(ncomp, srcmf.nComp());
@@ -179,8 +179,8 @@ Filter::ApplyStencil (MultiFab& dstmf, const MultiFab& srcmf, int scomp, int dco
* \param ncomp Number of components on which the filter is applied.
*/
void
-Filter::ApplyStencil (FArrayBox& dstfab, const FArrayBox& srcfab,
- const Box& tbx, int scomp, int dcomp, int ncomp)
+Filter::ApplyStencil (amrex::FArrayBox& dstfab, const amrex::FArrayBox& srcfab,
+ const amrex::Box& tbx, int scomp, int dcomp, int ncomp)
{
BL_PROFILE("BilinearFilter::ApplyStencil(FArrayBox)");
ncomp = std::min(ncomp, srcfab.nComp());
diff --git a/Source/Laser/LaserProfiles.H b/Source/Laser/LaserProfiles.H
index 528309492..e0ec0dc28 100644
--- a/Source/Laser/LaserProfiles.H
+++ b/Source/Laser/LaserProfiles.H
@@ -45,7 +45,7 @@ public:
/** Initialize Laser Profile
*
* Reads the section of the inputfile relative to the laser beam
- * (e.g. <laser_name>.profile_t_peak, <laser_name>.profile_duration...)
+ * (e.g. laser_name.profile_t_peak, laser_name.profile_duration...)
* and the "my_constants" section. It also receives some common
* laser profile parameters. It uses these data to initialize the
* member variables of the laser profile class.
@@ -64,6 +64,7 @@ public:
*
* Xp, Yp and amplitude must be arrays with the same length
*
+ * @param[in] np number of antenna particles
* @param[in] Xp X coordinate of the particles of the antenna
* @param[in] Yp Y coordinate of the particles of the antenna
* @param[in] t time (seconds)
diff --git a/Source/Particles/ParticleCreation/TransformParticle.H b/Source/Particles/ParticleCreation/TransformParticle.H
index 1b71df723..c0158db78 100644
--- a/Source/Particles/ParticleCreation/TransformParticle.H
+++ b/Source/Particles/ParticleCreation/TransformParticle.H
@@ -21,7 +21,7 @@ void transformSourceParticle(
/**
* \brief small modifications on product particle
* \param i index of particle
- * \param particle particle struct
+ * \param v_particle pointer to vector of particles
*/
template < ElementaryProcessType ProcessT >
AMREX_GPU_HOST_DEVICE AMREX_FORCE_INLINE
diff --git a/Source/Particles/PhysicalParticleContainer.H b/Source/Particles/PhysicalParticleContainer.H
index e70b470b8..1cd4ba621 100644
--- a/Source/Particles/PhysicalParticleContainer.H
+++ b/Source/Particles/PhysicalParticleContainer.H
@@ -163,13 +163,39 @@ public:
* \brief Apply NCI Godfrey filter to all components of E and B before gather
* \param lev MR level
* \param box box onto which the filter is applied
- * \param exeli safeguard to avoid destructing arrays between ParIter iterations on GPU
+ * \param exeli safeguard Elixir object (to avoid de-allocating too early
+ --between ParIter iterations-- on GPU) for field Ex
+ * \param eyeli safeguard Elixir object (to avoid de-allocating too early
+ --between ParIter iterations-- on GPU) for field Ey
+ * \param ezeli safeguard Elixir object (to avoid de-allocating too early
+ --between ParIter iterations-- on GPU) for field Ez
+ * \param bxeli safeguard Elixir object (to avoid de-allocating too early
+ --between ParIter iterations-- on GPU) for field Bx
+ * \param byeli safeguard Elixir object (to avoid de-allocating too early
+ --between ParIter iterations-- on GPU) for field By
+ * \param bzeli safeguard Elixir object (to avoid de-allocating too early
+ --between ParIter iterations-- on GPU) for field Bz
* \param filtered_Ex Array containing filtered value
+ * \param filtered_Ey Array containing filtered value
+ * \param filtered_Ez Array containing filtered value
+ * \param filtered_Bx Array containing filtered value
+ * \param filtered_By Array containing filtered value
+ * \param filtered_Bz Array containing filtered value
* \param Ex Field array before filtering (not modified)
- * \param ex_ptr pointer to the array used for field gather.
+ * \param Ey Field array before filtering (not modified)
+ * \param Ez Field array before filtering (not modified)
+ * \param Bx Field array before filtering (not modified)
+ * \param By Field array before filtering (not modified)
+ * \param Bz Field array before filtering (not modified)
+ * \param exfab pointer to the Ex field (modified)
+ * \param eyfab pointer to the Ey field (modified)
+ * \param ezfab pointer to the Ez field (modified)
+ * \param bxfab pointer to the Bx field (modified)
+ * \param byfab pointer to the By field (modified)
+ * \param bzfab pointer to the Bz field (modified)
*
* The NCI Godfrey filter is applied on Ex, the result is stored in filtered_Ex
- * and the pointer is modified (before this function is called, it points to Ex
+ * and the pointer exfab is modified (before this function is called, it points to Ex
* and after this function is called, it points to Ex_filtered)
*/
void applyNCIFilter (
diff --git a/Source/Particles/PhysicalParticleContainer.cpp b/Source/Particles/PhysicalParticleContainer.cpp
index c77ddf83b..d5c08074a 100644
--- a/Source/Particles/PhysicalParticleContainer.cpp
+++ b/Source/Particles/PhysicalParticleContainer.cpp
@@ -963,8 +963,12 @@ PhysicalParticleContainer::EvolveES (const Vector<std::array<std::unique_ptr<Mul
void
PhysicalParticleContainer::FieldGather (int lev,
- const MultiFab& Ex, const MultiFab& Ey, const MultiFab& Ez,
- const MultiFab& Bx, const MultiFab& By, const MultiFab& Bz)
+ const amrex::MultiFab& Ex,
+ const amrex::MultiFab& Ey,
+ const amrex::MultiFab& Ez,
+ const amrex::MultiFab& Bx,
+ const amrex::MultiFab& By,
+ const amrex::MultiFab& Bz)
{
const std::array<Real,3>& dx = WarpX::CellSize(lev);
@@ -2148,12 +2152,12 @@ PhysicalParticleContainer::FieldGather (WarpXParIter& pti,
RealVector& Bxp,
RealVector& Byp,
RealVector& Bzp,
- FArrayBox const * exfab,
- FArrayBox const * eyfab,
- FArrayBox const * ezfab,
- FArrayBox const * bxfab,
- FArrayBox const * byfab,
- FArrayBox const * bzfab,
+ amrex::FArrayBox const * exfab,
+ amrex::FArrayBox const * eyfab,
+ amrex::FArrayBox const * ezfab,
+ amrex::FArrayBox const * bxfab,
+ amrex::FArrayBox const * byfab,
+ amrex::FArrayBox const * bzfab,
const int ngE, const int e_is_nodal,
const long offset,
const long np_to_gather,
diff --git a/Source/Particles/WarpXParticleContainer.cpp b/Source/Particles/WarpXParticleContainer.cpp
index 8926301b2..e6c6d31bd 100644
--- a/Source/Particles/WarpXParticleContainer.cpp
+++ b/Source/Particles/WarpXParticleContainer.cpp
@@ -420,7 +420,7 @@ WarpXParticleContainer::DepositCurrent(WarpXParIter& pti,
void
WarpXParticleContainer::DepositCharge (WarpXParIter& pti, RealVector& wp,
const int * const ion_lev,
- MultiFab* rho, int icomp,
+ amrex::MultiFab* rho, int icomp,
const long offset, const long np_to_depose,
int thread_num, int lev, int depos_lev)
{
@@ -507,7 +507,7 @@ WarpXParticleContainer::DepositCharge (WarpXParIter& pti, RealVector& wp,
}
void
-WarpXParticleContainer::DepositCharge (Vector<std::unique_ptr<MultiFab> >& rho,
+WarpXParticleContainer::DepositCharge (amrex::Vector<std::unique_ptr<amrex::MultiFab> >& rho,
bool local, bool reset,
bool do_rz_volume_scaling)
{
@@ -760,7 +760,7 @@ WarpXParticleContainer::PushXES (Real dt)
}
void
-WarpXParticleContainer::PushX (Real dt)
+WarpXParticleContainer::PushX (amrex::Real dt)
{
const int nLevels = finestLevel();
for (int lev = 0; lev <= nLevels; ++lev) {
@@ -769,7 +769,7 @@ WarpXParticleContainer::PushX (Real dt)
}
void
-WarpXParticleContainer::PushX (int lev, Real dt)
+WarpXParticleContainer::PushX (int lev, amrex::Real dt)
{
BL_PROFILE("WPC::PushX()");
diff --git a/Source/QED/QedTableParserHelperFunctions.H b/Source/QED/QedTableParserHelperFunctions.H
index 9f9f37017..528613727 100644
--- a/Source/QED/QedTableParserHelperFunctions.H
+++ b/Source/QED/QedTableParserHelperFunctions.H
@@ -15,7 +15,7 @@ namespace QedUtils{
* This function safely extracts an amrex::Vector<T> from raw binary data.
* T must be a simple datatype (e.g. an int, a float, a double...).
*
- * @param[in] p_char a pointer to the binary stream
+ * @param[in] p_data a pointer to the binary stream
* @param[in] how_many how many T should be read from stream
* @param[in] p_last a pointer to the last element of the char* array
* @return {a tuple containing
@@ -43,7 +43,7 @@ namespace QedUtils{
* This function safely extracts a T from raw binary data.
* T must be a simple datatype (e.g. an int, a float, a double...).
*
- * @param[in] p_char a pointer to the binary stream
+ * @param[in] p_data a pointer to the binary stream
* @param[in] p_last a pointer to the last element of the char* array
* @return {a tuple containing
* 1) flag (which is false if p_last is exceeded)
diff --git a/Source/WarpX.cpp b/Source/WarpX.cpp
index d94e35f61..53728b54f 100644
--- a/Source/WarpX.cpp
+++ b/Source/WarpX.cpp
@@ -1116,9 +1116,9 @@ WarpX::Evolve (int numsteps) {
}
void
-WarpX::ComputeDivB (MultiFab& divB, int dcomp,
- const std::array<const MultiFab*, 3>& B,
- const std::array<Real,3>& dx)
+WarpX::ComputeDivB (amrex::MultiFab& divB, int dcomp,
+ const std::array<const amrex::MultiFab*, 3>& B,
+ const std::array<amrex::Real,3>& dx)
{
Real dxinv = 1./dx[0], dyinv = 1./dx[1], dzinv = 1./dx[2];
@@ -1150,9 +1150,9 @@ WarpX::ComputeDivB (MultiFab& divB, int dcomp,
}
void
-WarpX::ComputeDivB (MultiFab& divB, int dcomp,
- const std::array<const MultiFab*, 3>& B,
- const std::array<Real,3>& dx, int ngrow)
+WarpX::ComputeDivB (amrex::MultiFab& divB, int dcomp,
+ const std::array<const amrex::MultiFab*, 3>& B,
+ const std::array<amrex::Real,3>& dx, int ngrow)
{
Real dxinv = 1./dx[0], dyinv = 1./dx[1], dzinv = 1./dx[2];
@@ -1184,9 +1184,9 @@ WarpX::ComputeDivB (MultiFab& divB, int dcomp,
}
void
-WarpX::ComputeDivE (MultiFab& divE, int dcomp,
- const std::array<const MultiFab*, 3>& E,
- const std::array<Real,3>& dx)
+WarpX::ComputeDivE (amrex::MultiFab& divE, int dcomp,
+ const std::array<const amrex::MultiFab*, 3>& E,
+ const std::array<amrex::Real,3>& dx)
{
Real dxinv = 1./dx[0], dyinv = 1./dx[1], dzinv = 1./dx[2];
@@ -1218,9 +1218,9 @@ WarpX::ComputeDivE (MultiFab& divE, int dcomp,
}
void
-WarpX::ComputeDivE (MultiFab& divE, int dcomp,
- const std::array<const MultiFab*, 3>& E,
- const std::array<Real,3>& dx, int ngrow)
+WarpX::ComputeDivE (amrex::MultiFab& divE, int dcomp,
+ const std::array<const amrex::MultiFab*, 3>& E,
+ const std::array<amrex::Real,3>& dx, int ngrow)
{
Real dxinv = 1./dx[0], dyinv = 1./dx[1], dzinv = 1./dx[2];