aboutsummaryrefslogtreecommitdiff
diff options
context:
space:
mode:
-rw-r--r--Examples/Modules/boosted_diags/inputs.2d95
-rw-r--r--Examples/Modules/boosted_diags/inputs.3d95
-rw-r--r--Examples/Modules/charged_beam/inputs50
-rw-r--r--Examples/Modules/gaussian_beam/PICMI_inputs_gaussian_beam.py4
-rw-r--r--Examples/Modules/gaussian_beam/inputs100
-rw-r--r--Examples/Physics_applications/laser_acceleration/PICMI_inputs_laser_acceleration.py2
-rw-r--r--Examples/Physics_applications/plasma_acceleration/PICMI_inputs_plasma_acceleration.py2
-rw-r--r--Examples/Physics_applications/plasma_acceleration/PICMI_inputs_plasma_acceleration_mr.py2
-rw-r--r--Examples/Physics_applications/plasma_acceleration/inputs.2d.boost4
-rw-r--r--Examples/Physics_applications/plasma_acceleration/inputs.3d.boost2
-rw-r--r--Examples/Tests/Langmuir/PICMI_inputs_langmuir.py52
-rw-r--r--Examples/Tests/Langmuir/PICMI_inputs_langmuir2d.py2
-rw-r--r--Examples/Tests/Langmuir/inputs.2d.rz55
-rw-r--r--Examples/Tests/Langmuir/inputs.lb59
-rw-r--r--Examples/Tests/Langmuir/inputs.nolb59
-rw-r--r--Examples/Tests/Larmor/inputs77
-rw-r--r--Examples/Tests/Larmor/inputs.mr (renamed from Examples/Tests/Larmor/inputs.ml)0
-rw-r--r--Examples/Tests/laser_on_fine/inputs73
-rw-r--r--Examples/Tests/laser_on_fine/inputs.2d2
-rw-r--r--Regression/WarpX-tests.ini228
20 files changed, 237 insertions, 726 deletions
diff --git a/Examples/Modules/boosted_diags/inputs.2d b/Examples/Modules/boosted_diags/inputs.2d
deleted file mode 100644
index 6afe6977d..000000000
--- a/Examples/Modules/boosted_diags/inputs.2d
+++ /dev/null
@@ -1,95 +0,0 @@
-# Maximum number of time steps
-max_step = 260
-
-# number of grid points
-amr.n_cell = 64 64 512
-
-# Maximum allowable size of each subdomain in the problem domain;
-# this is used to decompose the domain for parallel calculations.
-
-amr.max_grid_size = 32
-
-# Maximum level in hierarchy (for now must be 0, i.e., one level in total)
-amr.max_level = 0
-amr.plot_int = 10 # How often to write plotfiles. "<= 0" means no plotfiles.
-amr.check_int = 10
-
-# Geometry
-geometry.coord_sys = 0 # 0: Cartesian
-geometry.is_periodic = 1 1 0 # Is periodic?
-geometry.prob_lo = -150.e-6 -150.e-6 -0.6e-3 # physical domain
-geometry.prob_hi = 150.e-6 150.e-6 0.
-
-# Verbosity
-warpx.verbose = 1
-
-# Algorithms
-algo.current_deposition = direct
-
-# Numerics
-interpolation.nox = 3
-interpolation.noy = 3
-interpolation.noz = 3
-warpx.use_filter = 1
-warpx.cfl = 1.0
-warpx.do_pml = 0
-
-# Moving window
-warpx.do_moving_window = 1
-warpx.moving_window_dir = z
-warpx.moving_window_v = 1.0 # in units of the speed of light
-
-# Boosted frame
-warpx.gamma_boost = 15.
-warpx.boost_direction = z
-
-# Diagnostics
-warpx.do_boosted_frame_diagnostic = 1
-warpx.num_snapshots_lab = 20
-warpx.dt_snapshots_lab = 7.0e-14
-
-# Species
-particles.nspecies = 2
-particles.species_names = electrons ions
-
-electrons.charge = -q_e
-electrons.mass = m_e
-electrons.injection_style = "NUniformPerCell"
-electrons.xmin = -150.e-6
-electrons.xmax = 150.e-6
-electrons.ymin = -150.e-6
-electrons.ymax = 150.e-6
-electrons.zmin = 0.e-6
-electrons.num_particles_per_cell_each_dim = 1 1 2
-electrons.profile = constant
-electrons.density = 1.
-electrons.momentum_distribution_type = "constant"
-electrons.do_continuous_injection = 1
-
-ions.charge = q_e
-ions.mass = m_p
-ions.injection_style = "NUniformPerCell"
-ions.xmin = -150.e-6
-ions.xmax = 150.e-6
-ions.ymin = -150.e-6
-ions.ymax = 150.e-6
-ions.zmin = 0.e-6
-ions.num_particles_per_cell_each_dim = 1 1 2
-ions.profile = constant
-ions.density = 1.
-ions.momentum_distribution_type = "constant"
-ions.do_continuous_injection = 1
-
-# Laser
-lasers.nlasers = 1
-lasers.names = laser1
-laser1.profile = Gaussian
-laser1.position = 0. 0. -1.e-6 # This point is on the laser plane
-laser1.direction = 0. 0. 1. # The plane normal direction
-laser1.polarization = 1. 0. 0. # The main polarization vector
-laser1.e_max = 8.e12 # Maximum amplitude of the laser field (in V/m)
-laser1.profile_waist = 5.e-5 # The waist of the laser (in meters)
-laser1.profile_duration = 16.7e-15 # The duration of the laser (in seconds)
-laser1.profile_t_peak = 33.4e-15 # The time at which the laser reaches its peak (in seconds)
-laser1.profile_focal_distance = 0.e-6 # Focal distance from the antenna (in meters)
-laser1.wavelength = 0.8e-6 # The wavelength of the laser (in meters)
diff --git a/Examples/Modules/boosted_diags/inputs.3d b/Examples/Modules/boosted_diags/inputs.3d
deleted file mode 100644
index 528eb6cd9..000000000
--- a/Examples/Modules/boosted_diags/inputs.3d
+++ /dev/null
@@ -1,95 +0,0 @@
-# Maximum number of time steps
-max_step = 260
-
-# number of grid points
-amr.n_cell = 64 64 512
-
-# Maximum allowable size of each subdomain in the problem domain;
-# this is used to decompose the domain for parallel calculations.
-
-amr.max_grid_size = 32
-
-# Maximum level in hierarchy (for now must be 0, i.e., one level in total)
-amr.max_level = 0
-amr.plot_int = 10 # How often to write plotfiles. "<= 0" means no plotfiles.
-amr.check_int = 10
-
-# Geometry
-geometry.coord_sys = 0 # 0: Cartesian
-geometry.is_periodic = 1 1 0 # Is periodic?
-geometry.prob_lo = -150.e-6 -150.e-6 -0.6e-3 # physical domain
-geometry.prob_hi = 150.e-6 150.e-6 0.
-
-# Verbosity
-warpx.verbose = 1
-
-# Algorithms
-algo.current_deposition = direct
-
-# Numerics
-interpolation.nox = 3
-interpolation.noy = 3
-interpolation.noz = 3
-warpx.use_filter = 1
-warpx.cfl = 1.0
-warpx.do_pml = 0
-
-# Moving window
-warpx.do_moving_window = 1
-warpx.moving_window_dir = z
-warpx.moving_window_v = 1.0 # in units of the speed of light
-
-# Boosted frame
-warpx.gamma_boost = 15.
-warpx.boost_direction = z
-
-# Diagnostics
-warpx.do_boosted_frame_diagnostic = 1
-warpx.num_snapshots_lab = 20;
-warpx.dt_snapshots_lab = 7.0e-14;
-
-# Species
-particles.nspecies = 2
-particles.species_names = electrons ions
-
-electrons.charge = -q_e
-electrons.mass = m_e
-electrons.injection_style = "NUniformPerCell"
-electrons.xmin = -150.e-6
-electrons.xmax = 150.e-6
-electrons.ymin = -150.e-6
-electrons.ymax = 150.e-6
-electrons.zmin = 0.e-6
-electrons.num_particles_per_cell_each_dim = 1 1 2
-electrons.profile = constant
-electrons.density = 1.
-electrons.momentum_distribution_type = "constant"
-electrons.do_continuous_injection = 1
-
-ions.charge = q_e
-ions.mass = m_p
-ions.injection_style = "NUniformPerCell"
-ions.xmin = -150.e-6
-ions.xmax = 150.e-6
-ions.ymin = -150.e-6
-ions.ymax = 150.e-6
-ions.zmin = 0.e-6
-ions.num_particles_per_cell_each_dim = 1 1 2
-ions.profile = constant
-ions.density = 1.
-ions.momentum_distribution_type = "constant"
-ions.do_continuous_injection = 1
-
-# Laser
-lasers.nlasers = 1
-lasers.names = laser1
-laser1.profile = Gaussian
-laser1.position = 0. 0. -1.e-6 # This point is on the laser plane
-laser1.direction = 0. 0. 1. # The plane normal direction
-laser1.polarization = 1. 0. 0. # The main polarization vector
-laser1.e_max = 8.e12 # Maximum amplitude of the laser field (in V/m)
-laser1.profile_waist = 5.e-5 # The waist of the laser (in meters)
-laser1.profile_duration = 16.7e-15 # The duration of the laser (in seconds)
-laser1.profile_t_peak = 33.4e-15 # The time at which the laser reaches its peak (in seconds)
-laser1.profile_focal_distance = 0.e-6 # Focal distance from the antenna (in meters)
-laser1.wavelength = 0.8e-6 # The wavelength of the laser (in meters)
diff --git a/Examples/Modules/charged_beam/inputs b/Examples/Modules/charged_beam/inputs
deleted file mode 100644
index 18b645281..000000000
--- a/Examples/Modules/charged_beam/inputs
+++ /dev/null
@@ -1,50 +0,0 @@
-# Maximum number of time steps
-max_step = 40
-
-# number of grid points
-amr.n_cell = 63 63 63
-
-# Maximum allowable size of each subdomain in the problem domain;
-# this is used to decompose the domain for parallel calculations.
-amr.max_grid_size = 32
-
-# Maximum level in hierarchy (for now must be 0, i.e., one level in total)
-amr.max_level = 0
-
-amr.plot_int = 1 # How often to write plotfiles. "<= 0" means no plotfiles.
-
-# Geometry
-geometry.coord_sys = 0 # 0: Cartesian
-geometry.is_periodic = 1 1 1 # Is periodic?
-geometry.prob_lo = -20.e-6 -20.e-6 -20.e-6 # physical domain
-geometry.prob_hi = 20.e-6 20.e-6 20.e-6
-
-# Verbosity
-warpx.verbose = 1
-
-# Algorithms
-algo.current_deposition = direct
-
-# CFL
-warpx.cfl = 1.0
-
-particles.nspecies = 1
-particles.species_names = electrons
-
-electrons.charge = -q_e
-electrons.mass = m_e
-electrons.injection_style = "NUniformPerCell"
-electrons.num_particles_per_cell_each_dim = 2 2 2
-
-electrons.xmin = -20.e-6
-electrons.xmax = 0.e-6
-electrons.ymin = -20.e-6
-electrons.ymax = 20.e-6
-electrons.zmin = -20.e-6
-electrons.zmax = 20.e-6
-
-electrons.profile = constant
-electrons.density = 1.e25 # number of electrons per m^3
-
-electrons.momentum_distribution_type = "constant"
-electrons.ux = 0.01 # ux = gamma*beta_x
diff --git a/Examples/Modules/gaussian_beam/PICMI_inputs_gaussian_beam.py b/Examples/Modules/gaussian_beam/PICMI_inputs_gaussian_beam.py
index a22e83794..ecc8f5a65 100644
--- a/Examples/Modules/gaussian_beam/PICMI_inputs_gaussian_beam.py
+++ b/Examples/Modules/gaussian_beam/PICMI_inputs_gaussian_beam.py
@@ -45,9 +45,9 @@ electrons = picmi.Species(particle_type='electron', name='electrons', initial_di
protons = picmi.Species(particle_type='proton', name='protons', initial_distribution=proton_beam)
sim = picmi.Simulation(solver = solver,
- max_steps = 1000,
+ max_steps = 10,
verbose = 1,
- warpx_plot_int = 8,
+ warpx_plot_int = 10,
warpx_current_deposition_algo = 'direct')
sim.add_species(electrons, layout=picmi.PseudoRandomLayout(n_macroparticles=number_sim_particles))
diff --git a/Examples/Modules/gaussian_beam/inputs b/Examples/Modules/gaussian_beam/inputs
deleted file mode 100644
index 46cd785f2..000000000
--- a/Examples/Modules/gaussian_beam/inputs
+++ /dev/null
@@ -1,100 +0,0 @@
-# Maximum number of time steps
-max_step = 1000
-
-# number of grid points
-amr.n_cell = 32 32 32
-
-# Maximum allowable size of each subdomain in the problem domain;
-# this is used to decompose the domain for parallel calculations.
-amr.max_grid_size = 16
-
-# Maximum level in hierarchy (for now must be 0, i.e., one level in total)
-amr.max_level = 0
-
-amr.plot_int = 8 # How often to write plotfiles. "<= 0" means no plotfiles.
-
-# Geometry
-geometry.coord_sys = 0 # 0: Cartesian
-geometry.is_periodic = 1 1 0 # Is periodic?
-geometry.prob_lo = -2. -2. -2. # physical domain
-geometry.prob_hi = 2. 2. 2.
-
-# Verbosity
-warpx.verbose = 1
-
-# Algorithms
-
-# interpolation
-interpolation.nox = 3
-interpolation.noy = 3
-interpolation.noz = 3
-
-# CFL
-warpx.cfl = 1.0
-
-# Information about the particle species
-particles.nspecies = 2
-particles.species_names = electrons protons
-
-#
-# The electron species information
-#
-
-electrons.charge = -q_e
-electrons.mass = m_e
-electrons.injection_style = "gaussian_beam"
-electrons.x_rms = 0.25
-electrons.y_rms = 0.25
-electrons.z_rms = 0.25
-electrons.x_m = 0.
-electrons.y_m = 0.
-electrons.z_m = 0.
-electrons.npart = 32768
-electrons.q_tot = -8.010883097437485e-07
-
-electrons.profile = "constant"
-electrons.density = 1
-electrons.momentum_distribution_type = "radial_expansion"
-electrons.u_over_r = -0.04
-
-electrons.xmin = -2
-electrons.xmax = 2
-electrons.ymin = -2
-electrons.ymax = 2
-electrons.zmin = -2
-electrons.zmax = 2
-
-#
-# The proton species information
-#
-
-protons.charge = q_e
-protons.mass = m_p
-protons.injection_style = "gaussian_beam"
-protons.x_rms = 0.25
-protons.y_rms = 0.25
-protons.z_rms = 0.25
-protons.x_m = 0.
-protons.y_m = 0.
-protons.z_m = 0.
-protons.npart = 32768
-protons.q_tot = 8.010883097437485e-07
-
-protons.profile = "constant"
-protons.density = 1
-protons.momentum_distribution_type = "radial_expansion"
-protons.u_over_r = 0.
-
-protons.xmin = -2
-protons.xmax = 2
-protons.ymin = -2
-protons.ymax = 2
-protons.zmin = -2
-protons.zmax = 2
-
-warpx.do_pml = 0
-
-# Moving window
-warpx.do_moving_window = 0
-warpx.moving_window_dir = z
-warpx.moving_window_v = 1.0 # in units of the speed of light
diff --git a/Examples/Physics_applications/laser_acceleration/PICMI_inputs_laser_acceleration.py b/Examples/Physics_applications/laser_acceleration/PICMI_inputs_laser_acceleration.py
index 3c86d6348..7568ac3e8 100644
--- a/Examples/Physics_applications/laser_acceleration/PICMI_inputs_laser_acceleration.py
+++ b/Examples/Physics_applications/laser_acceleration/PICMI_inputs_laser_acceleration.py
@@ -32,7 +32,7 @@ plasma_max = [ 20.e-6, 20.e-6, 1.e-3]
# --- Nb time steps
-max_steps = 1000
+max_steps = 10
# --- grid
diff --git a/Examples/Physics_applications/plasma_acceleration/PICMI_inputs_plasma_acceleration.py b/Examples/Physics_applications/plasma_acceleration/PICMI_inputs_plasma_acceleration.py
index 0cd713514..7b1f9ea5d 100644
--- a/Examples/Physics_applications/plasma_acceleration/PICMI_inputs_plasma_acceleration.py
+++ b/Examples/Physics_applications/plasma_acceleration/PICMI_inputs_plasma_acceleration.py
@@ -43,7 +43,7 @@ beam = picmi.Species(particle_type='electron', name='beam', initial_distribution
plasma = picmi.Species(particle_type='electron', name='plasma', initial_distribution=plasma_distribution)
sim = picmi.Simulation(solver = solver,
- max_steps = 1000,
+ max_steps = 10,
verbose = 1,
warpx_plot_int = 2,
warpx_current_deposition_algo = 'esirkepov')
diff --git a/Examples/Physics_applications/plasma_acceleration/PICMI_inputs_plasma_acceleration_mr.py b/Examples/Physics_applications/plasma_acceleration/PICMI_inputs_plasma_acceleration_mr.py
index 24b48d575..44049e244 100644
--- a/Examples/Physics_applications/plasma_acceleration/PICMI_inputs_plasma_acceleration_mr.py
+++ b/Examples/Physics_applications/plasma_acceleration/PICMI_inputs_plasma_acceleration_mr.py
@@ -52,7 +52,7 @@ beam = picmi.Species(particle_type='electron', name='beam', initial_distribution
plasma = picmi.Species(particle_type='electron', name='plasma', initial_distribution=plasma_distribution)
sim = picmi.Simulation(solver = solver,
- max_steps = 1000,
+ max_steps = 10,
verbose = 1,
warpx_plot_int = 2,
warpx_current_deposition_algo = 'esirkepov')
diff --git a/Examples/Physics_applications/plasma_acceleration/inputs.2d.boost b/Examples/Physics_applications/plasma_acceleration/inputs.2d.boost
index d711815eb..efd740765 100644
--- a/Examples/Physics_applications/plasma_acceleration/inputs.2d.boost
+++ b/Examples/Physics_applications/plasma_acceleration/inputs.2d.boost
@@ -1,8 +1,8 @@
#################################
####### GENERAL PARAMETERS ######
#################################
-stop_time = 4.03658656286e-11
-amr.n_cell = 64 1280
+max_step = 2500
+amr.n_cell = 64 640
amr.max_grid_size = 128
amr.blocking_factor = 32
amr.max_level = 0
diff --git a/Examples/Physics_applications/plasma_acceleration/inputs.3d.boost b/Examples/Physics_applications/plasma_acceleration/inputs.3d.boost
index 42446a9ac..de18ec054 100644
--- a/Examples/Physics_applications/plasma_acceleration/inputs.3d.boost
+++ b/Examples/Physics_applications/plasma_acceleration/inputs.3d.boost
@@ -2,7 +2,7 @@
####### GENERAL PARAMETERS ######
#################################
stop_time = 3.93151387287e-11
-amr.n_cell = 32 32 320
+amr.n_cell = 32 32 256
amr.max_grid_size = 64
amr.blocking_factor = 32
amr.max_level = 0
diff --git a/Examples/Tests/Langmuir/PICMI_inputs_langmuir.py b/Examples/Tests/Langmuir/PICMI_inputs_langmuir.py
deleted file mode 100644
index ea1c93ba3..000000000
--- a/Examples/Tests/Langmuir/PICMI_inputs_langmuir.py
+++ /dev/null
@@ -1,52 +0,0 @@
-# --- Simple example of Langmuir oscillations in a uniform plasma
-
-import numpy as np
-from pywarpx import picmi
-
-constants = picmi.constants
-
-nx = 64
-ny = 64
-nz = 64
-
-xmin = -20.e-6
-ymin = -20.e-6
-zmin = -20.e-6
-xmax = +20.e-6
-ymax = +20.e-6
-zmax = +20.e-6
-
-uniform_plasma = picmi.UniformDistribution(density = 1.e25,
- upper_bound = [0., None, None],
- directed_velocity = [0.1*constants.c, 0., 0.])
-
-electrons = picmi.Species(particle_type='electron', name='electrons', initial_distribution=uniform_plasma)
-
-grid = picmi.Cartesian3DGrid(number_of_cells = [nx, ny, nz],
- lower_bound = [xmin, ymin, zmin],
- upper_bound = [xmax, ymax, zmax],
- lower_boundary_conditions = ['periodic', 'periodic', 'periodic'],
- upper_boundary_conditions = ['periodic', 'periodic', 'periodic'],
- moving_window_velocity = [0., 0., 0.],
- warpx_max_grid_size=32)
-
-solver = picmi.ElectromagneticSolver(grid=grid, cfl=1.)
-
-sim = picmi.Simulation(solver = solver,
- max_steps = 40,
- verbose = 1,
- warpx_plot_int = 1,
- warpx_current_deposition_algo = 'direct',
- warpx_charge_deposition_algo = 'standard',
- warpx_field_gathering_algo = 'standard',
- warpx_particle_pusher_algo = 'boris')
-
-sim.add_species(electrons, layout=picmi.GriddedLayout(n_macroparticle_per_cell=[2,2,2], grid=grid))
-
-# write_inputs will create an inputs file that can be used to run
-# with the compiled version.
-sim.write_input_file(file_name='inputs_from_PICMI')
-
-# Alternatively, sim.step will run WarpX, controlling it from Python
-sim.step()
-
diff --git a/Examples/Tests/Langmuir/PICMI_inputs_langmuir2d.py b/Examples/Tests/Langmuir/PICMI_inputs_langmuir2d.py
index 8cbc63e50..cd33d20f0 100644
--- a/Examples/Tests/Langmuir/PICMI_inputs_langmuir2d.py
+++ b/Examples/Tests/Langmuir/PICMI_inputs_langmuir2d.py
@@ -40,5 +40,5 @@ sim.add_species(electrons, layout=picmi.GriddedLayout(n_macroparticle_per_cell=[
sim.write_input_file(file_name='inputs2d_from_PICMI')
# Alternatively, sim.step will run WarpX, controlling it from Python
-#sim.step()
+sim.step()
diff --git a/Examples/Tests/Langmuir/inputs.2d.rz b/Examples/Tests/Langmuir/inputs.2d.rz
deleted file mode 100644
index 70850eea6..000000000
--- a/Examples/Tests/Langmuir/inputs.2d.rz
+++ /dev/null
@@ -1,55 +0,0 @@
-# Maximum number of time steps
-max_step = 100
-
-# number of grid points
-amr.n_cell = 64 64
-
-# Maximum allowable size of each subdomain in the problem domain;
-# this is used to decompose the domain for parallel calculations.
-amr.max_grid_size = 32
-amr.blocking_factor = 32 32
-
-# Maximum level in hierarchy (for now must be 0, i.e., one level in total)
-amr.max_level = 0
-
-amr.plot_int = 1 # How often to write plotfiles. "<= 0" means no plotfiles.
-
-# Geometry
-geometry.coord_sys = 1 # 1: RZ
-geometry.is_periodic = 0 1
-geometry.prob_lo = 0.e0 -2e-05 # physical domain, rmin zmin
-geometry.prob_hi = 2e-05 2e-05 # rmax zmax
-
-# Verbosity
-warpx.verbose = 1
-warpx.do_moving_window = 0
-warpx.moving_window_dir = z
-warpx.moving_window_v = 0.0 # in units of the speed of light
-
-# Algorithms
-algo.current_deposition = direct
-interpolation.nox = 1
-interpolation.noy = 1
-interpolation.noz = 1
-
-# CFL
-warpx.cfl = 1.0
-
-particles.nspecies = 1
-particles.species_names = electrons
-
-electrons.charge = -q_e
-electrons.mass = m_e
-electrons.injection_style = "NUniformPerCell"
-electrons.num_particles_per_cell_each_dim = 2 1 2
-
-electrons.zmax = 0.0
-
-electrons.profile = constant
-electrons.density = 1.e25 # number of electrons per m^3
-
-electrons.momentum_distribution_type = "constant"
-electrons.ux = 0.0
-electrons.uy = 0.0
-electrons.uz = 0.1
-electrons.radially_weighted = true # Only true is supported
diff --git a/Examples/Tests/Langmuir/inputs.lb b/Examples/Tests/Langmuir/inputs.lb
deleted file mode 100644
index 73ededb23..000000000
--- a/Examples/Tests/Langmuir/inputs.lb
+++ /dev/null
@@ -1,59 +0,0 @@
-# Maximum number of time steps
-max_step = 400
-max_step = 10
-
-# number of grid points
-amr.n_cell = 16 16 8
-
-# Maximum allowable size of each subdomain in the problem domain;
-# this is used to decompose the domain for parallel calculations.
-amr.max_grid_size = 8
-
-# Maximum level in hierarchy (for now must be 0, i.e., one level in total)
-amr.max_level = 0
-
-amr.plot_int = 1 # How often to write plotfiles. "<= 0" means no plotfiles.
-amr.check_int = -1 # How often to write checkpoint files. "<= 0" means no plotfiles.
-
-# Geometry
-geometry.coord_sys = 0 # 0: Cartesian
-geometry.is_periodic = 1 1 1 # Is periodic?
-geometry.prob_lo = -20.e-6 -20.e-6 -20.e-6 # physical domain
-geometry.prob_hi = 20.e-6 20.e-6 20.e-6
-
-# Verbosity
-warpx.verbose = 1
-
-warpx.do_moving_window = 0
-warpx.moving_window_dir = 0
-warpx.moving_window_v = 0.0 # in units of the speed of light
-
-# Dynamic Load Balancing
-warpx.regrid_int = 1
-
-# Algorithms
-algo.current_deposition = direct
-
-# CFL
-warpx.cfl = 1.0
-
-particles.nspecies = 1
-particles.species_names = electrons
-
-electrons.charge = -q_e
-electrons.mass = m_e
-electrons.injection_style = "NUniformPerCell"
-electrons.num_particles_per_cell_each_dim = 2 2 2
-
-electrons.xmin = -20.e-6
-electrons.xmax = 0.e-6
-electrons.ymin = -20.e-6
-electrons.ymax = 20.e-6
-electrons.zmin = -20.e-6
-electrons.zmax = 20.e-6
-
-electrons.profile = constant
-electrons.density = 1.e25 # number of electrons per m^3
-
-electrons.momentum_distribution_type = "constant"
-electrons.ux = 1.0 # ux = gamma*beta_x
diff --git a/Examples/Tests/Langmuir/inputs.nolb b/Examples/Tests/Langmuir/inputs.nolb
deleted file mode 100644
index 6ac0629cb..000000000
--- a/Examples/Tests/Langmuir/inputs.nolb
+++ /dev/null
@@ -1,59 +0,0 @@
-# Maximum number of time steps
-max_step = 400
-max_step = 10
-
-# number of grid points
-amr.n_cell = 16 16 8
-
-# Maximum allowable size of each subdomain in the problem domain;
-# this is used to decompose the domain for parallel calculations.
-amr.max_grid_size = 8
-
-# Maximum level in hierarchy (for now must be 0, i.e., one level in total)
-amr.max_level = 0
-
-amr.plot_int = 1 # How often to write plotfiles. "<= 0" means no plotfiles.
-amr.check_int = -1 # How often to write checkpoint files. "<= 0" means no plotfiles.
-
-# Geometry
-geometry.coord_sys = 0 # 0: Cartesian
-geometry.is_periodic = 1 1 1 # Is periodic?
-geometry.prob_lo = -20.e-6 -20.e-6 -20.e-6 # physical domain
-geometry.prob_hi = 20.e-6 20.e-6 20.e-6
-
-# Verbosity
-warpx.verbose = 1
-
-warpx.do_moving_window = 0
-warpx.moving_window_dir = 0
-warpx.moving_window_v = 0.0 # in units of the speed of light
-
-# Dynamic Load Balancing
-warpx.regrid_int = -1
-
-# Algorithms
-algo.current_deposition = direct
-
-# CFL
-warpx.cfl = 1.0
-
-particles.nspecies = 1
-particles.species_names = electrons
-
-electrons.charge = -q_e
-electrons.mass = m_e
-electrons.injection_style = "NUniformPerCell"
-electrons.num_particles_per_cell_each_dim = 2 2 2
-
-electrons.xmin = -20.e-6
-electrons.xmax = 0.e-6
-electrons.ymin = -20.e-6
-electrons.ymax = 20.e-6
-electrons.zmin = -20.e-6
-electrons.zmax = 20.e-6
-
-electrons.profile = constant
-electrons.density = 1.e25 # number of electrons per m^3
-
-electrons.momentum_distribution_type = "constant"
-electrons.ux = 1.0 # ux = gamma*beta_x
diff --git a/Examples/Tests/Larmor/inputs b/Examples/Tests/Larmor/inputs
deleted file mode 100644
index 9ffd6ded9..000000000
--- a/Examples/Tests/Larmor/inputs
+++ /dev/null
@@ -1,77 +0,0 @@
-# Maximum number of time steps
-max_step = 200
-
-# number of grid points
-amr.n_cell = 32 32
-
-# The lo and hi ends of grids are multipliers of blocking factor
-amr.blocking_factor = 16
-
-# Maximum allowable size of each subdomain in the problem domain;
-# this is used to decompose the domain for parallel calculations.
-amr.max_grid_size = 64
-
-# Maximum level in hierarchy (for now must be 0, i.e., one level in total)
-amr.max_level = 0
-
-warpx.fine_tag_lo = -0.8 -0.8
-warpx.fine_tag_hi = 0.8 0.8
-
-amr.plot_int = 1 # How often to write plotfiles. "<= 0" means no plotfiles.
-
-warpx.plot_raw_fields = 1
-warpx.plot_finepatch = 1
-warpx.plot_crsepatch = 1
-warpx.fields_to_plot = Ex Ey Ez Bx By Bz jx jy jz part_per_cell divE divB
-
-# Geometry
-geometry.coord_sys = 0 # 0: Cartesian
-geometry.is_periodic = 0 0 0 # Is periodic?
-geometry.prob_lo = -2.0 -2.0 # physical domain
-geometry.prob_hi = 2.0 2.0
-
-# PML
-warpx.do_pml = 1
-warpx.pml_ncell = 10
-
-warpx.B_external = 0.0 0.00078110417851950768 0.0
-
-# Verbosity
-warpx.verbose = 1
-
-# Algorithms
-
-# CFL
-warpx.cfl = 1.0
-
-# particles
-particles.nspecies = 2
-particles.species_names = electron positron
-
-particles.nspecies = 1
-particles.species_names = electron
-
-electron.charge = -q_e
-electron.mass = m_e
-electron.injection_style = "SingleParticle"
-electron.single_particle_pos = 0.0 0.0 -1.25
-electron.single_particle_vel = -0.45825756949558416 0.0 0.0 # gamma*beta
-
-positron.charge = q_e
-positron.mass = m_e
-positron.injection_style = "SingleParticle"
-positron.single_particle_pos = 0.0 0.0 -1.25
-positron.single_particle_vel = 0.45825756949558416 0.0 0.0 # gamma*beta
-
-electron.single_particle_weight = 1.0e12
-positron.single_particle_weight = 1.0e12
-
-# interpolation
-interpolation.nox = 3
-interpolation.noy = 3
-interpolation.noz = 3
-
-# Moving window
-warpx.do_moving_window = 0
-
-warpx.do_dive_cleaning = 1
diff --git a/Examples/Tests/Larmor/inputs.ml b/Examples/Tests/Larmor/inputs.mr
index f70560bd9..f70560bd9 100644
--- a/Examples/Tests/Larmor/inputs.ml
+++ b/Examples/Tests/Larmor/inputs.mr
diff --git a/Examples/Tests/laser_on_fine/inputs b/Examples/Tests/laser_on_fine/inputs
deleted file mode 100644
index 83d70e6a1..000000000
--- a/Examples/Tests/laser_on_fine/inputs
+++ /dev/null
@@ -1,73 +0,0 @@
-# Maximum number of time steps
-max_step = 500
-
-# number of grid points
-amr.n_cell = 64 64 64
-
-# The lo and hi ends of grids are multipliers of blocking factor
-amr.blocking_factor = 32
-
-# Maximum allowable size of each subdomain in the problem domain;
-# this is used to decompose the domain for parallel calculations.
-amr.max_grid_size = 64
-
-# Maximum level in hierarchy (for now must be 0, i.e., one level in total)
-amr.max_level = 1
-
-warpx.fine_tag_lo = -10.e-6 -10.e-6 -0.4e-6
-warpx.fine_tag_hi = 10.e-6 10.e-6 0.4e-6
-
-amr.plot_int = 10 # How often to write plotfiles. "<= 0" means no plotfiles.
-
-warpx.plot_raw_fields = 1
-warpx.plot_finepatch = 1
-warpx.plot_crsepatch = 1
-warpx.fields_to_plot = Ex Ey Ez Bx By Bz jx jy jz part_per_cell divB
-
-# Geometry
-geometry.coord_sys = 0 # 0: Cartesian
-geometry.is_periodic = 1 1 0 # Is periodic?
-geometry.prob_lo = -30.e-6 -30.e-6 -1.25e-6 # physical domain
-geometry.prob_hi = 30.e-6 30.e-6 1.25e-6
-
-# PML
-warpx.do_pml = 1
-warpx.pml_ncell = 10
-
-# Verbosity
-warpx.verbose = 1
-
-# Algorithms
-algo.current_deposition = esirkepov
-algo.charge_deposition = standard
-algo.field_gathering = standard
-
-# CFL
-warpx.cfl = 1.0
-particles.nspecies = 0
-
-# interpolation
-interpolation.nox = 1
-interpolation.noy = 1
-interpolation.noz = 1
-
-# Moving window
-warpx.do_moving_window = 0
-warpx.moving_window_dir = z
-warpx.moving_window_v = 1.0 # in units of the speed of light
-
-# Laser
-lasers.nlasers = 1
-lasers.names = laser1
-laser1.prob_lo = -12.e-6 -12.e-6 -5.e-6
-laser1.prob_hi = 12.e-6 12.e-6 5.e-6
-laser1.profile = Gaussian
-laser1.position = 0. 0. 0.e-6 # This point is on the laser plane
-laser1.direction = 0. 0. 1. # The plane normal direction
-laser1.polarization = 1. 0. 0. # The main polarization vector
-laser1.e_max = 16.e12 # Maximum amplitude of the laser field (in V/m)
-laser1.profile_waist = 3.e-6 # The waist of the laser (in meters)
-laser1.profile_duration = 15.e-15 # The duration of the laser (in seconds)
-laser1.profile_t_peak = 30.e-15 # The time at which the laser reaches its peak (in seconds)
-laser1.profile_focal_distance = 100.e-6 # Focal distance from the antenna (in meters)
-laser1.wavelength = 0.8e-6 # The wavelength of the laser (in meters)
diff --git a/Examples/Tests/laser_on_fine/inputs.2d b/Examples/Tests/laser_on_fine/inputs.2d
index 6919bac64..50a97a58a 100644
--- a/Examples/Tests/laser_on_fine/inputs.2d
+++ b/Examples/Tests/laser_on_fine/inputs.2d
@@ -2,7 +2,7 @@
max_step = 500
# number of grid points
-amr.n_cell = 64 64 64
+amr.n_cell = 64 64
# The lo and hi ends of grids are multipliers of blocking factor
amr.blocking_factor = 32
diff --git a/Regression/WarpX-tests.ini b/Regression/WarpX-tests.ini
index 66629d167..0c57c5a9e 100644
--- a/Regression/WarpX-tests.ini
+++ b/Regression/WarpX-tests.ini
@@ -445,7 +445,7 @@ particleTypes = electrons ions
analysisRoutine = Examples/Tests/Langmuir/analysis_langmuir_multi_rz.py
analysisOutputImage = langmuir_multi_rz_analysis.png
-[Langmuir_rz_multimode]
+[Python_Langmuir_rz_multimode]
buildDir = .
inputFile = Examples/Tests/Langmuir/PICMI_inputs_langmuir_rz_multimode_analyze.py
customRunCmd = python PICMI_inputs_langmuir_rz_multimode_analyze.py
@@ -662,3 +662,229 @@ compileTest = 0
doVis = 0
compareParticles = 0
analysisRoutine = Examples/Modules/qed/quantum_synchrotron/analysis_2d_tau_init.py
+
+[Python_gaussian_beam]
+buildDir = .
+inputFile = Examples/Modules/gaussian_beam/PICMI_inputs_gaussian_beam.py
+customRunCmd = python PICMI_inputs_gaussian_beam.py
+dim = 3
+addToCompileString = USE_PYTHON_MAIN=TRUE
+restartTest = 0
+useMPI = 1
+numprocs = 2
+useOMP = 1
+numthreads = 1
+compileTest = 0
+doVis = 0
+compareParticles = 1
+particleTypes = electrons
+
+[PlasmaAccelerationBoost]
+buildDir = .
+inputFile = Examples/Physics_applications/plasma_acceleration/inputs.2d.boost
+runtime_params = warpx.do_dynamic_scheduling=0 warpx.serialize_ics=1 amr.n_cell=64 256 max_step=20
+dim = 2
+addToCompileString =
+restartTest = 0
+useMPI = 1
+numprocs = 2
+useOMP = 1
+numthreads = 2
+compileTest = 0
+doVis = 0
+
+[Python_PlasmaAcceleration]
+buildDir = .
+inputFile = Examples/Physics_applications/plasma_acceleration/PICMI_inputs_plasma_acceleration.py
+customRunCmd = python PICMI_inputs_plasma_acceleration.py
+dim = 3
+addToCompileString = USE_PYTHON_MAIN=TRUE
+restartTest = 0
+useMPI = 1
+numprocs = 2
+useOMP = 1
+numthreads = 1
+compileTest = 0
+doVis = 0
+compareParticles = 1
+particleTypes = beam
+
+[Python_PlasmaAccelerationMR]
+buildDir = .
+inputFile = Examples/Physics_applications/plasma_acceleration/PICMI_inputs_plasma_acceleration_mr.py
+customRunCmd = python PICMI_inputs_plasma_acceleration_mr.py
+dim = 3
+addToCompileString = USE_PYTHON_MAIN=TRUE
+restartTest = 0
+useMPI = 1
+numprocs = 2
+useOMP = 1
+numthreads = 1
+compileTest = 0
+doVis = 0
+compareParticles = 1
+particleTypes = beam
+
+[PlasmaAccelerationBoost]
+buildDir = .
+inputFile = Examples/Physics_applications/plasma_acceleration/inputs.3d.boost
+runtime_params = warpx.do_dynamic_scheduling=0 warpx.serialize_ics=1 amr.n_cell=64 256 max_step=5
+dim = 3
+addToCompileString =
+restartTest = 0
+useMPI = 1
+numprocs = 2
+useOMP = 1
+numthreads = 2
+compileTest = 0
+doVis = 0
+
+[PlasmaMirror]
+buildDir = .
+inputFile = Examples/Physics_applications/plasma_mirror/inputs.2d
+runtime_params = warpx.do_dynamic_scheduling=0 warpx.serialize_ics=1 amr.n_cell=256 128 max_step=20
+dim = 2
+addToCompileString =
+restartTest = 0
+useMPI = 1
+numprocs = 2
+useOMP = 1
+numthreads = 2
+compileTest = 0
+doVis = 0
+
+[LaserAccelerationRZ]
+buildDir = .
+inputFile = Examples/Physics_applications/laser_acceleration/inputs.rz
+runtime_params = max_step=10
+dim = 2
+addToCompileString = USE_RZ=TRUE
+restartTest = 0
+useMPI = 1
+numprocs = 4
+useOMP = 1
+numthreads = 1
+compileTest = 0
+doVis = 0
+runtime_params = electrons.plot_vars=w ux uy uz Ex Ey Ez Bx By beam.plot_vars=w ux uy uz Ex Ey Ez Bx By
+compareParticles = 1
+particleTypes = electrons beam
+
+[Python_LaserAccelerationMR]
+buildDir = .
+inputFile = Examples/Physics_applications/laser_acceleration/PICMI_inputs_laser_acceleration.py
+customRunCmd = python PICMI_inputs_laser_acceleration.py
+dim = 3
+addToCompileString = USE_PYTHON_MAIN=TRUE
+restartTest = 0
+useMPI = 1
+numprocs = 2
+useOMP = 1
+numthreads = 1
+compileTest = 0
+doVis = 0
+compareParticles = 1
+particleTypes = electrons
+
+[SelfForceElectrostatic]
+buildDir = .
+inputFile = Examples/Tests/self_force_test/inputs
+runtime_params = max_step=10
+dim = 3
+addToCompileString = DO_ELECTROSTATIC=TRUE
+restartTest = 0
+useMPI = 1
+numprocs = 4
+useOMP = 1
+numthreads = 1
+compileTest = 0
+doVis = 0
+
+[Langmuir_RZ]
+buildDir = .
+inputFile = Examples/Physics_applications/laser_acceleration/inputs.rz
+runtime_params = max_step=10
+dim = 2
+addToCompileString = USE_RZ=TRUE
+restartTest = 0
+useMPI = 1
+numprocs = 4
+useOMP = 1
+numthreads = 1
+compileTest = 0
+doVis = 0
+runtime_params = electrons.plot_vars=w ux uy uz Ex Ey Ez Bx By beam.plot_vars=w ux uy uz Ex Ey Ez Bx By
+compareParticles = 1
+particleTypes = electrons beam
+
+[Python_Langmuir_2d]
+buildDir = .
+inputFile = Examples/Tests/Langmuir/PICMI_inputs_langmuir2d.py
+customRunCmd = python PICMI_inputs_langmuir2d.py
+dim = 2
+addToCompileString = USE_PYTHON_MAIN=TRUE
+restartTest = 0
+useMPI = 1
+numprocs = 2
+useOMP = 1
+numthreads = 1
+compileTest = 0
+doVis = 0
+compareParticles = 1
+particleTypes = electrons
+
+[Python_Langmuir_rz_multimode]
+buildDir = .
+inputFile = Examples/Tests/Langmuir/PICMI_inputs_langmuir_rz.py
+customRunCmd = python PICMI_inputs_langmuir_rz.py
+dim = 2
+addToCompileString = USE_PYTHON_MAIN=TRUE USE_RZ=TRUE
+restartTest = 0
+useMPI = 1
+numprocs = 4
+useOMP = 1
+numthreads = 1
+compileTest = 0
+doVis = 0
+
+[GPU_inputs]
+buildDir = .
+inputFile = Examples/Tests/gpu_test/inputs
+runtime_params = warpx.do_dynamic_scheduling=0 warpx.serialize_ics=1
+dim = 3
+addToCompileString =
+restartTest = 0
+useMPI = 1
+numprocs = 2
+useOMP = 1
+numthreads = 2
+compileTest = 0
+doVis = 0
+
+[LaserOnFine]
+buildDir = .
+inputFile = Examples/Tests/laser_on_fine/inputs.2d
+runtime_params = max_step=50
+dim = 2
+addToCompileString =
+restartTest = 0
+useMPI = 1
+numprocs = 2
+useOMP = 1
+numthreads = 2
+compileTest = 0
+doVis = 0
+
+[Larmor]
+buildDir = .
+inputFile = Examples/Tests/Larmor/inputs.mr
+runtime_params = max_step=10
+dim = 2
+addToCompileString =
+restartTest = 0
+useMPI = 1
+numprocs = 2
+useOMP = 1
+numthreads = 2
+compileTest = 0
+doVis = 0