aboutsummaryrefslogtreecommitdiff
path: root/Source
diff options
context:
space:
mode:
Diffstat (limited to 'Source')
-rw-r--r--Source/Diagnostics/BTDiagnostics.H4
-rw-r--r--Source/Diagnostics/BackTransformedDiagnostic.H4
-rw-r--r--Source/Diagnostics/ComputeDiagFunctors/BackTransformFunctor.H2
-rw-r--r--Source/Diagnostics/ComputeDiagFunctors/ComputeDiagFunctor.H4
-rw-r--r--Source/Diagnostics/Diagnostics.H4
-rw-r--r--Source/Diagnostics/FlushFormats/FlushFormat.H2
-rw-r--r--Source/Diagnostics/FlushFormats/FlushFormatAscent.H2
-rw-r--r--Source/Diagnostics/FlushFormats/FlushFormatPlotfile.H2
-rw-r--r--Source/Diagnostics/ParticleDiag/ParticleDiag.H4
-rw-r--r--Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CartesianCKCAlgorithm.H12
-rw-r--r--Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CartesianNodalAlgorithm.H12
-rw-r--r--Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CartesianYeeAlgorithm.H12
-rw-r--r--Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceSolver.cpp2
-rw-r--r--Source/Laser/LaserProfiles.H2
-rw-r--r--Source/Particles/Filter/FilterFunctors.H6
-rw-r--r--Source/Particles/PhotonParticleContainer.H4
-rw-r--r--Source/Particles/ShapeFactors.H16
-rw-r--r--Source/Particles/Sorting/SortingUtils.H12
-rw-r--r--Source/Particles/WarpXParticleContainer.H10
-rw-r--r--Source/WarpX.H20
20 files changed, 68 insertions, 68 deletions
diff --git a/Source/Diagnostics/BTDiagnostics.H b/Source/Diagnostics/BTDiagnostics.H
index 3033c86f0..63e8289dc 100644
--- a/Source/Diagnostics/BTDiagnostics.H
+++ b/Source/Diagnostics/BTDiagnostics.H
@@ -16,7 +16,7 @@ private:
/** Flush m_mf_output and particles to file. */
// Currently this is an empty function. When OpenPMD/Plotfile is supported
// this function can be moved to the base class Diagnostics.
- void Flush (int i_buffer) override {} ;
+ void Flush (int i_buffer) override {}
/** whether to write output files at this time step
* The data is flushed when the buffer is full and/or
* when the simulation ends or when forced.
@@ -35,7 +35,7 @@ private:
/** This function initialized and allocates particle buffers for all the snapshots.
* The particle containers required for this must be added to populate this function.
*/
- void InitializeParticleBuffer () override {};
+ void InitializeParticleBuffer () override {}
/** Compute the cell-centered data for all user-requested fields and store in
* the multi-level cell-centered multifab, m_mf_cc. This MultiFab extends
* over the entire domain and is coarsened using the user-defined crse_ratio
diff --git a/Source/Diagnostics/BackTransformedDiagnostic.H b/Source/Diagnostics/BackTransformedDiagnostic.H
index d21a12f44..8776dbb1c 100644
--- a/Source/Diagnostics/BackTransformedDiagnostic.H
+++ b/Source/Diagnostics/BackTransformedDiagnostic.H
@@ -88,7 +88,7 @@ class LabFrameDiag {
/// extent of the z_lab multifab intersects with the user-defined sub-domain
/// for the reduced diagnostic (i.e., a 1D, 2D, or 3D region of the domain).
virtual void AddDataToBuffer(amrex::MultiFab& tmp_slice_ptr, int i_lab,
- amrex::Gpu::ManagedDeviceVector<int> map_actual_fields_to_dump){};
+ amrex::Gpu::ManagedDeviceVector<int> map_actual_fields_to_dump){}
/// Back-transformed lab-frame particles is copied from
/// tmp_particle_buffer to particles_buffer.
@@ -98,7 +98,7 @@ class LabFrameDiag {
/// sub-domain +/- 1 cell size width for the reduced slice diagnostic.
virtual void AddPartDataToParticleBuffer(
amrex::Vector<WarpXParticleContainer::DiagnosticParticleData> tmp_particle_buffer,
- int nSpeciesBoostedFrame) {};
+ int nSpeciesBoostedFrame) {}
};
/** \brief
diff --git a/Source/Diagnostics/ComputeDiagFunctors/BackTransformFunctor.H b/Source/Diagnostics/ComputeDiagFunctors/BackTransformFunctor.H
index b8702e715..d6fb4d80a 100644
--- a/Source/Diagnostics/ComputeDiagFunctors/BackTransformFunctor.H
+++ b/Source/Diagnostics/ComputeDiagFunctors/BackTransformFunctor.H
@@ -35,7 +35,7 @@ public:
BackTransformFunctor( const amrex::MultiFab * const mf_src, const int lev,
const int ncomp, const amrex::IntVect crse_ratio= amrex::IntVect(1));
- void operator()(amrex::MultiFab& mf_dst, int dcomp) const override {};
+ void operator()(amrex::MultiFab& mf_dst, int dcomp) const override {}
private:
/** pointer to source multifab (cell-centered multi-component multifab) */
amrex::MultiFab const * const m_mf_src = nullptr;
diff --git a/Source/Diagnostics/ComputeDiagFunctors/ComputeDiagFunctor.H b/Source/Diagnostics/ComputeDiagFunctors/ComputeDiagFunctor.H
index 2cacf1e54..718c39f86 100644
--- a/Source/Diagnostics/ComputeDiagFunctors/ComputeDiagFunctor.H
+++ b/Source/Diagnostics/ComputeDiagFunctors/ComputeDiagFunctor.H
@@ -12,7 +12,7 @@ ComputeDiagFunctor
{
public:
ComputeDiagFunctor( int ncomp, amrex::IntVect crse_ratio) :
- m_ncomp(ncomp), m_crse_ratio(crse_ratio) {};
+ m_ncomp(ncomp), m_crse_ratio(crse_ratio) {}
//** Virtual Destructor to handle clean destruction of derived classes */
virtual ~ComputeDiagFunctor() = default;
/** Compute a field and store the result in mf_dst
@@ -25,7 +25,7 @@ public:
virtual void operator() (amrex::MultiFab& mf_dst, int dcomp) const = 0;
/** Number of component from the input multifab to write to the output
* multifab */
- int nComp () const { return m_ncomp; };
+ int nComp () const { return m_ncomp; }
private:
/** Number of components of mf_dst that this functor updates. */
int m_ncomp;
diff --git a/Source/Diagnostics/Diagnostics.H b/Source/Diagnostics/Diagnostics.H
index 3997c3b4b..4f7e57772 100644
--- a/Source/Diagnostics/Diagnostics.H
+++ b/Source/Diagnostics/Diagnostics.H
@@ -85,13 +85,13 @@ protected:
/** Initialize member variables and arrays specific to the diagnostics in the
* derived classes.(FullDiagnostics, BTDiagnostics)
*/
- virtual void DerivedInitData () {};
+ virtual void DerivedInitData () {}
/** This function initialized particle buffers (not implemented in diagnostics, yet) */
virtual void InitializeParticleBuffer () = 0;
/** Prepare data (either fill-boundary or cell-centered data for
back-transform diagnostics) to be processed for diagnostics.
*/
- virtual void PrepareFieldDataForOutput () {};
+ virtual void PrepareFieldDataForOutput () {}
/** Name of diagnostics: runtime parameter given in the input file. */
std::string m_diag_name;
/** Prefix for output directories */
diff --git a/Source/Diagnostics/FlushFormats/FlushFormat.H b/Source/Diagnostics/FlushFormats/FlushFormat.H
index d83355dd3..826c56d03 100644
--- a/Source/Diagnostics/FlushFormats/FlushFormat.H
+++ b/Source/Diagnostics/FlushFormats/FlushFormat.H
@@ -19,7 +19,7 @@ public:
bool plot_raw_fields_guards,
bool plot_raw_rho, bool plot_raw_F) const = 0;
- virtual ~FlushFormat() {};
+ virtual ~FlushFormat() {}
};
#endif // WARPX_FLUSHFORMAT_H_
diff --git a/Source/Diagnostics/FlushFormats/FlushFormatAscent.H b/Source/Diagnostics/FlushFormats/FlushFormatAscent.H
index 9aa670405..357b9357a 100644
--- a/Source/Diagnostics/FlushFormats/FlushFormatAscent.H
+++ b/Source/Diagnostics/FlushFormats/FlushFormatAscent.H
@@ -36,7 +36,7 @@ public:
void WriteParticles(const amrex::Vector<ParticleDiag>& particle_diags, conduit::Node& a_bp_mesh) const;
#endif
- ~FlushFormatAscent() {};
+ ~FlushFormatAscent() {}
};
#endif // WARPX_FLUSHFORMATASCENT_H_
diff --git a/Source/Diagnostics/FlushFormats/FlushFormatPlotfile.H b/Source/Diagnostics/FlushFormats/FlushFormatPlotfile.H
index f3eb671d9..477a00a0f 100644
--- a/Source/Diagnostics/FlushFormats/FlushFormatPlotfile.H
+++ b/Source/Diagnostics/FlushFormats/FlushFormatPlotfile.H
@@ -40,7 +40,7 @@ public:
void WriteParticles(const std::string& filename,
const amrex::Vector<ParticleDiag>& particle_diags) const;
- ~FlushFormatPlotfile() {};
+ ~FlushFormatPlotfile() {}
};
#endif // WARPX_FLUSHFORMATPLOTFILE_H_
diff --git a/Source/Diagnostics/ParticleDiag/ParticleDiag.H b/Source/Diagnostics/ParticleDiag/ParticleDiag.H
index c91991603..fda7a1e3b 100644
--- a/Source/Diagnostics/ParticleDiag/ParticleDiag.H
+++ b/Source/Diagnostics/ParticleDiag/ParticleDiag.H
@@ -9,8 +9,8 @@ class ParticleDiag
{
public:
ParticleDiag(std::string diag_name, std::string name, WarpXParticleContainer* pc);
- WarpXParticleContainer* getParticleContainer() const { return m_pc; };
- std::string getSpeciesName() const { return m_name; };
+ WarpXParticleContainer* getParticleContainer() const { return m_pc; }
+ std::string getSpeciesName() const { return m_name; }
amrex::Vector<int> plot_flags;
bool m_do_random_filter = false;
diff --git a/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CartesianCKCAlgorithm.H b/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CartesianCKCAlgorithm.H
index bb480364a..d5b567bc1 100644
--- a/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CartesianCKCAlgorithm.H
+++ b/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CartesianCKCAlgorithm.H
@@ -138,7 +138,7 @@ struct CartesianCKCAlgorithm {
+ betaxz * (F(i+1,j+1,k ,ncomp) - F(i ,j+1,k ,ncomp)
+ F(i+1,j-1,k ,ncomp) - F(i ,j-1,k ,ncomp));
#endif
- };
+ }
/**
* Perform derivative along x on a nodal grid, from a cell-centered field `F` */
@@ -150,7 +150,7 @@ struct CartesianCKCAlgorithm {
amrex::Real const inv_dx = coefs_x[0];
return inv_dx*( F(i,j,k,ncomp) - F(i-1,j,k,ncomp) );
- };
+ }
/**
* Perform derivative along y on a cell-centered grid, from a nodal field `F` */
@@ -178,7 +178,7 @@ struct CartesianCKCAlgorithm {
#elif (defined WARPX_DIM_XZ)
return 0._rt; // 2D Cartesian: derivative along y is 0
#endif
- };
+ }
/**
* Perform derivative along y on a nodal grid, from a cell-centered field `F` */
@@ -195,7 +195,7 @@ struct CartesianCKCAlgorithm {
#elif (defined WARPX_DIM_XZ)
return 0._rt; // 2D Cartesian: derivative along y is 0
#endif
- };
+ }
/**
* Perform derivative along z on a cell-centered grid, from a nodal field `F` */
@@ -227,7 +227,7 @@ struct CartesianCKCAlgorithm {
+ betazx * (F(i+1,j+1,k ,ncomp) - F(i+1,j ,k ,ncomp)
+ F(i-1,j+1,k ,ncomp) - F(i-1,j ,k ,ncomp));
#endif
- };
+ }
/**
* Perform derivative along z on a nodal grid, from a cell-centered field `F` */
@@ -243,7 +243,7 @@ struct CartesianCKCAlgorithm {
#elif (defined WARPX_DIM_XZ)
return inv_dz*( F(i,j,k,ncomp) - F(i,j-1,k,ncomp) );
#endif
- };
+ }
};
diff --git a/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CartesianNodalAlgorithm.H b/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CartesianNodalAlgorithm.H
index 99510cc52..b0fe4d562 100644
--- a/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CartesianNodalAlgorithm.H
+++ b/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CartesianNodalAlgorithm.H
@@ -67,7 +67,7 @@ struct CartesianNodalAlgorithm {
using namespace amrex;
Real const inv_dx = coefs_x[0];
return 0.5_rt*inv_dx*( F(i+1,j,k,ncomp) - F(i-1,j,k,ncomp) );
- };
+ }
/**
* Perform derivative along x
@@ -81,7 +81,7 @@ struct CartesianNodalAlgorithm {
return UpwardDx( F, coefs_x, n_coefs_x, i, j, k ,ncomp);
// For CartesianNodalAlgorithm, UpwardDx and DownwardDx are equivalent
- };
+ }
/**
* Perform derivative along y
@@ -100,7 +100,7 @@ struct CartesianNodalAlgorithm {
#elif (defined WARPX_DIM_XZ)
return 0._rt; // 2D Cartesian: derivative along y is 0
#endif
- };
+ }
/**
* Perform derivative along y
@@ -114,7 +114,7 @@ struct CartesianNodalAlgorithm {
return UpwardDy( F, coefs_y, n_coefs_y, i, j, k ,ncomp);
// For CartesianNodalAlgorithm, UpwardDy and DownwardDy are equivalent
- };
+ }
/**
* Perform derivative along z
@@ -133,7 +133,7 @@ struct CartesianNodalAlgorithm {
#elif (defined WARPX_DIM_XZ)
return 0.5_rt*inv_dz*( F(i,j+1,k,ncomp) - F(i,j-1,k,ncomp) );
#endif
- };
+ }
/**
* Perform derivative along z
@@ -147,7 +147,7 @@ struct CartesianNodalAlgorithm {
return UpwardDz( F, coefs_z, n_coefs_z, i, j, k ,ncomp);
// For CartesianNodalAlgorithm, UpwardDz and DownwardDz are equivalent
- };
+ }
};
diff --git a/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CartesianYeeAlgorithm.H b/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CartesianYeeAlgorithm.H
index 1c8609dfa..29e3d710e 100644
--- a/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CartesianYeeAlgorithm.H
+++ b/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CartesianYeeAlgorithm.H
@@ -63,7 +63,7 @@ struct CartesianYeeAlgorithm {
amrex::Real const inv_dx = coefs_x[0];
return inv_dx*( F(i+1,j,k,ncomp) - F(i,j,k,ncomp) );
- };
+ }
/**
* Perform derivative along x on a nodal grid, from a cell-centered field `F`*/
@@ -75,7 +75,7 @@ struct CartesianYeeAlgorithm {
amrex::Real const inv_dx = coefs_x[0];
return inv_dx*( F(i,j,k,ncomp) - F(i-1,j,k,ncomp) );
- };
+ }
/**
* Perform derivative along y on a cell-centered grid, from a nodal field `F`*/
@@ -92,7 +92,7 @@ struct CartesianYeeAlgorithm {
#elif (defined WARPX_DIM_XZ)
return 0._rt; // 2D Cartesian: derivative along y is 0
#endif
- };
+ }
/**
* Perform derivative along y on a nodal grid, from a cell-centered field `F`*/
@@ -109,7 +109,7 @@ struct CartesianYeeAlgorithm {
#elif (defined WARPX_DIM_XZ)
return 0._rt; // 2D Cartesian: derivative along y is 0
#endif
- };
+ }
/**
* Perform derivative along z on a cell-centered grid, from a nodal field `F`*/
@@ -126,7 +126,7 @@ struct CartesianYeeAlgorithm {
#elif (defined WARPX_DIM_XZ)
return inv_dz*( F(i,j+1,k,ncomp) - F(i,j,k,ncomp) );
#endif
- };
+ }
/**
* Perform derivative along z on a nodal grid, from a cell-centered field `F`*/
@@ -143,7 +143,7 @@ struct CartesianYeeAlgorithm {
#elif (defined WARPX_DIM_XZ)
return inv_dz*( F(i,j,k,ncomp) - F(i,j-1,k,ncomp) );
#endif
- };
+ }
};
diff --git a/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceSolver.cpp b/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceSolver.cpp
index 9676710b5..08ff5e18f 100644
--- a/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceSolver.cpp
+++ b/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceSolver.cpp
@@ -55,4 +55,4 @@ FiniteDifferenceSolver::FiniteDifferenceSolver (
} else {
amrex::Abort("Unknown algorithm");
}
-};
+}
diff --git a/Source/Laser/LaserProfiles.H b/Source/Laser/LaserProfiles.H
index 5b7f284ea..585e65a8e 100644
--- a/Source/Laser/LaserProfiles.H
+++ b/Source/Laser/LaserProfiles.H
@@ -97,7 +97,7 @@ public:
amrex::Real t,
amrex::Real * AMREX_RESTRICT const amplitude) const = 0;
- virtual ~ILaserProfile(){};
+ virtual ~ILaserProfile(){}
};
/**
diff --git a/Source/Particles/Filter/FilterFunctors.H b/Source/Particles/Filter/FilterFunctors.H
index 02a5f14c1..44240f3fc 100644
--- a/Source/Particles/Filter/FilterFunctors.H
+++ b/Source/Particles/Filter/FilterFunctors.H
@@ -26,7 +26,7 @@ struct RandomFilter
* \param a_fraction fraction of particles to select
*/
RandomFilter(bool a_is_active, amrex::Real a_fraction)
- : m_is_active(a_is_active), m_fraction(a_fraction) {};
+ : m_is_active(a_is_active), m_fraction(a_fraction) {}
/**
* \brief draw random number, return 1 if number < m_fraction, 1 otherwise
@@ -55,7 +55,7 @@ struct UniformFilter
* \param a_stride one particle every a_stride is written to file
*/
UniformFilter(bool a_is_active, int a_stride)
- : m_is_active(a_is_active), m_stride(a_stride) {};
+ : m_is_active(a_is_active), m_stride(a_stride) {}
/**
* \brief return 1 if stride divide particle_id, 0 otherwise
@@ -86,7 +86,7 @@ struct ParserFilter
: m_is_active(a_is_active), m_function_partparser(a_filter_parser)
{
m_t = WarpX::GetInstance().gett_new(0);
- };
+ }
/**
* \brief return 1 if the particle is selected by the parser
diff --git a/Source/Particles/PhotonParticleContainer.H b/Source/Particles/PhotonParticleContainer.H
index 0bfe38f42..1291f2cf9 100644
--- a/Source/Particles/PhotonParticleContainer.H
+++ b/Source/Particles/PhotonParticleContainer.H
@@ -82,7 +82,7 @@ public:
const amrex::MultiFab& Ez,
const amrex::MultiFab& Bx,
const amrex::MultiFab& By,
- const amrex::MultiFab& Bz) override {};
+ const amrex::MultiFab& Bz) override {}
// DepositCurrent should do nothing for photons
@@ -100,7 +100,7 @@ public:
int thread_num,
int lev,
int depos_lev,
- amrex::Real dt) override {};
+ amrex::Real dt) override {}
};
#endif // #ifndef WARPX_PhotonParticleContainer_H_
diff --git a/Source/Particles/ShapeFactors.H b/Source/Particles/ShapeFactors.H
index 1455d2888..917f0872d 100644
--- a/Source/Particles/ShapeFactors.H
+++ b/Source/Particles/ShapeFactors.H
@@ -23,7 +23,7 @@ struct Compute_shape_factor
{
template< typename T >
AMREX_GPU_HOST_DEVICE AMREX_FORCE_INLINE
- int operator()(T* const sx, T xint) const { return 0; };
+ int operator()(T* const sx, T xint) const { return 0; }
};
/**
@@ -41,7 +41,7 @@ struct Compute_shape_factor< 0 >
const auto j = static_cast<int>(xmid + T(0.5));
sx[0] = T(1.0);
return j;
- };
+ }
};
/**
@@ -61,7 +61,7 @@ struct Compute_shape_factor< 1 >
sx[0] = T(1.0) - xint;
sx[1] = xint;
return j;
- };
+ }
};
/**
@@ -83,7 +83,7 @@ struct Compute_shape_factor< 2 >
sx[2] = T(0.5)*(T(0.5) + xint)*(T(0.5) + xint);
// index of the leftmost cell where particle deposits
return j-1;
- };
+ }
};
/**
@@ -106,7 +106,7 @@ struct Compute_shape_factor< 3 >
sx[3] = (T(1.0))/(T(6.0))*xint*xint*xint;
// index of the leftmost cell where particle deposits
return j-1;
- };
+ }
};
/**
@@ -140,7 +140,7 @@ struct Compute_shifted_shape_factor< 1 >
sx[1+i_shift] = T(1.0) - xint;
sx[2+i_shift] = xint;
return i;
- };
+ }
};
/**
@@ -163,7 +163,7 @@ struct Compute_shifted_shape_factor< 2 >
sx[3+i_shift] = T(0.5)*(T(0.5) + xint)*(T(0.5) + xint);
// index of the leftmost cell where particle deposits
return i - 1;
- };
+ }
};
/**
@@ -187,7 +187,7 @@ struct Compute_shifted_shape_factor< 3 >
sx[4+i_shift] = (T(1.0))/(T(6.0))*xint*xint*xint;
// index of the leftmost cell where particle deposits
return i - 1;
- };
+ }
};
#endif // SHAPEFACTORS_H_
diff --git a/Source/Particles/Sorting/SortingUtils.H b/Source/Particles/Sorting/SortingUtils.H
index 73eb76305..f07ac450d 100644
--- a/Source/Particles/Sorting/SortingUtils.H
+++ b/Source/Particles/Sorting/SortingUtils.H
@@ -104,7 +104,7 @@ class fillBufferFlag
m_prob_lo[idim] = geom.ProbLo(idim);
m_inv_cell_size[idim] = geom.InvCellSize(idim);
}
- };
+ }
AMREX_GPU_HOST_DEVICE AMREX_FORCE_INLINE
@@ -117,7 +117,7 @@ class fillBufferFlag
// Find the value of the buffer flag in this cell and
// store it at the corresponding particle position in the array `inexflag`
m_inexflag_ptr[i] = m_buffer_mask(iv);
- };
+ }
private:
amrex::GpuArray<amrex::Real,AMREX_SPACEDIM> m_prob_lo;
@@ -164,7 +164,7 @@ class fillBufferFlagRemainingParticles
m_prob_lo[idim] = geom.ProbLo(idim);
m_inv_cell_size[idim] = geom.InvCellSize(idim);
}
- };
+ }
AMREX_GPU_HOST_DEVICE AMREX_FORCE_INLINE
@@ -177,7 +177,7 @@ class fillBufferFlagRemainingParticles
// Find the value of the buffer flag in this cell and
// store it at the corresponding particle position in the array `inexflag`
m_inexflag_ptr[m_indices_ptr[i+m_start_index]] = m_buffer_mask(iv);
- };
+ }
private:
amrex::GpuArray<amrex::Real,AMREX_SPACEDIM> m_prob_lo;
@@ -209,12 +209,12 @@ class copyAndReorder
m_src_ptr = src.dataPtr();
m_dst_ptr = dst.dataPtr();
m_indices_ptr = indices.dataPtr();
- };
+ }
AMREX_GPU_DEVICE AMREX_FORCE_INLINE
void operator()( const long ip ) const {
m_dst_ptr[ip] = m_src_ptr[ m_indices_ptr[ip] ];
- };
+ }
private:
T const* m_src_ptr;
diff --git a/Source/Particles/WarpXParticleContainer.H b/Source/Particles/WarpXParticleContainer.H
index 4c493b21f..27ac85a27 100644
--- a/Source/Particles/WarpXParticleContainer.H
+++ b/Source/Particles/WarpXParticleContainer.H
@@ -256,7 +256,7 @@ public:
virtual void WriteHeader (std::ostream& os) const;
- virtual void ConvertUnits (ConvertDirection convert_dir){};
+ virtual void ConvertUnits (ConvertDirection convert_dir){}
static void ReadParameters ();
@@ -302,17 +302,17 @@ public:
//amrex::Real getMass () {return mass;}
amrex::ParticleReal getMass () const {return mass;}
- int DoFieldIonization() const { return do_field_ionization; };
+ int DoFieldIonization() const { return do_field_ionization; }
int DoQED() const {
#ifdef WARPX_QED
return m_do_qed;
#else
return false;
#endif
- };
+ }
//Species for which QED effects are relevant should override these methods
- virtual bool has_quantum_sync() const {return false;};
- virtual bool has_breit_wheeler() const {return false;};
+ virtual bool has_quantum_sync() const {return false;}
+ virtual bool has_breit_wheeler() const {return false;}
// build filter functors
bool m_do_random_filter = false;
diff --git a/Source/WarpX.H b/Source/WarpX.H
index 8e8085024..6f071bbb6 100644
--- a/Source/WarpX.H
+++ b/Source/WarpX.H
@@ -246,7 +246,7 @@ public:
const amrex::MultiFab& getBfield_fp (int lev, int direction) {return *Bfield_fp[lev][direction];}
const amrex::MultiFab& getrho_fp (int lev) {return *rho_fp[lev];}
const amrex::MultiFab& getF_fp (int lev) {return *F_fp[lev];}
- bool DoPML () const {return do_pml;};
+ bool DoPML () const {return do_pml;}
/** get low-high-low-high-... vector for each direction indicating if mother grid PMLs are enabled */
std::vector<bool> getPMLdirections() const;
@@ -405,8 +405,8 @@ public:
void SyncCurrent ();
void SyncRho ();
- amrex::Vector<int> getnsubsteps () const {return nsubsteps;};
- int getnsubsteps (int lev) const {return nsubsteps[lev];};
+ amrex::Vector<int> getnsubsteps () const {return nsubsteps;}
+ int getnsubsteps (int lev) const {return nsubsteps[lev];}
amrex::Vector<int> getistep () const {return istep;}
int getistep (int lev) const {return istep[lev];}
void setistep (int lev, int ii) {istep[lev] = ii;}
@@ -417,9 +417,9 @@ public:
void sett_new (int lev, amrex::Real time) {t_new[lev] = time;}
amrex::Vector<amrex::Real> getdt () const {return dt;}
amrex::Real getdt (int lev) const {return dt[lev];}
- amrex::Real getmoving_window_x() const {return moving_window_x;};
- bool getis_synchronized() const {return is_synchronized;};
- void setplot_rho (bool a_plot_rho) {plot_rho = a_plot_rho;};
+ amrex::Real getmoving_window_x() const {return moving_window_x;}
+ bool getis_synchronized() const {return is_synchronized;}
+ void setplot_rho (bool a_plot_rho) {plot_rho = a_plot_rho;}
int maxStep () const {return max_step;}
amrex::Real stopTime () const {return stop_time;}
@@ -471,10 +471,10 @@ public:
void ComputeDivE(amrex::MultiFab& divE, const int lev);
- const amrex::IntVect getngE() const { return guard_cells.ng_alloc_EB; };
- const amrex::IntVect getngF() const { return guard_cells.ng_alloc_F; };
- const amrex::IntVect getngExtra() const { return guard_cells.ng_Extra; };
- const amrex::IntVect getngUpdateAux() const { return guard_cells.ng_UpdateAux; };
+ const amrex::IntVect getngE() const { return guard_cells.ng_alloc_EB; }
+ const amrex::IntVect getngF() const { return guard_cells.ng_alloc_F; }
+ const amrex::IntVect getngExtra() const { return guard_cells.ng_Extra; }
+ const amrex::IntVect getngUpdateAux() const { return guard_cells.ng_UpdateAux; }
void ComputeSpaceChargeField (bool const reset_fields);
void AddSpaceChargeField (WarpXParticleContainer& pc);