|
WarpX
|
This is the complete list of members for WarpX, including all inherited members.
| AddCurrentFromFineLevelandSumBoundary(const ablastr::fields::MultiLevelVectorField &J_fp, const ablastr::fields::MultiLevelVectorField &J_cp, const ablastr::fields::MultiLevelVectorField &J_buffer, int lev) | WarpX | private |
| AddExternalFields(int lev) | WarpX | private |
| AddMagnetostaticFieldLabFrame() | WarpX | |
| AddRhoFromFineLevelandSumBoundary(const ablastr::fields::MultiLevelScalarField &charge_fp, const ablastr::fields::MultiLevelScalarField &charge_cp, ablastr::fields::MultiLevelScalarField const &charge_buffer, int lev, int icomp, int ncomp) | WarpX | private |
| Afield_dotMask | WarpX | mutableprivate |
| 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={}) | WarpX | |
| AllocLevelData(int lev, const amrex::BoxArray &ba, const amrex::DistributionMapping &dm) | WarpX | private |
| 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) | WarpX | private |
| 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) | WarpX | private |
| 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, 3 > const &is_per) | amrex::AmrCore | |
| AmrCore(Geometry const &level_0_geom, AmrInfo const &amr_info) | amrex::AmrCore | |
| AmrCore(AmrCore &&rhs) noexcept | amrex::AmrCore | |
| AmrCore(const AmrCore &rhs)=delete | amrex::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, 3 > const &is_per) | amrex::AmrMesh | |
| AmrMesh(Geometry const &level_0_geom, AmrInfo const &amr_info) | amrex::AmrMesh | |
| AmrMesh(const AmrMesh &rhs)=delete | amrex::AmrMesh | |
| AmrMesh(AmrMesh &&rhs)=default | amrex::AmrMesh | |
| ApplyBfieldBoundary(int lev, PatchType patch_type, SubcyclingHalf subcycling_half, amrex::Real cur_time) | WarpX | |
| ApplyEfieldBoundary(int lev, PatchType patch_type, amrex::Real cur_time) | WarpX | |
| ApplyElectronPressureBoundary(int lev, PatchType patch_type) | WarpX | |
| ApplyFieldBoundaryOnAxis(amrex::MultiFab *Er, amrex::MultiFab *Et, amrex::MultiFab *Ez, int lev) const | WarpX | |
| ApplyFilterandSumBoundaryRho(int lev, int glev, amrex::MultiFab &rho, int icomp, int ncomp) | WarpX | |
| ApplyFilterandSumBoundaryRho(const ablastr::fields::MultiLevelScalarField &charge_fp, const ablastr::fields::MultiLevelScalarField &charge_cp, int lev, PatchType patch_type, int icomp, int ncomp) | WarpX | private |
| ApplyFilterMF(const ablastr::fields::MultiLevelVectorField &mfvec, int lev, int idim) | WarpX | |
| ApplyFilterMF(const ablastr::fields::MultiLevelVectorField &mfvec, int lev) | WarpX | |
| ApplyInverseVolumeScalingToChargeDensity(amrex::MultiFab *Rho, int lev) const | WarpX | |
| ApplyInverseVolumeScalingToCurrentDensity(amrex::MultiFab *Jx, amrex::MultiFab *Jy, amrex::MultiFab *Jz, int lev) const | 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 | |
| BackwardCompatibility() | WarpX | private |
| beta_boost | WarpX | static |
| Bfield_dotMask | WarpX | mutableprivate |
| bilinear_filter | WarpX | |
| blocking_factor | amrex::AmrInfo | protected |
| blockingFactor(int lev) const noexcept | amrex::AmrMesh | |
| boost_direction | WarpX | static |
| boxArray() const noexcept | amrex::AmrMesh | |
| boxArray(int lev) const noexcept | amrex::AmrMesh | |
| boxArray(int a_coarsest_lev, int a_finest_lev) const noexcept | amrex::AmrMesh | |
| BuildBufferMasks() | WarpX | private |
| BuildBufferMasksInBox(amrex::Box tbx, amrex::IArrayBox &buffer_mask, const amrex::IArrayBox &guard_mask, int ng) | WarpX | |
| CalculateExternalCurlA() | WarpX | |
| CellSize(int lev) | WarpX | static |
| cfl | WarpX | private |
| charge_deposition_algo | WarpX | inlinestatic |
| check_input | amrex::AmrInfo | protected |
| CheckGuardCells() | WarpX | private |
| checkInput() | amrex::AmrMesh | protected |
| CheckLoadBalance(int step) | WarpX | |
| checkStopSimulation(amrex::Real cur_time) | WarpX | private |
| ChopGrids(int lev, BoxArray &ba, int target_size) const | amrex::AmrMesh | |
| ClearBoxArray(int lev) noexcept | amrex::AmrMesh | |
| ClearDistributionMap(int lev) noexcept | amrex::AmrMesh | |
| ClearLevel(int lev) final | WarpX | protectedvirtual |
| compute_max_step_from_btd | WarpX | static |
| ComputeCostsHeuristic(amrex::Vector< std::unique_ptr< amrex::LayoutData< amrex::Real > > > &costs) | WarpX | |
| ComputeDistanceToEB() | WarpX | |
| ComputeDivB(amrex::MultiFab &divB, int dcomp, ablastr::fields::VectorField const &B, const std::array< amrex::Real, 3 > &dx) | WarpX | static |
| ComputeDivB(amrex::MultiFab &divB, int dcomp, ablastr::fields::VectorField const &B, const std::array< amrex::Real, 3 > &dx, amrex::IntVect ngrow) | WarpX | static |
| ComputeDivE(amrex::MultiFab &divE, int lev) | WarpX | |
| ComputeDt() | WarpX | |
| ComputeEightWaysExtensions() | WarpX | |
| ComputeExternalFieldOnGridUsingParser(const std::variant< warpx::fields::FieldType, std::string > &field, amrex::ParserExecutor< 4 > const &fx_parser, amrex::ParserExecutor< 4 > const &fy_parser, amrex::ParserExecutor< 4 > const &fz_parser, int lev, PatchType patch_type, amrex::Vector< std::array< std::unique_ptr< amrex::iMultiFab >, 3 > > const &eb_update_field, bool use_eb_flags=true) | WarpX | |
| ComputeFaceExtensions() | WarpX | |
| ComputeMagnetostaticField() | WarpX | |
| ComputeMaxStep() | WarpX | |
| computeMaxStepBoostAccelerator() | WarpX | |
| ComputeOneWayExtensions() | WarpX | |
| ComputePMLFactors() | WarpX | private |
| ComputeSpaceChargeField(bool reset_fields) | WarpX | |
| computeVectorPotential(ablastr::fields::MultiLevelVectorField const &curr, ablastr::fields::MultiLevelVectorField const &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) | WarpX | |
| CopyJPML() | WarpX | |
| costs | WarpX | private |
| costs_heuristic_cells_wt | WarpX | private |
| costs_heuristic_particles_wt | WarpX | private |
| CountCells(int lev) const noexcept | amrex::AmrMesh | |
| current_buffer_masks | WarpX | private |
| current_correction | WarpX | |
| current_deposition_algo | WarpX | inlinestatic |
| CurrentBufferMasks(int lev) | WarpX | static |
| DampFieldsInGuards(int lev, const ablastr::fields::VectorField &Efield, const ablastr::fields::VectorField &Bfield) | WarpX | |
| DampFieldsInGuards(int lev, 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_x | WarpX | |
| device_current_centering_stencil_coeffs_y | WarpX | |
| device_current_centering_stencil_coeffs_z | WarpX | |
| device_field_centering_stencil_coeffs_x | WarpX | |
| device_field_centering_stencil_coeffs_y | WarpX | |
| device_field_centering_stencil_coeffs_z | WarpX | |
| DistributionMap() const noexcept | amrex::AmrMesh | |
| DistributionMap(int lev) const noexcept | amrex::AmrMesh | |
| DistributionMap(int a_coarsest_lev, int a_finest_lev) const noexcept | amrex::AmrMesh | |
| dmap | amrex::AmrMesh | protected |
| do_current_centering | WarpX | |
| do_divb_cleaning | WarpX | static |
| do_dive_cleaning | WarpX | static |
| do_dynamic_scheduling | WarpX | static |
| do_fluid_species | WarpX | private |
| do_moving_window | WarpX | static |
| do_pml | WarpX | private |
| do_pml_divb_cleaning | WarpX | private |
| do_pml_dive_cleaning | WarpX | private |
| do_pml_Hi | WarpX | private |
| do_pml_in_domain | WarpX | private |
| do_pml_j_damping | WarpX | private |
| do_pml_Lo | WarpX | private |
| do_shared_mem_charge_deposition | WarpX | static |
| do_shared_mem_current_deposition | WarpX | static |
| do_silver_mueller | WarpX | private |
| do_similar_dm_pml | WarpX | private |
| do_single_precision_comms | WarpX | static |
| doFieldIonization() | WarpX | |
| DoFluidSpecies() const | WarpX | inline |
| DoPML() const | WarpX | inline |
| doQEDEvents() | WarpX | |
| dt | WarpX | private |
| Efield_dotMask | WarpX | mutableprivate |
| electromagnetic_solver_id | WarpX | inlinestatic |
| electrostatic_solver_id | WarpX | inlinestatic |
| end_moving_window_step | WarpX | static |
| ErrorEst(int lev, amrex::TagBoxArray &tags, amrex::Real time, int) final | WarpX | |
| amrex::AmrCore::ErrorEst(int lev, TagBoxArray &tags, Real time, int ngrow) override=0 | amrex::AmrCore | protectedpure virtual |
| Evolve(int numsteps=-1) | WarpX | |
| evolve_scheme | WarpX | |
| EvolveB(amrex::Real dt, SubcyclingHalf subcycling_half, amrex::Real start_time) | WarpX | |
| EvolveB(int lev, amrex::Real dt, SubcyclingHalf subcycling_half, amrex::Real start_time) | WarpX | |
| EvolveB(int lev, PatchType patch_type, amrex::Real dt, SubcyclingHalf subcycling_half, amrex::Real start_time) | WarpX | |
| EvolveE(amrex::Real dt, amrex::Real start_time) | WarpX | |
| EvolveE(int lev, amrex::Real dt, amrex::Real start_time) | WarpX | |
| EvolveE(int lev, PatchType patch_type, amrex::Real dt, amrex::Real start_time) | WarpX | |
| EvolveF(amrex::Real dt, int const rho_comp) | WarpX | |
| EvolveF(int lev, amrex::Real dt, int const rho_comp) | WarpX | |
| EvolveF(int lev, PatchType patch_type, amrex::Real dt, int const rho_comp) | WarpX | |
| EvolveG(amrex::Real dt) | WarpX | |
| EvolveG(int lev, amrex::Real dt) | WarpX | |
| EvolveG(int lev, PatchType patch_type, amrex::Real dt) | WarpX | |
| ExplicitFillBoundaryEBUpdateAux() | WarpX | private |
| fft_do_time_averaging | WarpX | static |
| fft_periodic_single_box | WarpX | private |
| field_boundary_hi | WarpX | inlinestatic |
| field_boundary_lo | WarpX | inlinestatic |
| field_centering_nox | WarpX | static |
| field_centering_noy | WarpX | static |
| field_centering_noz | WarpX | static |
| field_gathering_algo | WarpX | inlinestatic |
| field_io_nfiles | WarpX | private |
| 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) | WarpX | private |
| FillBoundaryB_avg(amrex::IntVect ng) | WarpX | |
| FillBoundaryB_avg(int lev, amrex::IntVect ng) | WarpX | |
| FillBoundaryB_avg(int lev, PatchType patch_type, amrex::IntVect ng) | WarpX | private |
| 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) | WarpX | private |
| FillBoundaryE_avg(amrex::IntVect ng) | WarpX | |
| FillBoundaryE_avg(int lev, amrex::IntVect ng) | WarpX | |
| FillBoundaryE_avg(int lev, PatchType patch_type, amrex::IntVect ng) | WarpX | private |
| 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) | WarpX | private |
| 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) | WarpX | private |
| filter_npass_each_dir | WarpX | static |
| Finalize() | WarpX | static |
| fine_tag_hi | WarpX | private |
| fine_tag_lo | WarpX | private |
| finest_level | amrex::AmrMesh | protected |
| finestLevel() const noexcept | amrex::AmrMesh | |
| FinishImplicitField(const ablastr::fields::MultiLevelVectorField &Field_fp, const ablastr::fields::MultiLevelVectorField &Field_n, amrex::Real theta) | WarpX | |
| FinishImplicitParticleUpdate() | WarpX | |
| FinishMagneticFieldAndApplyBCs(ablastr::fields::MultiLevelVectorField const &a_Bn, amrex::Real a_theta, amrex::Real a_time) | WarpX | |
| galerkin_interpolation | WarpX | static |
| gamma_boost | WarpX | static |
| gather_buffer_masks | WarpX | private |
| GatherBufferMasks(int lev) | WarpX | static |
| Geom() const noexcept | amrex::AmrMesh | |
| Geom(int lev) const noexcept | amrex::AmrMesh | |
| Geom(int a_coarsest_lev, int a_finest_lev) const noexcept | amrex::AmrMesh | |
| Geom() noexcept | amrex::AmrMesh | |
| Geom(int lev) noexcept | amrex::AmrMesh | |
| geom | amrex::AmrMesh | protected |
| get_accelerator_lattice(int lev) | WarpX | inline |
| get_load_balance_intervals() const | WarpX | inline |
| get_ng_depos_J() const | WarpX | inline |
| get_ng_depos_rho() const | WarpX | inline |
| get_ng_fieldgather() const | WarpX | inline |
| get_numprocs() const | WarpX | inline |
| get_pointer_fdtd_solver_fp(int lev) | WarpX | inline |
| get_pointer_HybridPICModel() const | WarpX | inline |
| get_spectral_solver_fp(int lev) | WarpX | inline |
| GetAreaNotToTag(int) | amrex::AmrMesh | virtual |
| GetAuthors() const | WarpX | inline |
| getCosts(int lev) | WarpX | static |
| getCurrentBufferMasks(int lev) const | WarpX | inlineprivate |
| getdo_moving_window() const | WarpX | inline |
| getdt() const | WarpX | inline |
| getdt(int lev) const | WarpX | inline |
| GetEBReduceParticleShapeFlag() const | WarpX | inline |
| GetEBUpdateBFlag() | WarpX | inline |
| GetEBUpdateEFlag() | WarpX | inline |
| GetElectrostaticSolver() | WarpX | inline |
| GetFieldBoundaryHi() const | WarpX | inline |
| GetFieldBoundaryLo() const | WarpX | inline |
| getFieldDotMaskPointer(warpx::fields::FieldType field_type, int lev, ablastr::fields::Direction dir) const | WarpX | |
| GetFluidContainer() | WarpX | inline |
| getGatherBufferMasks(int lev) const | WarpX | inlineprivate |
| GetInstance() | WarpX | static |
| getis_synchronized() const | WarpX | inline |
| getistep() const | WarpX | inline |
| getistep(int lev) const | WarpX | inline |
| GetLevel(Box const &domain) const noexcept | amrex::AmrMesh | |
| getLoadBalanceEfficiency(int lev) | WarpX | |
| getmoving_window_x() const | WarpX | inline |
| GetMultiDiags() | WarpX | inline |
| GetMultiFabRegister() | WarpX | inline |
| getngEB() const | WarpX | inline |
| getngF() const | WarpX | inline |
| getngUpdateAux() const | WarpX | inline |
| getnsubsteps() const | WarpX | inline |
| getnsubsteps(int lev) const | WarpX | inline |
| GetParGDB() const noexcept | amrex::AmrCore | |
| GetPartContainer() | WarpX | inline |
| GetParticleBoundaryBuffer() | WarpX | inline |
| GetPML(int lev) | WarpX | |
| GetPML_RZ(int lev) | WarpX | |
| getPMLdirections() const | WarpX | |
| getRealBox(const amrex::Box &bx, int lev) | WarpX | static |
| GetRestartDMap(const std::string &chkfile, const amrex::BoxArray &ba, int lev) const | WarpX | private |
| gett_new() const | WarpX | inline |
| gett_new(int lev) const | WarpX | inline |
| gett_old() const | WarpX | inline |
| gett_old(int lev) const | WarpX | inline |
| grid_eff | amrex::AmrInfo | protected |
| grid_type | WarpX | inlinestatic |
| gridEff() const noexcept | amrex::AmrMesh | |
| grids | amrex::AmrMesh | protected |
| guard_cells | WarpX | private |
| HandleParticlesAtBoundaries(int step, amrex::Real cur_time, int num_moved) | WarpX | private |
| HandleSignals() | WarpX | private |
| 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 | |
| HybridPICDepositRhoAndJ() | WarpX | |
| HybridPICEvolveFields() | WarpX | |
| HybridPICInitializeRhoJandB() | WarpX | |
| ImplicitComputeRHSE(amrex::Real dt, WarpXSolverVec &a_Erhs_vec) | WarpX | |
| ImplicitComputeRHSE(int lev, amrex::Real dt, WarpXSolverVec &a_Erhs_vec) | WarpX | |
| ImplicitComputeRHSE(int lev, PatchType patch_type, amrex::Real dt, WarpXSolverVec &a_Erhs_vec) | WarpX | |
| imultifab_map | WarpX | |
| InitAmrCore() | amrex::AmrCore | private |
| 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::AmrMesh | private |
| InitBorrowing() | WarpX | |
| InitData() | WarpX | |
| InitDiagnostics() | WarpX | private |
| InitEB() | WarpX | |
| InitFilter() | WarpX | private |
| InitFromCheckpoint() | WarpX | private |
| InitFromScratch() | WarpX | private |
| amrex::AmrCore::InitFromScratch(Real time) | amrex::AmrCore | |
| InitializeEBGridData(int lev) | WarpX | |
| InitLevelData(int lev, amrex::Real time) | WarpX | protected |
| InitNCICorrector() | WarpX | private |
| InitPML() | WarpX | private |
| injected_plasma_species | WarpX | private |
| InvCellSize(int lev) | WarpX | static |
| isAnyParticleBoundaryThermal() | WarpX | static |
| istep | WarpX | private |
| iterate_on_new_grids | amrex::AmrInfo | protected |
| LevelDefined(int lev) const noexcept | amrex::AmrMesh | |
| load_balance_costs_update_algo | WarpX | inlinestatic |
| load_balance_efficiency | WarpX | private |
| load_balance_efficiency_ratio_threshold | WarpX | private |
| load_balance_intervals | WarpX | private |
| load_balance_knapsack_factor | WarpX | private |
| load_balance_with_sfc | WarpX | private |
| LoadBalance() | WarpX | |
| LoadExternalFields(int lev) | WarpX | |
| LowerCorner(const amrex::Box &bx, int lev, amrex::Real time_shift_delta) | WarpX | static |
| m_accelerator_lattice | WarpX | private |
| m_authors | WarpX | private |
| m_borrowing | WarpX | private |
| m_const_dt | WarpX | private |
| m_current_centering_nox | WarpX | private |
| m_current_centering_noy | WarpX | private |
| m_current_centering_noz | WarpX | private |
| m_do_initial_div_cleaning | WarpX | private |
| m_do_subcycling | WarpX | private |
| m_dt_update_interval | WarpX | private |
| m_eb_reduce_particle_shape | WarpX | private |
| m_eb_update_B | WarpX | private |
| m_eb_update_E | WarpX | private |
| m_electrostatic_solver | WarpX | private |
| m_em_solver_medium | WarpX | private |
| m_exit_loop_due_to_interrupt_signal | WarpX | private |
| m_fdtd_solver_cp | WarpX | private |
| m_fdtd_solver_fp | WarpX | private |
| m_field_factory | WarpX | private |
| m_fields | WarpX | |
| m_fill_guards_current | WarpX | static |
| m_fill_guards_fields | WarpX | static |
| m_flag_ext_face | WarpX | private |
| m_flag_info_face | WarpX | private |
| m_galilean_shift | WarpX | |
| m_gdb | amrex::AmrCore | protected |
| m_hybrid_pic_model | WarpX | private |
| m_implicit_solver | WarpX | private |
| m_instance | WarpX | privatestatic |
| m_is_synchronized | WarpX | private |
| m_JRhom | WarpX | private |
| m_JRhom_subintervals | WarpX | private |
| m_limit_verbose_step | WarpX | private |
| m_macroscopic_properties | WarpX | private |
| m_macroscopic_solver_algo | WarpX | private |
| m_max_dt | WarpX | private |
| m_mirror_z | WarpX | private |
| m_mirror_z_npoints | WarpX | private |
| m_mirror_z_width | WarpX | private |
| m_num_mirrors | WarpX | private |
| m_p_ext_field_params | WarpX | private |
| m_particle_boundary_buffer | WarpX | private |
| m_psatd_solution_type | WarpX | private |
| m_quantum_xi_c2 | WarpX | |
| m_rho_nodal_flag | WarpX | |
| m_safe_guard_cells | WarpX | private |
| m_sort_idx_type | WarpX | private |
| m_sort_particles_for_deposition | WarpX | private |
| m_v_comoving | WarpX | |
| m_v_galilean | WarpX | |
| m_vector_poisson_boundary_handler | WarpX | |
| m_verboncoeur_axis_correction | WarpX | private |
| m_zmax_plasma_to_compute_max_step | WarpX | private |
| MacroscopicEvolveE(amrex::Real dt, amrex::Real start_time) | WarpX | |
| MacroscopicEvolveE(int lev, amrex::Real dt, amrex::Real start_time) | WarpX | |
| MacroscopicEvolveE(int lev, PatchType patch_type, amrex::Real dt, amrex::Real start_time) | WarpX | |
| magnetostatic_solver_max_iters | WarpX | |
| magnetostatic_solver_verbosity | WarpX | |
| MakeBaseGrids() const | amrex::AmrMesh | |
| MakeDistributionMap(int lev, amrex::BoxArray const &ba) final | WarpX | protectedvirtual |
| 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 &) final | WarpX | protected |
| amrex::AmrCore::MakeNewLevelFromCoarse(int lev, Real time, const BoxArray &ba, const DistributionMapping &dm)=0 | amrex::AmrCore | protectedpure virtual |
| MakeNewLevelFromScratch(int lev, amrex::Real time, const amrex::BoxArray &new_grids, const amrex::DistributionMapping &new_dmap) final | WarpX | protected |
| amrex::AmrCore::MakeNewLevelFromScratch(int lev, Real time, const BoxArray &ba, const DistributionMapping &dm) override=0 | amrex::AmrCore | protectedpure virtual |
| MakeWarpX() | WarpX | privatestatic |
| ManualTagsPlacement(int, TagBoxArray &, const Vector< IntVect > &) | amrex::AmrMesh | virtual |
| max_grid_size | amrex::AmrInfo | protected |
| max_level | amrex::AmrInfo | protected |
| max_step | WarpX | private |
| maxGridSize(int lev) const noexcept | amrex::AmrMesh | |
| maxLevel() const noexcept | amrex::AmrMesh | |
| maxlevel_extEMfield_init | WarpX | |
| MaxRefRatio(int lev) const noexcept | amrex::AmrMesh | |
| maxStep() const | WarpX | inline |
| mffile_nstreams | WarpX | private |
| MoveWindow(int step, bool move_j) | WarpX | |
| moving_window_active(int const step) | WarpX | inlinestatic |
| moving_window_dir | WarpX | static |
| moving_window_v | WarpX | static |
| moving_window_x | WarpX | private |
| multi_diags | WarpX | private |
| myfl | WarpX | private |
| mypc | WarpX | private |
| n_current_deposition_buffer | WarpX | static |
| n_error_buf | amrex::AmrInfo | protected |
| n_field_gather_buffer | WarpX | static |
| n_proper | amrex::AmrInfo | protected |
| n_rz_azimuthal_modes | WarpX | static |
| nci_godfrey_filter_bxbyez | WarpX | |
| nci_godfrey_filter_exeybz | WarpX | |
| ncomps | WarpX | static |
| nErrorBuf(int lev, int direction=0) const noexcept | amrex::AmrMesh | |
| nErrorBufVect(int lev) const noexcept | amrex::AmrMesh | |
| nox | WarpX | static |
| nox_fft | WarpX | private |
| noy | WarpX | static |
| noy_fft | WarpX | private |
| noz | WarpX | static |
| noz_fft | WarpX | private |
| nProper() const noexcept | amrex::AmrMesh | |
| nsubsteps | WarpX | private |
| num_injected_species | WarpX | private |
| num_setba | amrex::AmrMesh | protected |
| num_setdm | amrex::AmrMesh | protected |
| numprocs | WarpX | private |
| OneStep(amrex::Real a_cur_time, amrex::Real a_dt, int a_step) | WarpX | private |
| OneStep_JRhom(amrex::Real cur_time) | WarpX | private |
| OneStep_nosub(amrex::Real cur_time) | WarpX | private |
| OneStep_sub1(amrex::Real cur_time) | WarpX | private |
| operator=(WarpX const &)=delete | WarpX | |
| operator=(WarpX &&)=delete | WarpX | |
| amrex::AmrCore::operator=(AmrCore &&rhs) noexcept | amrex::AmrCore | |
| amrex::AmrCore::operator=(const AmrCore &rhs)=delete | amrex::AmrCore | |
| amrex::AmrMesh::operator=(const AmrMesh &rhs)=delete | amrex::AmrMesh | |
| amrex::AmrMesh::operator=(AmrMesh &&rhs)=default | amrex::AmrMesh | |
| override_sync_intervals | WarpX | private |
| particle_boundary_hi | WarpX | inlinestatic |
| particle_boundary_lo | WarpX | inlinestatic |
| particle_io_nfiles | WarpX | private |
| particle_max_grid_crossings | WarpX | static |
| particle_pusher_algo | WarpX | inlinestatic |
| pec_insulator_boundary | WarpX | private |
| phi_dotMask | WarpX | mutableprivate |
| PicsarVersion() | WarpX | static |
| pml | WarpX | private |
| pml_delta | WarpX | private |
| pml_has_particles | WarpX | private |
| pml_ncell | WarpX | private |
| pml_rz | WarpX | private |
| poisson_solver_id | WarpX | inlinestatic |
| PostProcessBaseGrids(amrex::BoxArray &ba0) const final | WarpX | virtual |
| PostRestart() | WarpX | private |
| printGridSummary(std::ostream &os, int min_lev, int max_lev) const noexcept | amrex::AmrCore | |
| PrintMainPICparameters() | WarpX | |
| ProjectionCleanDivB() | WarpX | |
| ProjPeriodic(BoxList &blout, const Box &domain, Array< int, 3 > const &is_per) | amrex::AmrMesh | privatestatic |
| PSATDBackwardTransformEB() | WarpX | private |
| PSATDBackwardTransformEBavg(ablastr::fields::MultiLevelVectorField const &E_avg_fp, ablastr::fields::MultiLevelVectorField const &B_avg_fp, ablastr::fields::MultiLevelVectorField const &E_avg_cp, ablastr::fields::MultiLevelVectorField const &B_avg_cp) | WarpX | private |
| PSATDBackwardTransformF() | WarpX | private |
| PSATDBackwardTransformG() | WarpX | private |
| PSATDBackwardTransformJ(std::string const &J_fp_string, std::string const &J_cp_string) | WarpX | private |
| PSATDEraseAverageFields() | WarpX | private |
| PSATDForwardTransformEB() | WarpX | private |
| PSATDForwardTransformF() | WarpX | private |
| PSATDForwardTransformG() | WarpX | private |
| PSATDForwardTransformJ(std::string const &J_fp_string, std::string const &J_cp_string, bool apply_kspace_filter=true) | WarpX | private |
| PSATDForwardTransformRho(std::string const &charge_fp_string, std::string const &charge_cp_string, int icomp, int dcomp, bool apply_kspace_filter=true) | WarpX | private |
| PSATDMoveJNewToJMid() | WarpX | private |
| PSATDMoveJNewToJOld() | WarpX | private |
| PSATDMoveRhoNewToRhoMid() | WarpX | private |
| PSATDMoveRhoNewToRhoOld() | WarpX | private |
| PSATDPushSpectralFields() | WarpX | private |
| PSATDScaleAverageFields(amrex::Real scale_factor) | WarpX | private |
| PushParticlesandDeposit(int lev, amrex::Real cur_time, SubcyclingHalf subcycling_half=SubcyclingHalf::None, bool skip_current=false, ImplicitOptions const *implicit_options=nullptr) | WarpX | |
| PushParticlesandDeposit(amrex::Real cur_time, bool skip_current=false, ImplicitOptions const *implicit_options=nullptr) | WarpX | |
| PushPSATD(amrex::Real start_time) | WarpX | private |
| ReadExternalFieldFromFile(const std::string &read_fields_from_path, amrex::MultiFab *mf, const std::string &F_name, const std::string &F_component) | WarpX | |
| ReadParameters() | WarpX | private |
| reduced_diags | WarpX | |
| ref_patch_parser | WarpX | private |
| ref_ratio | amrex::AmrInfo | protected |
| refine_grid_layout | amrex::AmrInfo | protected |
| refine_grid_layout_dims | amrex::AmrInfo | protected |
| refine_plasma | WarpX | static |
| RefRatio(int lev) | WarpX | static |
| refRatio(int lev) const noexcept | amrex::AmrMesh | |
| refRatio() const noexcept | amrex::AmrMesh | |
| regrid(int lbase, Real time, bool initial=false) | amrex::AmrCore | virtual |
| regrid_int | WarpX | private |
| RemakeLevel(int lev, amrex::Real time, const amrex::BoxArray &ba, const amrex::DistributionMapping &dm) final | WarpX | protected |
| amrex::AmrCore::RemakeLevel(int lev, Real time, const BoxArray &ba, const DistributionMapping &dm)=0 | amrex::AmrCore | protectedpure virtual |
| RescaleCosts(int step) | WarpX | |
| ResetCosts() | WarpX | |
| ResetInstance() | WarpX | static |
| ResetProbDomain(const amrex::RealBox &rb) | WarpX | |
| restart_chkfile | WarpX | private |
| RestrictCurrentFromFineToCoarsePatch(const ablastr::fields::MultiLevelVectorField &J_fp, const ablastr::fields::MultiLevelVectorField &J_cp, int lev) | WarpX | private |
| RestrictRhoFromFineToCoarsePatch(int lev) | WarpX | private |
| SaveParticlesAtImplicitStepStart() | WarpX | |
| serialize_initial_conditions | WarpX | static |
| SetBlockingFactor(int new_bf) noexcept | amrex::AmrMesh | |
| SetBlockingFactor(const IntVect &new_bf) noexcept | amrex::AmrMesh | |
| SetBlockingFactor(const Vector< int > &new_bf) noexcept | amrex::AmrMesh | |
| SetBlockingFactor(const Vector< IntVect > &new_bf) noexcept | amrex::AmrMesh | |
| SetBoxArray(int lev, const BoxArray &ba_in) noexcept | amrex::AmrMesh | |
| SetDistributionMap(int lev, const DistributionMapping &dmap_in) noexcept | amrex::AmrMesh | |
| SetElectricFieldAndApplyBCs(const WarpXSolverVec &a_E, amrex::Real a_time) | WarpX | |
| SetFinestLevel(int new_finest_level) noexcept | amrex::AmrMesh | |
| SetGeometry(int lev, const Geometry &geom_in) noexcept | amrex::AmrMesh | |
| SetGridEff(Real eff) noexcept | amrex::AmrMesh | |
| setistep(int lev, int ii) | WarpX | inline |
| SetIterateToFalse() noexcept | amrex::AmrMesh | protected |
| setLoadBalanceEfficiency(int lev, amrex::Real efficiency) | WarpX | |
| SetMaxGridSize(int new_mgs) noexcept | amrex::AmrMesh | |
| SetMaxGridSize(const IntVect &new_mgs) noexcept | amrex::AmrMesh | |
| SetMaxGridSize(const Vector< int > &new_mgs) noexcept | amrex::AmrMesh | |
| SetMaxGridSize(const Vector< IntVect > &new_mgs) noexcept | amrex::AmrMesh | |
| SetNProper(int n) noexcept | amrex::AmrMesh | |
| sett_new(int lev, amrex::Real time) | WarpX | inline |
| SetUseNewChop() noexcept | amrex::AmrMesh | protected |
| setVectorPotentialBC(ablastr::fields::MultiLevelVectorField const &A) const | WarpX | |
| shared_mem_current_tpb | WarpX | static |
| shared_tilesize | WarpX | static |
| ShiftGalileanBoundary() | WarpX | |
| ShrinkBorrowing() | WarpX | |
| slice_cr_ratio | WarpX | private |
| slice_max_grid_size | WarpX | private |
| slice_plot_int | WarpX | private |
| slice_realbox | WarpX | private |
| sort_bin_size | WarpX | static |
| sort_idx_type | WarpX | static |
| sort_intervals | WarpX | static |
| sort_particles_for_deposition | WarpX | static |
| spectral_solver_cp | WarpX | private |
| spectral_solver_fp | WarpX | private |
| SpectralSourceFreeFieldAdvance(amrex::Real start_time) | WarpX | |
| start_moving_window_step | WarpX | static |
| stop_time | WarpX | private |
| stopTime() const | WarpX | inline |
| SumBoundaryJ(const ablastr::fields::MultiLevelVectorField ¤t, int lev, int idim, const amrex::Periodicity &period) | WarpX | private |
| SumBoundaryJ(const ablastr::fields::MultiLevelVectorField ¤t, int lev, const amrex::Periodicity &period) | WarpX | private |
| sync_nodal_points | WarpX | privatestatic |
| SyncCurrent(const std::string ¤t_fp_string) | WarpX | |
| SyncCurrentAndRho() | WarpX | |
| synchronize_velocity_for_diagnostics | WarpX | private |
| SynchronizeVelocityWithPosition() | WarpX | |
| SyncMassMatricesPC() | WarpX | |
| SyncRho() | WarpX | |
| SyncRho(const ablastr::fields::MultiLevelScalarField &charge_fp, const ablastr::fields::MultiLevelScalarField &charge_cp, ablastr::fields::MultiLevelScalarField const &charge_buffer) | WarpX | |
| t_new | WarpX | private |
| t_old | WarpX | private |
| time_dependency_J | WarpX | inlinestatic |
| time_dependency_rho | WarpX | inlinestatic |
| time_of_last_gal_shift | WarpX | |
| update_with_rho | WarpX | |
| UpdateAuxilaryData() | WarpX | |
| UpdateAuxilaryDataSameType() | WarpX | |
| UpdateAuxilaryDataStagToNodal() | WarpX | |
| UpdateDtFromParticleSpeeds() | WarpX | |
| UpdateMagneticFieldAndApplyBCs(ablastr::fields::MultiLevelVectorField const &a_Bn, amrex::Real a_thetadt, amrex::Real start_time) | WarpX | |
| updateMaxStep(const int new_max_step) | WarpX | inline |
| updateStopTime(const amrex::Real new_stop_time) | WarpX | inline |
| UpperCorner(const amrex::Box &bx, int lev, amrex::Real time_shift_delta) | WarpX | static |
| use_fdtd_nci_corr | WarpX | static |
| use_filter | WarpX | static |
| use_filter_compensation | WarpX | static |
| use_fixed_coarse_grids | amrex::AmrInfo | protected |
| use_fixed_upto_level | amrex::AmrInfo | protected |
| use_hybrid_QED | WarpX | private |
| use_kspace_filter | WarpX | static |
| use_new_chop | amrex::AmrInfo | protected |
| use_single_read | WarpX | private |
| use_single_write | WarpX | private |
| useFixedCoarseGrids() const noexcept | amrex::AmrMesh | |
| useFixedUpToLevel() const noexcept | amrex::AmrMesh | |
| v_particle_pml | WarpX | private |
| Verbose() const | WarpX | inline |
| verbose | WarpX | private |
| Version() | WarpX | static |
| WarpX(WarpX const &)=delete | WarpX | |
| WarpX(WarpX &&)=delete | WarpX | |
| WarpX() | WarpX | private |
| warpx_do_continuous_injection | WarpX | private |
| write_diagnostics_on_restart | WarpX | private |
| zmin_domain_boost_step_0 | WarpX | static |
| ~AmrCore() override | amrex::AmrCore | |
| ~AmrMesh()=default | amrex::AmrMesh | virtual |
| ~WarpX() override | WarpX |