WarpX
WarpX Member List

This is the complete list of members for WarpX, including all inherited members.

AddBoundaryField()WarpX
AddCurrentFromFineLevelandSumBoundary(const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &J_fp, const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &J_cp, const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &J_buffer, int lev)WarpXprivate
AddExternalFields()WarpXprivate
AddMagnetostaticFieldLabFrame()WarpX
AddRhoFromFineLevelandSumBoundary(const amrex::Vector< std::unique_ptr< amrex::MultiFab >> &charge_fp, const amrex::Vector< std::unique_ptr< amrex::MultiFab >> &charge_cp, const amrex::Vector< std::unique_ptr< amrex::MultiFab >> &charge_buffer, int lev, int icomp, int ncomp)WarpXprivate
AddSpaceChargeField(WarpXParticleContainer &pc)WarpX
AddSpaceChargeFieldLabFrame()WarpX
AliasInitMultiFab(std::unique_ptr< amrex::MultiFab > &mf, const amrex::MultiFab &mf_to_alias, int scomp, int ncomp, int level, const std::string &name, std::optional< const amrex::Real > initial_value)WarpXstatic
AllocateCenteringCoefficients(amrex::Gpu::DeviceVector< amrex::Real > &device_centering_stencil_coeffs_x, amrex::Gpu::DeviceVector< amrex::Real > &device_centering_stencil_coeffs_y, amrex::Gpu::DeviceVector< amrex::Real > &device_centering_stencil_coeffs_z, int centering_nox, int centering_noy, int centering_noz, short a_grid_type)WarpXprivate
AllocInitMultiFab(std::unique_ptr< amrex::MultiFab > &mf, const amrex::BoxArray &ba, const amrex::DistributionMapping &dm, int ncomp, const amrex::IntVect &ngrow, int level, const std::string &name, std::optional< const amrex::Real > initial_value={})WarpXstatic
AllocInitMultiFab(std::unique_ptr< amrex::iMultiFab > &mf, const amrex::BoxArray &ba, const amrex::DistributionMapping &dm, int ncomp, const amrex::IntVect &ngrow, int level, const std::string &name, std::optional< const int > initial_value={})WarpXstatic
AllocInitMultiFabFromModel(std::unique_ptr< amrex::MultiFab > &mf, amrex::MultiFab &mf_model, int level, const std::string &name, std::optional< const amrex::Real > initial_value={})WarpXstatic
AllocLevelData(int lev, const amrex::BoxArray &ba, const amrex::DistributionMapping &dm)WarpXprivate
AllocLevelMFs(int lev, const amrex::BoxArray &ba, const amrex::DistributionMapping &dm, const amrex::IntVect &ngEB, amrex::IntVect &ngJ, const amrex::IntVect &ngRho, const amrex::IntVect &ngF, const amrex::IntVect &ngG, bool aux_is_nodal)WarpXprivate
AllocLevelSpectralSolverRZ(amrex::Vector< std::unique_ptr< SpectralSolverRZ >> &spectral_solver, int lev, const amrex::BoxArray &realspace_ba, const amrex::DistributionMapping &dm, const std::array< amrex::Real, 3 > &dx)WarpXprivate
AmrCore()amrex::AmrCore
AmrCore(const RealBox *rb, int max_level_in, const Vector< int > &n_cell_in, int coord=-1, Vector< IntVect > ref_ratios=Vector< IntVect >(), const int *is_per=nullptr)amrex::AmrCore
AmrCore(const RealBox &rb, int max_level_in, const Vector< int > &n_cell_in, int coord, Vector< IntVect > const &ref_ratios, Array< int, AMREX_SPACEDIM > const &is_per)amrex::AmrCore
AmrCore(Geometry const &level_0_geom, AmrInfo const &amr_info)amrex::AmrCore
AmrCore(AmrCore &&rhs) noexceptamrex::AmrCore
AmrCore(const AmrCore &rhs)=deleteamrex::AmrCore
AmrMesh()amrex::AmrMesh
AmrMesh(const RealBox *rb, int max_level_in, const Vector< int > &n_cell_in, int coord=-1, Vector< IntVect > refrat=Vector< IntVect >(), const int *is_per=nullptr)amrex::AmrMesh
AmrMesh(const RealBox &rb, int max_level_in, const Vector< int > &n_cell_in, int coord, Vector< IntVect > const &a_refrat, Array< int, AMREX_SPACEDIM > const &is_per)amrex::AmrMesh
AmrMesh(Geometry const &level_0_geom, AmrInfo const &amr_info)amrex::AmrMesh
AmrMesh(const AmrMesh &rhs)=deleteamrex::AmrMesh
AmrMesh(AmrMesh &&rhs)=defaultamrex::AmrMesh
ApplyBCKCorrection(int idim)WarpX
ApplyBfieldBoundary(int lev, PatchType patch_type, DtType dt_type)WarpX
ApplyEfieldBoundary(int lev, PatchType patch_type)WarpX
ApplyElectronPressureBoundary(int lev, PatchType patch_type)WarpX
ApplyFieldBoundaryOnAxis(amrex::MultiFab *Er, amrex::MultiFab *Et, amrex::MultiFab *Ez, int lev) constWarpX
ApplyFilterandSumBoundaryRho(int lev, int glev, amrex::MultiFab &rho, int icomp, int ncomp)WarpX
ApplyFilterandSumBoundaryRho(const amrex::Vector< std::unique_ptr< amrex::MultiFab >> &charge_fp, const amrex::Vector< std::unique_ptr< amrex::MultiFab >> &charge_cp, int lev, PatchType patch_type, int icomp, int ncomp)WarpXprivate
ApplyFilterJ(const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &current, int lev, int idim)WarpXprivate
ApplyFilterJ(const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &current, int lev)WarpXprivate
ApplyInverseVolumeScalingToChargeDensity(amrex::MultiFab *Rho, int lev)WarpX
ApplyInverseVolumeScalingToCurrentDensity(amrex::MultiFab *Jx, amrex::MultiFab *Jy, amrex::MultiFab *Jz, int lev)WarpX
ApplyJfieldBoundary(int lev, amrex::MultiFab *Jx, amrex::MultiFab *Jy, amrex::MultiFab *Jz, PatchType patch_type)WarpX
applyMirrors(amrex::Real time)WarpX
ApplyRhofieldBoundary(int lev, amrex::MultiFab *Rho, PatchType patch_type)WarpX
AverageAndPackFields(amrex::Vector< std::string > &varnames, amrex::Vector< amrex::MultiFab > &mf_avg, amrex::IntVect ngrow) constWarpX
BackwardCompatibility()WarpXprivate
beta_boostWarpXstatic
Bfield_auxWarpXprivate
Bfield_avg_cpWarpXprivate
Bfield_avg_fpWarpXprivate
Bfield_caxWarpXprivate
Bfield_cpWarpXprivate
Bfield_fpWarpXprivate
Bfield_fp_externalWarpXprivate
Bfield_nWarpXprivate
Bfield_saveWarpXprivate
Bfield_sliceWarpXprivate
bilinear_filterWarpX
blocking_factoramrex::AmrInfoprotected
blockingFactor(int lev) const noexceptamrex::AmrMesh
boost_directionWarpXstatic
boxArray() const noexceptamrex::AmrMesh
boxArray(int lev) const noexceptamrex::AmrMesh
boxArray(int a_coarsest_lev, int a_finest_lev) const noexceptamrex::AmrMesh
BuildBufferMasks()WarpXprivate
BuildBufferMasksInBox(amrex::Box tbx, amrex::IArrayBox &buffer_mask, const amrex::IArrayBox &guard_mask, int ng)WarpX
CellSize(int lev)WarpXstatic
cflWarpXprivate
charge_bufWarpXprivate
charge_deposition_algoWarpXstatic
check_inputamrex::AmrInfoprotected
checkEarlyUnusedParams()WarpXprivate
CheckGuardCells()WarpXprivate
checkInput()amrex::AmrMeshprotected
CheckKnownIssues()WarpXprivate
CheckLoadBalance(int step)WarpX
checkStopSimulation(amrex::Real cur_time)WarpXprivate
ChopGrids(int lev, BoxArray &ba, int target_size) constamrex::AmrMesh
ClearBoxArray(int lev) noexceptamrex::AmrMesh
ClearDistributionMap(int lev) noexceptamrex::AmrMesh
ClearLevel(int lev) finalWarpXprotectedvirtual
compute_max_step_from_btdWarpXstatic
computeB(amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 > > &B, const amrex::Vector< std::unique_ptr< amrex::MultiFab > > &phi, std::array< amrex::Real, 3 > beta={{0, 0, 0}}) constWarpX
ComputeCostsHeuristic(amrex::Vector< std::unique_ptr< amrex::LayoutData< amrex::Real > > > &costs)WarpX
ComputeDistanceToEB()WarpX
ComputeDivB(amrex::MultiFab &divB, int dcomp, const std::array< const amrex::MultiFab *const, 3 > &B, const std::array< amrex::Real, 3 > &dx)WarpXstatic
ComputeDivB(amrex::MultiFab &divB, int dcomp, const std::array< const amrex::MultiFab *const, 3 > &B, const std::array< amrex::Real, 3 > &dx, amrex::IntVect ngrow)WarpXstatic
ComputeDivE(amrex::MultiFab &divE, int lev)WarpX
ComputeDt()WarpX
computeE(amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 > > &E, const amrex::Vector< std::unique_ptr< amrex::MultiFab > > &phi, std::array< amrex::Real, 3 > beta={{0, 0, 0}}) constWarpX
ComputeEightWaysExtensions()WarpX
ComputeFaceExtensions()WarpX
ComputeMagnetostaticField()WarpX
ComputeMaxStep()WarpX
computeMaxStepBoostAccelerator()WarpX
ComputeOneWayExtensions()WarpX
computePhi(const amrex::Vector< std::unique_ptr< amrex::MultiFab > > &rho, amrex::Vector< std::unique_ptr< amrex::MultiFab > > &phi, std::array< amrex::Real, 3 > beta={{0, 0, 0}}, amrex::Real required_precision=amrex::Real(1.e-11), amrex::Real absolute_tolerance=amrex::Real(0.0), int max_iters=200, int verbosity=2) constWarpX
computePhiTriDiagonal(const amrex::Vector< std::unique_ptr< amrex::MultiFab > > &rho, amrex::Vector< std::unique_ptr< amrex::MultiFab > > &phi) constWarpX
ComputePMLFactors()WarpXprivate
ComputeSpaceChargeField(bool reset_fields)WarpX
computeVectorPotential(const amrex::Vector< amrex::Array< std::unique_ptr< amrex::MultiFab >, 3 > > &curr, amrex::Vector< amrex::Array< std::unique_ptr< amrex::MultiFab >, 3 > > &A, amrex::Real required_precision=amrex::Real(1.e-11), amrex::Real absolute_tolerance=amrex::Real(0.0), int max_iters=200, int verbosity=2) constWarpX
CopyJPML()WarpX
costsWarpXprivate
costs_heuristic_cells_wtWarpXprivate
costs_heuristic_particles_wtWarpXprivate
CountCells(int lev) noexceptamrex::AmrMesh
CountExtFaces()WarpX
current_bufWarpXprivate
current_buffer_masksWarpXprivate
current_centering_noxWarpXstatic
current_centering_noyWarpXstatic
current_centering_nozWarpXstatic
current_correctionWarpX
current_cpWarpXprivate
current_deposition_algoWarpXstatic
current_fpWarpXprivate
current_fp_nodalWarpXprivate
current_fp_vayWarpXprivate
current_sliceWarpXprivate
current_storeWarpXprivate
CurrentBufferMasks(int lev)WarpXstatic
DampFieldsInGuards(int lev, const std::array< std::unique_ptr< amrex::MultiFab >, 3 > &Efield, const std::array< std::unique_ptr< amrex::MultiFab >, 3 > &Bfield)WarpX
DampFieldsInGuards(int lev, std::unique_ptr< amrex::MultiFab > &mf)WarpX
DampJPML()WarpX
DampJPML(int lev)WarpX
DampJPML(int lev, PatchType patch_type)WarpX
DampPML()WarpX
DampPML(int lev)WarpX
DampPML(int lev, PatchType patch_type)WarpX
DampPML_Cartesian(int lev, PatchType patch_type)WarpX
device_current_centering_stencil_coeffs_xWarpX
device_current_centering_stencil_coeffs_yWarpX
device_current_centering_stencil_coeffs_zWarpX
device_field_centering_stencil_coeffs_xWarpX
device_field_centering_stencil_coeffs_yWarpX
device_field_centering_stencil_coeffs_zWarpX
DistributionMap() const noexceptamrex::AmrMesh
DistributionMap(int lev) const noexceptamrex::AmrMesh
DistributionMap(int a_coarsest_lev, int a_finest_lev) const noexceptamrex::AmrMesh
dmapamrex::AmrMeshprotected
do_compute_max_step_from_zmaxWarpXstatic
do_current_centeringWarpXstatic
do_device_synchronizeWarpXstatic
do_divb_cleaningWarpXstatic
do_dive_cleaningWarpXstatic
do_dynamic_schedulingWarpXstatic
do_fluid_speciesWarpXprivate
do_moving_windowWarpXstatic
do_multi_JWarpXstatic
do_multi_J_n_depositionsWarpXstatic
do_pmlWarpXprivate
do_pml_divb_cleaningWarpXprivate
do_pml_dive_cleaningWarpXprivate
do_pml_HiWarpXprivate
do_pml_in_domainWarpXprivate
do_pml_j_dampingWarpXprivate
do_pml_LoWarpXprivate
do_shared_mem_charge_depositionWarpXstatic
do_shared_mem_current_depositionWarpXstatic
do_silver_muellerWarpXprivate
do_similar_dm_pmlWarpXprivate
do_single_precision_commsWarpXstatic
do_subcyclingWarpXstatic
doFieldIonization()WarpX
doFieldIonization(int lev)WarpX
DoFluidSpecies() constWarpXinline
DoPML() constWarpXinline
doQEDEvents()WarpX
doQEDEvents(int lev)WarpX
dtWarpXprivate
ECTRhofieldWarpXprivate
Efield_auxWarpXprivate
Efield_avg_cpWarpXprivate
Efield_avg_fpWarpXprivate
Efield_caxWarpXprivate
Efield_cpWarpXprivate
Efield_fpWarpXprivate
Efield_fp_externalWarpXprivate
Efield_nWarpXprivate
Efield_saveWarpXprivate
Efield_sliceWarpXprivate
electromagnetic_solver_idWarpXstatic
electrostatic_solver_idWarpXstatic
em_solver_mediumWarpXstatic
end_moving_window_stepWarpXstatic
ErrorEst(int lev, amrex::TagBoxArray &tags, amrex::Real time, int) finalWarpX
amrex::AmrCore::ErrorEst(int lev, TagBoxArray &tags, Real time, int ngrow) override=0amrex::AmrCoreprotectedpure virtual
Evolve(int numsteps=-1)WarpX
evolve_schemeWarpXstatic
EvolveB(amrex::Real dt, DtType dt_type)WarpX
EvolveB(int lev, amrex::Real dt, DtType dt_type)WarpX
EvolveB(int lev, PatchType patch_type, amrex::Real dt, DtType dt_type)WarpX
EvolveE(amrex::Real dt)WarpX
EvolveE(int lev, amrex::Real dt)WarpX
EvolveE(int lev, PatchType patch_type, amrex::Real dt)WarpX
EvolveF(amrex::Real dt, DtType dt_type)WarpX
EvolveF(int lev, amrex::Real dt, DtType dt_type)WarpX
EvolveF(int lev, PatchType patch_type, amrex::Real dt, DtType dt_type)WarpX
EvolveG(amrex::Real dt, DtType dt_type)WarpX
EvolveG(int lev, amrex::Real dt, DtType dt_type)WarpX
EvolveG(int lev, PatchType patch_type, amrex::Real dt, DtType dt_type)WarpX
EvolveImplicitPicardInit(int lev)WarpX
ExplicitFillBoundaryEBUpdateAux()WarpXprivate
F_cpWarpXprivate
F_fpWarpXprivate
F_sliceWarpXprivate
fft_do_time_averagingWarpXstatic
fft_periodic_single_boxWarpXprivate
field_boundary_hiWarpXstatic
field_boundary_loWarpXstatic
field_centering_noxWarpXstatic
field_centering_noyWarpXstatic
field_centering_nozWarpXstatic
field_gathering_algoWarpXstatic
field_io_nfilesWarpXprivate
fieldFactory(int lev) const noexceptWarpXinlineprivate
FillBoundaryAux(amrex::IntVect ng)WarpX
FillBoundaryAux(int lev, amrex::IntVect ng)WarpX
FillBoundaryB(amrex::IntVect ng, std::optional< bool > nodal_sync=std::nullopt)WarpX
FillBoundaryB(int lev, amrex::IntVect ng, std::optional< bool > nodal_sync=std::nullopt)WarpX
FillBoundaryB(int lev, PatchType patch_type, amrex::IntVect ng, std::optional< bool > nodal_sync=std::nullopt)WarpXprivate
FillBoundaryB_avg(amrex::IntVect ng)WarpX
FillBoundaryB_avg(int lev, amrex::IntVect ng)WarpX
FillBoundaryB_avg(int lev, PatchType patch_type, amrex::IntVect ng)WarpXprivate
FillBoundaryE(amrex::IntVect ng, std::optional< bool > nodal_sync=std::nullopt)WarpX
FillBoundaryE(int lev, amrex::IntVect ng, std::optional< bool > nodal_sync=std::nullopt)WarpX
FillBoundaryE(int lev, PatchType patch_type, amrex::IntVect ng, std::optional< bool > nodal_sync=std::nullopt)WarpXprivate
FillBoundaryE_avg(amrex::IntVect ng)WarpX
FillBoundaryE_avg(int lev, amrex::IntVect ng)WarpX
FillBoundaryE_avg(int lev, PatchType patch_type, amrex::IntVect ng)WarpXprivate
FillBoundaryF(amrex::IntVect ng, std::optional< bool > nodal_sync=std::nullopt)WarpX
FillBoundaryF(int lev, amrex::IntVect ng, std::optional< bool > nodal_sync=std::nullopt)WarpX
FillBoundaryF(int lev, PatchType patch_type, amrex::IntVect ng, std::optional< bool > nodal_sync=std::nullopt)WarpXprivate
FillBoundaryG(amrex::IntVect ng, std::optional< bool > nodal_sync=std::nullopt)WarpX
FillBoundaryG(int lev, amrex::IntVect ng, std::optional< bool > nodal_sync=std::nullopt)WarpX
FillBoundaryG(int lev, PatchType patch_type, amrex::IntVect ng, std::optional< bool > nodal_sync=std::nullopt)WarpXprivate
filter_npass_each_dirWarpXstatic
Finalize()WarpXstatic
fine_tag_hiWarpXprivate
fine_tag_loWarpXprivate
finest_levelamrex::AmrMeshprotected
finestLevel() const noexceptamrex::AmrMesh
FinishImplicitFieldUpdate(amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 > > &Efield_fp, amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 > > &Efield_n)WarpX
FinishImplicitParticleUpdate(WarpXParticleContainer &pc, int lev)WarpX
G_cpWarpXprivate
G_fpWarpXprivate
G_sliceWarpXprivate
galerkin_interpolationWarpXstatic
gamma_boostWarpXstatic
gather_buffer_masksWarpXprivate
GatherBufferMasks(int lev)WarpXstatic
geomamrex::AmrMeshprotected
Geom() const noexceptamrex::AmrMesh
Geom(int lev) const noexceptamrex::AmrMesh
Geom(int a_coarsest_lev, int a_finest_lev) const noexceptamrex::AmrMesh
Geom() noexceptamrex::AmrMesh
Geom(int lev) noexceptamrex::AmrMesh
get_accelerator_lattice(int lev)WarpXinline
get_load_balance_intervals() constWarpXinline
get_ng_depos_J() constWarpXinline
get_ng_depos_rho() constWarpXinline
get_ng_fieldgather() constWarpXinline
get_numprocs() constWarpXinline
get_pointer_fdtd_solver_fp(int lev)WarpXinline
get_pointer_HybridPICModel() constWarpXinline
get_spectral_solver_fp(int lev)WarpXinline
GetAreaNotToTag(int)amrex::AmrMeshvirtual
GetAuthors() constWarpXinline
getCosts(int lev)WarpXstatic
getCurrentBufferMasks(int lev) constWarpXinlineprivate
getdo_moving_window() constWarpXinline
getdt() constWarpXinline
getdt(int lev) constWarpXinline
getField(warpx::fields::FieldType field_type, int lev, int direction=0) constWarpX
getFieldPointer(warpx::fields::FieldType field_type, int lev, int direction=0) constWarpX
getFieldPointerArray(warpx::fields::FieldType field_type, int lev) constWarpX
getFieldPointerUnchecked(warpx::fields::FieldType field_type, int lev, int direction=0) constWarpXprivate
GetFluidContainer()WarpXinline
getFornbergStencilCoefficients(int n_order, short a_grid_type)WarpXstatic
getGatherBufferMasks(int lev) constWarpXinlineprivate
GetHybridPICModel()WarpXinline
GetInstance()WarpXstatic
getis_synchronized() constWarpXinline
getistep() constWarpXinline
getistep(int lev) constWarpXinline
GetLevel(Box const &domain) noexceptamrex::AmrMesh
getLoadBalanceEfficiency(int lev)WarpX
GetMacroscopicProperties()WarpXinline
getmoving_window_x() constWarpXinline
GetMultiDiags()WarpXinline
getngEB() constWarpXinline
getngF() constWarpXinline
getngUpdateAux() constWarpXinline
getnsubsteps() constWarpXinline
getnsubsteps(int lev) constWarpXinline
GetPartContainer()WarpXinline
GetParticleBoundaryBuffer()WarpXinline
GetPML(int lev)WarpX
GetPML_RZ(int lev)WarpX
getPMLdirections() constWarpX
getPMLRZ()WarpXinline
getRealBox(const amrex::Box &bx, int lev)WarpXstatic
GetRestartDMap(const std::string &chkfile, const amrex::BoxArray &ba, int lev) constWarpXprivate
gett_new() constWarpXinline
gett_new(int lev) constWarpXinline
gett_old() constWarpXinline
gett_old(int lev) constWarpXinline
grid_effamrex::AmrInfoprotected
grid_typeWarpXstatic
gridEff() const noexceptamrex::AmrMesh
gridsamrex::AmrMeshprotected
guard_cellsWarpXprivate
HandleParticlesAtBoundaries(int step, amrex::Real cur_time, int num_moved)WarpXprivate
HandleSignals()WarpXprivate
Hybrid_QED_Push(amrex::Vector< amrex::Real > dt)WarpX
Hybrid_QED_Push(int lev, amrex::Real dt)WarpX
Hybrid_QED_Push(int lev, PatchType patch_type, amrex::Real dt)WarpX
HybridPICDepositInitialRhoAndJ()WarpX
HybridPICEvolveFields()WarpX
imultifab_mapWarpXstatic
InitAmrCore()amrex::AmrCoreprivate
InitAmrMesh(int max_level_in, const Vector< int > &n_cell_in, Vector< IntVect > refrat=Vector< IntVect >(), const RealBox *rb=nullptr, int coord=-1, const int *is_per=nullptr)amrex::AmrMeshprivate
InitBorrowing()WarpX
InitData()WarpX
InitDiagnostics()WarpXprivate
InitEB()WarpX
InitFilter()WarpXprivate
InitFromCheckpoint()WarpXprivate
InitFromScratch()WarpXprivate
amrex::AmrCore::InitFromScratch(Real time)amrex::AmrCore
InitializeEBGridData(int lev)WarpX
InitializeExternalFieldsOnGridUsingParser(amrex::MultiFab *mfx, amrex::MultiFab *mfy, amrex::MultiFab *mfz, amrex::ParserExecutor< 3 > const &xfield_parser, amrex::ParserExecutor< 3 > const &yfield_parser, amrex::ParserExecutor< 3 > const &zfield_parser, std::array< std::unique_ptr< amrex::MultiFab >, 3 > const &edge_lengths, std::array< std::unique_ptr< amrex::MultiFab >, 3 > const &face_areas, char field, int lev, PatchType patch_type)WarpX
InitLevelData(int lev, amrex::Real time)WarpXprotected
InitNCICorrector()WarpXprivate
InitPML()WarpXprivate
injected_plasma_speciesWarpXprivate
is_synchronizedWarpXprivate
isAnyBoundaryPML()WarpX
isAnyParticleBoundaryThermal()WarpXstatic
isFieldInitialized(warpx::fields::FieldType field_type, int lev, int direction=0) constWarpX
istepWarpXprivate
iterate_on_new_gridsamrex::AmrInfoprotected
J_in_timeWarpXstatic
LevelDefined(int lev) noexceptamrex::AmrMesh
load_balance_costs_update_algoWarpXstatic
load_balance_efficiencyWarpXprivate
load_balance_efficiency_ratio_thresholdWarpXprivate
load_balance_intervalsWarpXprivate
load_balance_knapsack_factorWarpXprivate
load_balance_with_sfcWarpXprivate
LoadBalance()WarpX
LoadExternalFieldsFromFile(int lev)WarpX
LowerCorner(const amrex::Box &bx, int lev, amrex::Real time_shift_delta)WarpXstatic
m_accelerator_latticeWarpXprivate
m_area_modWarpXprivate
m_authorsWarpXprivate
m_borrowingWarpXprivate
m_boundary_potential_specifiedWarpX
m_const_dtWarpXprivate
m_distance_to_ebWarpXprivate
m_edge_lengthsWarpXprivate
m_exit_loop_due_to_interrupt_signalWarpXprivate
m_face_areasWarpXprivate
m_fdtd_solver_cpWarpXprivate
m_fdtd_solver_fpWarpXprivate
m_field_factoryWarpXprivate
m_fill_guards_currentWarpXstatic
m_fill_guards_fieldsWarpXstatic
m_flag_ext_faceWarpXprivate
m_flag_info_faceWarpXprivate
m_galilean_shiftWarpX
m_hybrid_pic_modelWarpXprivate
m_instanceWarpXprivatestatic
m_macroscopic_propertiesWarpXprivate
m_p_ext_field_paramsWarpXprivate
m_particle_boundary_bufferWarpXprivate
m_poisson_boundary_handlerWarpX
m_rho_nodal_flagWarpX
m_v_comovingWarpX
m_v_galileanWarpX
m_vector_poisson_boundary_handlerWarpX
macroscopic_solver_algoWarpXstatic
MacroscopicEvolveE(amrex::Real dt)WarpX
MacroscopicEvolveE(int lev, amrex::Real dt)WarpX
MacroscopicEvolveE(int lev, PatchType patch_type, amrex::Real dt)WarpX
MakeBaseGrids() constamrex::AmrMesh
MakeDistributionMap(int lev, BoxArray const &ba)amrex::AmrMeshvirtual
MakeNewGrids(int lbase, Real time, int &new_finest, Vector< BoxArray > &new_grids)amrex::AmrMesh
MakeNewGrids(Real time=0.0)amrex::AmrMesh
MakeNewLevelFromCoarse(int, amrex::Real, const amrex::BoxArray &, const amrex::DistributionMapping &) finalWarpXprotected
amrex::AmrCore::MakeNewLevelFromCoarse(int lev, Real time, const BoxArray &ba, const DistributionMapping &dm)=0amrex::AmrCoreprotectedpure virtual
MakeNewLevelFromScratch(int lev, amrex::Real time, const amrex::BoxArray &new_grids, const amrex::DistributionMapping &new_dmap) finalWarpXprotected
amrex::AmrCore::MakeNewLevelFromScratch(int lev, Real time, const BoxArray &ba, const DistributionMapping &dm) override=0amrex::AmrCoreprotectedpure virtual
MakeWarpX()WarpXprivatestatic
ManualTagsPlacement(int, TagBoxArray &, const Vector< IntVect > &)amrex::AmrMeshvirtual
max_grid_sizeamrex::AmrInfoprotected
max_levelamrex::AmrInfoprotected
max_picard_iterationsWarpXstatic
max_stepWarpXprivate
maxGridSize(int lev) const noexceptamrex::AmrMesh
maxLevel() const noexceptamrex::AmrMesh
maxlevel_extEMfield_initWarpX
MaxRefRatio(int lev) const noexceptamrex::AmrMesh
maxStep() constWarpXinline
mffile_nstreamsWarpXprivate
mirror_zWarpX
mirror_z_npointsWarpX
mirror_z_widthWarpX
MoveWindow(int step, bool move_j)WarpX
moving_window_active(int const step)WarpXinlinestatic
moving_window_dirWarpXstatic
moving_window_vWarpXstatic
moving_window_xWarpXprivate
multi_diagsWarpXprivate
multifab_mapWarpXstatic
myflWarpXprivate
mypcWarpXprivate
n_current_deposition_bufferWarpXstatic
n_error_bufamrex::AmrInfoprotected
n_field_gather_bufferWarpXstatic
n_properamrex::AmrInfoprotected
n_rz_azimuthal_modesWarpXstatic
nci_godfrey_filter_bxbyezWarpX
nci_godfrey_filter_exeybzWarpX
ncompsWarpXstatic
nErrorBuf(int lev, int direction=0) const noexceptamrex::AmrMesh
nErrorBufVect(int lev) const noexceptamrex::AmrMesh
NodalSyncJ(const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &J_fp, const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &J_cp, int lev, PatchType patch_type)WarpXprivate
NodalSyncRho(const amrex::Vector< std::unique_ptr< amrex::MultiFab >> &charge_fp, const amrex::Vector< std::unique_ptr< amrex::MultiFab >> &charge_cp, int lev, PatchType patch_type, int icomp, int ncomp)WarpXprivate
noxWarpXstatic
nox_fftWarpXprivate
noyWarpXstatic
noy_fftWarpXprivate
nozWarpXstatic
noz_fftWarpXprivate
nProper() const noexceptamrex::AmrMesh
nsubstepsWarpXprivate
num_injected_speciesWarpXprivate
num_mirrorsWarpXstatic
num_setbaamrex::AmrMeshprotected
num_setdmamrex::AmrMeshprotected
numprocsWarpXprivate
OneStep_ImplicitPicard(amrex::Real cur_time)WarpXprivate
OneStep_multiJ(amrex::Real cur_time)WarpXprivate
OneStep_nosub(amrex::Real cur_time)WarpXprivate
OneStep_sub1(amrex::Real cur_time)WarpXprivate
operator=(WarpX const &)=deleteWarpX
operator=(WarpX &&)=defaultWarpX
amrex::AmrCore::operator=(AmrCore &&rhs) noexceptamrex::AmrCore
amrex::AmrCore::operator=(const AmrCore &rhs)=deleteamrex::AmrCore
amrex::AmrMesh::operator=(const AmrMesh &rhs)=deleteamrex::AmrMesh
amrex::AmrMesh::operator=(AmrMesh &&rhs)=defaultamrex::AmrMesh
override_sync_intervalsWarpXprivate
particle_boundary_hiWarpXstatic
particle_boundary_loWarpXstatic
particle_io_nfilesWarpXprivate
particle_pusher_algoWarpXstatic
PerformanceHints()WarpXprivate
phi_fpWarpXprivate
picard_iteration_toleranceWarpXstatic
PicsarVersion()WarpXstatic
plotfile_headerversionWarpXprivate
pmlWarpXprivate
pml_deltaWarpXprivate
pml_has_particlesWarpXprivate
pml_ncellWarpXprivate
pml_rzWarpXprivate
poisson_solver_idWarpXstatic
PostProcessBaseGrids(amrex::BoxArray &ba0) const finalWarpXprotectedvirtual
PostRestart()WarpXprivate
prepareFields(int step, amrex::Vector< std::string > &varnames, amrex::Vector< amrex::MultiFab > &mf_avg, amrex::Vector< const amrex::MultiFab * > &output_mf, amrex::Vector< amrex::Geometry > &output_geom) constWarpX
PrintDtDxDyDz()WarpX
printGridSummary(std::ostream &os, int min_lev, int max_lev) const noexceptamrex::AmrCore
PrintMainPICparameters()WarpX
ProjPeriodic(BoxList &blout, const Box &domain, Array< int, AMREX_SPACEDIM > const &is_per)amrex::AmrMeshprivatestatic
psatd_solution_typeWarpXstatic
PSATDBackwardTransformEB(const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &E_fp, const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &B_fp, const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &E_cp, const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &B_cp)WarpXprivate
PSATDBackwardTransformEBavg(const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &E_avg_fp, const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &B_avg_fp, const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &E_avg_cp, const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &B_avg_cp)WarpXprivate
PSATDBackwardTransformF()WarpXprivate
PSATDBackwardTransformG()WarpXprivate
PSATDBackwardTransformJ(const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &J_fp, const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &J_cp)WarpXprivate
PSATDCurrentCorrection()WarpXprivate
PSATDEraseAverageFields()WarpXprivate
PSATDForwardTransformEB(const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &E_fp, const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &B_fp, const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &E_cp, const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &B_cp)WarpXprivate
PSATDForwardTransformF()WarpXprivate
PSATDForwardTransformG()WarpXprivate
PSATDForwardTransformJ(const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &J_fp, const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &J_cp, bool apply_kspace_filter=true)WarpXprivate
PSATDForwardTransformRho(const amrex::Vector< std::unique_ptr< amrex::MultiFab >> &charge_fp, const amrex::Vector< std::unique_ptr< amrex::MultiFab >> &charge_cp, int icomp, int dcomp, bool apply_kspace_filter=true)WarpXprivate
PSATDMoveJNewToJOld()WarpXprivate
PSATDMoveRhoNewToRhoOld()WarpXprivate
PSATDPushSpectralFields()WarpXprivate
PSATDScaleAverageFields(amrex::Real scale_factor)WarpXprivate
PSATDSubtractCurrentPartialSumsAvg()WarpX
PSATDVayDeposition()WarpXprivate
PushParticlesandDeposit(int lev, amrex::Real cur_time, DtType a_dt_type=DtType::Full, bool skip_current=false, PushType push_type=PushType::Explicit)WarpX
PushParticlesandDeposit(amrex::Real cur_time, bool skip_current=false, PushType push_type=PushType::Explicit)WarpX
PushPSATD()WarpXprivate
quantum_xi_c2WarpXstatic
ReadExternalFieldFromFile(const std::string &read_fields_from_path, amrex::MultiFab *mf, const std::string &F_name, const std::string &F_component)WarpX
ReadParameters()WarpXprivate
reduced_diagsWarpX
ref_patch_parserWarpXprivate
ref_ratioamrex::AmrInfoprotected
refine_grid_layoutamrex::AmrInfoprotected
refine_grid_layout_dimsamrex::AmrInfoprotected
refine_plasmaWarpXstatic
RefRatio(int lev)WarpXstatic
refRatio(int lev) const noexceptamrex::AmrMesh
refRatio() const noexceptamrex::AmrMesh
regrid(int lbase, Real time, bool initial=false)amrex::AmrCorevirtual
regrid_intWarpXprivate
RemakeLevel(int lev, amrex::Real time, const amrex::BoxArray &ba, const amrex::DistributionMapping &dm) finalWarpXprotected
amrex::AmrCore::RemakeLevel(int lev, Real time, const BoxArray &ba, const DistributionMapping &dm)=0amrex::AmrCoreprotectedpure virtual
ReorderFornbergCoefficients(amrex::Vector< amrex::Real > &ordered_coeffs, amrex::Vector< amrex::Real > &unordered_coeffs, int order)WarpXprivate
require_picard_convergenceWarpXstatic
RescaleCosts(int step)WarpX
ResetCosts()WarpX
ResetInstance()WarpXstatic
ResetProbDomain(const amrex::RealBox &rb)WarpX
restart_chkfileWarpXprivate
RestoreCurrent(int lev)WarpXprivate
RestrictCurrentFromFineToCoarsePatch(const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &J_fp, const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &J_cp, int lev)WarpXprivate
RestrictRhoFromFineToCoarsePatch(const amrex::Vector< std::unique_ptr< amrex::MultiFab >> &charge_fp, const amrex::Vector< std::unique_ptr< amrex::MultiFab >> &charge_cp, int lev)WarpXprivate
rho_cpWarpXprivate
rho_fpWarpXprivate
rho_in_timeWarpXstatic
rho_sliceWarpXprivate
safe_guard_cellsWarpXstatic
SaveParticlesAtImplicitStepStart(WarpXParticleContainer &pc, int lev)WarpX
ScrapeParticles()WarpXprivate
self_fields_absolute_toleranceWarpXstatic
self_fields_max_itersWarpXstatic
self_fields_required_precisionWarpXstatic
self_fields_verbosityWarpXstatic
serialize_initial_conditionsWarpXstatic
SetBlockingFactor(int new_bf) noexceptamrex::AmrMesh
SetBlockingFactor(const IntVect &new_bf) noexceptamrex::AmrMesh
SetBlockingFactor(const Vector< int > &new_bf) noexceptamrex::AmrMesh
SetBlockingFactor(const Vector< IntVect > &new_bf) noexceptamrex::AmrMesh
SetBoxArray(int lev, const BoxArray &ba_in) noexceptamrex::AmrMesh
SetDistributionMap(int lev, const DistributionMapping &dmap_in) noexceptamrex::AmrMesh
SetFinestLevel(int new_finest_level) noexceptamrex::AmrMesh
SetGeometry(int lev, const Geometry &geom_in) noexceptamrex::AmrMesh
SetGridEff(Real eff) noexceptamrex::AmrMesh
setistep(int lev, int ii)WarpXinline
SetIterateToFalse() noexceptamrex::AmrMeshprotected
setLoadBalanceEfficiency(int lev, amrex::Real efficiency)WarpX
SetMaxGridSize(int new_mgs) noexceptamrex::AmrMesh
SetMaxGridSize(const IntVect &new_mgs) noexceptamrex::AmrMesh
SetMaxGridSize(const Vector< int > &new_mgs) noexceptamrex::AmrMesh
SetMaxGridSize(const Vector< IntVect > &new_mgs) noexceptamrex::AmrMesh
SetNProper(int n) noexceptamrex::AmrMesh
setPhiBC(amrex::Vector< std::unique_ptr< amrex::MultiFab > > &phi) constWarpX
sett_new(int lev, amrex::Real time)WarpXinline
SetUseNewChop() noexceptamrex::AmrMeshprotected
setVectorPotentialBC(amrex::Vector< amrex::Array< std::unique_ptr< amrex::MultiFab >, 3 > > &A) constWarpX
shared_mem_current_tpbWarpXstatic
shared_tilesizeWarpXstatic
ShiftGalileanBoundary()WarpX
shiftMF(amrex::MultiFab &mf, const amrex::Geometry &geom, int num_shift, int dir, int lev, bool update_cost_flag, amrex::Real external_field=0.0, bool useparser=false, amrex::ParserExecutor< 3 > const &field_parser={})WarpXstatic
ShrinkBorrowing()WarpX
slice_cr_ratioWarpXprivate
slice_max_grid_sizeWarpXprivate
slice_plot_intWarpXprivate
slice_plotfile_headerversionWarpXprivate
slice_realboxWarpXprivate
sort_bin_sizeWarpXstatic
sort_idx_typeWarpXstatic
sort_intervalsWarpXstatic
sort_particles_for_depositionWarpXstatic
spectral_solver_cpWarpXprivate
spectral_solver_fpWarpXprivate
start_moving_window_stepWarpXstatic
stop_timeWarpXprivate
stopTime() constWarpXinline
StoreCurrent(int lev)WarpXprivate
SumBoundaryJ(const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &current, int lev, int idim, const amrex::Periodicity &period)WarpXprivate
SumBoundaryJ(const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &current, int lev, const amrex::Periodicity &period)WarpXprivate
sync_nodal_pointsWarpXprivatestatic
SyncCurrent(const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &J_fp, const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &J_cp, const amrex::Vector< std::array< std::unique_ptr< amrex::MultiFab >, 3 >> &J_buffer)WarpX
SyncCurrentAndRho()WarpX
SyncRho()WarpX
SyncRho(const amrex::Vector< std::unique_ptr< amrex::MultiFab >> &charge_fp, const amrex::Vector< std::unique_ptr< amrex::MultiFab >> &charge_cp, const amrex::Vector< std::unique_ptr< amrex::MultiFab >> &charge_buffer)WarpX
t_newWarpXprivate
t_oldWarpXprivate
time_of_last_gal_shiftWarpX
update_with_rhoWarpX
UpdateAuxilaryData()WarpX
UpdateAuxilaryDataSameType()WarpX
UpdateAuxilaryDataStagToNodal()WarpX
UpdateCurrentNodalToStag(amrex::MultiFab &dst, amrex::MultiFab const &src)WarpX
UpdateInjectionPosition(amrex::Real dt)WarpX
updateMaxStep(const int new_max_step)WarpXinline
updateStopTime(const amrex::Real new_stop_time)WarpXinline
UpperCorner(const amrex::Box &bx, int lev, amrex::Real time_shift_delta)WarpXstatic
use_fdtd_nci_corrWarpXstatic
use_filterWarpXstatic
use_filter_compensationWarpXstatic
use_fixed_coarse_gridsamrex::AmrInfoprotected
use_fixed_upto_levelamrex::AmrInfoprotected
use_hybrid_QEDWarpXprivate
use_kspace_filterWarpXstatic
use_new_chopamrex::AmrInfoprotected
use_single_readWarpXprivate
use_single_writeWarpXprivate
useFixedCoarseGrids() const noexceptamrex::AmrMesh
useFixedUpToLevel() const noexceptamrex::AmrMesh
v_particle_pmlWarpXprivate
vector_potential_fp_nodalWarpXprivate
vector_potential_grad_buf_b_stagWarpXprivate
vector_potential_grad_buf_e_stagWarpXprivate
VenlWarpXprivate
verboncoeur_axis_correctionWarpXstatic
verboseWarpXprivate
Verbose() constWarpXinline
Version()WarpXstatic
WarpX(WarpX const &)=deleteWarpX
WarpX(WarpX &&)=defaultWarpX
WarpX()WarpXprivate
warpx_do_continuous_injectionWarpXprivate
write_diagnostics_on_restartWarpXprivate
WriteUsedInputsFile() constWarpX
zmax_plasma_to_compute_max_stepWarpXstatic
zmin_domain_boost_step_0WarpXstatic
~AmrCore() overrideamrex::AmrCore
~AmrMesh()=defaultamrex::AmrMeshvirtual
~WarpX() overrideWarpX