aboutsummaryrefslogtreecommitdiff
path: root/Source
diff options
context:
space:
mode:
Diffstat (limited to 'Source')
-rw-r--r--Source/BoundaryConditions/PML.cpp2
-rw-r--r--Source/FieldSolver/FiniteDifferenceSolver/EvolveBPML.cpp2
-rw-r--r--Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CylindricalYeeAlgorithm.H2
-rw-r--r--Source/FieldSolver/SpectralSolver/SpectralAlgorithms/PsatdAlgorithm.H2
-rw-r--r--Source/FieldSolver/SpectralSolver/SpectralAlgorithms/PsatdAlgorithmRZ.cpp2
-rw-r--r--Source/FieldSolver/SpectralSolver/SpectralAlgorithms/SpectralBaseAlgorithmRZ.H4
-rw-r--r--Source/FieldSolver/SpectralSolver/SpectralHankelTransform/BesselRoots.H8
-rw-r--r--Source/FieldSolver/SpectralSolver/SpectralHankelTransform/SpectralHankelTransformer.H2
-rw-r--r--Source/Utils/KernelTimer.H12
-rw-r--r--Source/Utils/WarpXUtil.cpp2
10 files changed, 26 insertions, 12 deletions
diff --git a/Source/BoundaryConditions/PML.cpp b/Source/BoundaryConditions/PML.cpp
index 630703b3b..6f033043a 100644
--- a/Source/BoundaryConditions/PML.cpp
+++ b/Source/BoundaryConditions/PML.cpp
@@ -554,7 +554,7 @@ PML::PML (const int lev, const BoxArray& grid_ba, const DistributionMapping& /*g
if (WarpX::maxwell_solver_id == MaxwellSolverAlgo::PSATD) {
#ifndef WARPX_USE_PSATD
- amrex::ignore_unused(dt);
+ amrex::ignore_unused(lev, dt);
# if(AMREX_SPACEDIM!=3)
amrex::ignore_unused(noy_fft);
# endif
diff --git a/Source/FieldSolver/FiniteDifferenceSolver/EvolveBPML.cpp b/Source/FieldSolver/FiniteDifferenceSolver/EvolveBPML.cpp
index fbc62f661..6eb7caacc 100644
--- a/Source/FieldSolver/FiniteDifferenceSolver/EvolveBPML.cpp
+++ b/Source/FieldSolver/FiniteDifferenceSolver/EvolveBPML.cpp
@@ -32,7 +32,7 @@ void FiniteDifferenceSolver::EvolveBPML (
// Select algorithm (The choice of algorithm is a runtime option,
// but we compile code for each algorithm, using templates)
#ifdef WARPX_DIM_RZ
- amrex::ignore_unused(Bfield, Efield, dt);
+ amrex::ignore_unused(Bfield, Efield, dt, dive_cleaning);
amrex::Abort("PML are not implemented in cylindrical geometry.");
#else
if (m_do_nodal) {
diff --git a/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CylindricalYeeAlgorithm.H b/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CylindricalYeeAlgorithm.H
index 1978a61a5..2fb0c8e80 100644
--- a/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CylindricalYeeAlgorithm.H
+++ b/Source/FieldSolver/FiniteDifferenceSolver/FiniteDifferenceAlgorithms/CylindricalYeeAlgorithm.H
@@ -114,7 +114,7 @@ struct CylindricalYeeAlgorithm {
Real const inv_dr = coefs_r[0];
return inv_dr*( F(i+1,j,k,comp) - F(i,j,k,comp) );
- };
+ }
/**
* Perform derivative along r on a nodal grid, from a cell-centered field `F` */
diff --git a/Source/FieldSolver/SpectralSolver/SpectralAlgorithms/PsatdAlgorithm.H b/Source/FieldSolver/SpectralSolver/SpectralAlgorithms/PsatdAlgorithm.H
index d5efe5b74..efa907d14 100644
--- a/Source/FieldSolver/SpectralSolver/SpectralAlgorithms/PsatdAlgorithm.H
+++ b/Source/FieldSolver/SpectralSolver/SpectralAlgorithms/PsatdAlgorithm.H
@@ -41,7 +41,7 @@ class PsatdAlgorithm : public SpectralBaseAlgorithm
} else {
return SpectralFieldIndex::n_fields;
}
- };
+ }
// TODO Add Doxygen docs
void InitializeSpectralCoefficients (
diff --git a/Source/FieldSolver/SpectralSolver/SpectralAlgorithms/PsatdAlgorithmRZ.cpp b/Source/FieldSolver/SpectralSolver/SpectralAlgorithms/PsatdAlgorithmRZ.cpp
index b96d5fa93..86d9f9696 100644
--- a/Source/FieldSolver/SpectralSolver/SpectralAlgorithms/PsatdAlgorithmRZ.cpp
+++ b/Source/FieldSolver/SpectralSolver/SpectralAlgorithms/PsatdAlgorithmRZ.cpp
@@ -299,7 +299,7 @@ PsatdAlgorithmRZ::CurrentCorrection (const int lev,
}
void
-PsatdAlgorithmRZ::VayDeposition (const int lev /**/,
+PsatdAlgorithmRZ::VayDeposition (const int /* lev */,
SpectralFieldDataRZ& /*field_data*/,
std::array<std::unique_ptr<amrex::MultiFab>,3>& /*current*/)
{
diff --git a/Source/FieldSolver/SpectralSolver/SpectralAlgorithms/SpectralBaseAlgorithmRZ.H b/Source/FieldSolver/SpectralSolver/SpectralAlgorithms/SpectralBaseAlgorithmRZ.H
index c19d2fc5e..51bba5b87 100644
--- a/Source/FieldSolver/SpectralSolver/SpectralAlgorithms/SpectralBaseAlgorithmRZ.H
+++ b/Source/FieldSolver/SpectralSolver/SpectralAlgorithms/SpectralBaseAlgorithmRZ.H
@@ -26,7 +26,7 @@ class SpectralBaseAlgorithmRZ
// The destructor should also be a virtual function, so that
// a pointer to subclass of `SpectraBaseAlgorithm` actually
// calls the subclass's destructor.
- virtual ~SpectralBaseAlgorithmRZ() {};
+ virtual ~SpectralBaseAlgorithmRZ() {}
/**
* \brief Virtual function for current correction in Fourier space
@@ -74,7 +74,7 @@ class SpectralBaseAlgorithmRZ
int const norder_z, bool const nodal)
// Compute and assign the modified k vectors
: modified_kz_vec(spectral_kspace.getModifiedKComponent(dm, 1, norder_z, nodal))
- {};
+ {}
// Modified finite-order vectors
KVectorComponent modified_kz_vec;
diff --git a/Source/FieldSolver/SpectralSolver/SpectralHankelTransform/BesselRoots.H b/Source/FieldSolver/SpectralSolver/SpectralHankelTransform/BesselRoots.H
index a44d192fb..6465d119e 100644
--- a/Source/FieldSolver/SpectralSolver/SpectralHankelTransform/BesselRoots.H
+++ b/Source/FieldSolver/SpectralSolver/SpectralHankelTransform/BesselRoots.H
@@ -32,7 +32,10 @@
! (www.jpmoreau.fr)
! ------------------------------------------------------------------------ */
-using amrex::operator""_rt;
+#include <AMReX_REAL.H>
+
+#include <cmath>
+
void SecantRootFinder(int n, int nitmx, amrex::Real tol, amrex::Real *zeroj, int *ier);
@@ -52,6 +55,8 @@ void SecantRootFinder(int n, int nitmx, amrex::Real tol, amrex::Real *zeroj, int
* handbook of mathematical functions
*/
void GetBesselRoots(int n, int nk, amrex::Vector<amrex::Real>& roots, amrex::Vector<int> &ier) {
+ using namespace amrex::literals;
+
amrex::Real zeroj;
int ierror, ik, k;
@@ -125,6 +130,7 @@ void GetBesselRoots(int n, int nk, amrex::Vector<amrex::Real>& roots, amrex::Vec
}
void SecantRootFinder(int n, int nitmx, amrex::Real tol, amrex::Real *zeroj, int *ier) {
+ using namespace amrex::literals;
amrex::Real p0, p1, q0, q1, dp, p;
amrex::Real c[2];
diff --git a/Source/FieldSolver/SpectralSolver/SpectralHankelTransform/SpectralHankelTransformer.H b/Source/FieldSolver/SpectralSolver/SpectralHankelTransform/SpectralHankelTransformer.H
index e24123f78..82cf48fe4 100644
--- a/Source/FieldSolver/SpectralSolver/SpectralHankelTransform/SpectralHankelTransformer.H
+++ b/Source/FieldSolver/SpectralSolver/SpectralHankelTransform/SpectralHankelTransformer.H
@@ -22,7 +22,7 @@ class SpectralHankelTransformer
{
public:
- SpectralHankelTransformer () {};
+ SpectralHankelTransformer () {}
SpectralHankelTransformer (const int nr,
const int n_rz_azimuthal_modes,
diff --git a/Source/Utils/KernelTimer.H b/Source/Utils/KernelTimer.H
index 8c13e1add..b52f0d33b 100644
--- a/Source/Utils/KernelTimer.H
+++ b/Source/Utils/KernelTimer.H
@@ -21,8 +21,14 @@ public:
* (for performance, it is recommended to allocate pinned host memory).
*/
AMREX_GPU_DEVICE
- KernelTimer (const bool do_timing, amrex::Real* cost)
- : m_do_timing(do_timing), m_cost(cost) {
+ KernelTimer
+#if (defined AMREX_USE_GPU)
+ (const bool do_timing, amrex::Real* cost)
+ : m_do_timing(do_timing), m_cost(cost)
+#else
+ (const bool, amrex::Real*)
+#endif
+ {
#if (defined AMREX_USE_GPU)
if (do_timing && cost) {
#if defined(AMREX_USE_CUDA) || defined(AMREX_USE_HIP)
@@ -53,6 +59,7 @@ public:
#endif
}
+#if (defined AMREX_USE_GPU)
private:
//! Stores whether kernel timer is active.
bool m_do_timing;
@@ -62,6 +69,7 @@ private:
//! Store the time difference (cost) from a single thread.
long long int m_wt;
+#endif
};
#endif
diff --git a/Source/Utils/WarpXUtil.cpp b/Source/Utils/WarpXUtil.cpp
index a87027176..622a0256e 100644
--- a/Source/Utils/WarpXUtil.cpp
+++ b/Source/Utils/WarpXUtil.cpp
@@ -362,7 +362,7 @@ void ReadBCParams ()
if (pp_geometry.queryarr("is_periodic", geom_periodicity)) {
return;
// When all boundary conditions are supported, the abort statement below will be introduced
- amrex::Abort("geometry.is_periodic is not supported. Please use `boundary.field_lo`, `boundary.field_hi` to specifiy field boundary conditions and 'boundary.particle_lo', 'boundary.particle_hi' to specify particle boundary conditions.");
+ //amrex::Abort("geometry.is_periodic is not supported. Please use `boundary.field_lo`, `boundary.field_hi` to specifiy field boundary conditions and 'boundary.particle_lo', 'boundary.particle_hi' to specify particle boundary conditions.");
}
// particle boundary may not be explicitly specified for some applications
bool particle_boundary_specified = false;