|
|
| ItoPlasmaGodunovStepper ()=delete |
| | Disallowed default constructor. Use the full constructor.
|
| |
| | ItoPlasmaGodunovStepper (RefCountedPtr< ItoPlasmaPhysics > &a_physics) |
| | Full constructor. More...
|
| |
|
virtual | ~ItoPlasmaGodunovStepper () |
| | Destructor. Does nothing.
|
| |
| virtual Real | advance (const Real a_dt) override |
| | Advance the Ito-Poisson-KMC system over a_dt. More...
|
| |
|
virtual void | allocate () override |
| | Allocate storage required for advancing the equations.
|
| |
|
virtual void | parseOptions () override |
| | Parse options.
|
| |
|
virtual void | parseRuntimeOptions () override |
| | Parse run-time options.
|
| |
| virtual void | preRegrid (const int a_lmin, const int a_oldFinestLevel) override |
| | Perform pre-regrid operations. More...
|
| |
| virtual void | regrid (const int a_lmin, const int a_oldFinestLevel, const int a_newFinestLevel) override |
| | Regrid methods – puts all data on the new mesh. More...
|
| |
|
| ItoPlasmaStepper () |
| | Default constructor. Sets default options.
|
| |
| | ItoPlasmaStepper (RefCountedPtr< ItoPlasmaPhysics > &a_physics) |
| | Full constructor. Calls the other constructor. More...
|
| |
|
virtual | ~ItoPlasmaStepper () |
| | Destructor.
|
| |
|
virtual void | allocateInternals () |
| | Allocate "internal" storage.
|
| |
|
virtual void | setupSolvers () override |
| | Set up solvers.
|
| |
|
virtual void | initialData () override |
| | Fill solvers with initial data.
|
| |
| virtual void | postCheckpointSetup () override |
| | Perform post-checkpoint operations. More...
|
| |
| virtual void | postCheckpointPoisson () |
| | Do some post-checkpoint operations for the electrostatic part. More...
|
| |
|
virtual void | postInitialize () override |
| | Post-initialization operations. Default does nothing.
|
| |
| virtual void | writePlotData (EBAMRCellData &a_output, Vector< std::string > &a_plotVariableNames, int &a_icomp) const override |
| | Write plot data to output holder. More...
|
| |
|
virtual int | getNumberOfPlotVariables () const override |
| | Get number of plot variables for the output file.
|
| |
| virtual Vector< long int > | getCheckpointLoads (const std::string a_realm, const int a_level) const override |
| | Get computational loads to be checkpointed. More...
|
| |
|
virtual Real | computeDt () override |
| | Compute a time step used for the advance method.
|
| |
| virtual void | synchronizeSolverTimes (const int a_step, const Real a_time, const Real a_dt) override |
| | Synchronize solver times for all the solvers. More...
|
| |
|
virtual void | printStepReport () override |
| | Print a step report. Used by Driver for user monitoring of simulation.
|
| |
|
virtual void | registerRealms () override |
| | Register realms used for the simulation.
|
| |
|
virtual void | registerOperators () override |
| | Register operators used for the simulation.
|
| |
|
virtual void | postRegrid () override |
| | Perform post-regrid operations – default implementation does nothing.
|
| |
| virtual bool | loadBalanceThisRealm (const std::string a_realm) const override |
| | Load balancing query for a specified realm. If this returns true for a_realm, load balancing routines will be called during regrids for the input realm. More...
|
| |
| virtual void | loadBalanceBoxes (Vector< Vector< int >> &a_procs, Vector< Vector< Box >> &a_boxes, const std::string a_realm, const Vector< DisjointBoxLayout > &a_grids, const int a_lmin, const int a_finestLevel) override |
| | Load balance grid boxes for a specified realm. More...
|
| |
| virtual void | setIto (RefCountedPtr< ItoLayout< ItoSolver >> &a_itoLayout) noexcept |
| | Set the Ito layout. More...
|
| |
| virtual void | setFieldSolver (RefCountedPtr< FieldSolver > &a_fieldSolver) noexcept |
| | Set the field solver. More...
|
| |
| virtual void | setRadiativeTransferSolvers (RefCountedPtr< RtLayout< McPhoto >> &a_rteLayout) noexcept |
| | Set the radiative transfer solvers. More...
|
| |
| virtual void | setVoltage (const std::function< Real(const Real a_time)> &a_voltage) noexcept |
| | Set voltage used for the simulation. More...
|
| |
| virtual Real | getTime () const noexcept |
| | Get current simulation time. More...
|
| |
| virtual void | computeElectricField (EBAMRCellData &a_electricField, const phase::which_phase a_phase) const noexcept |
| | Recompute the electric field onto the specified data holder. More...
|
| |
|
| TimeStepper () |
| | Default constructor (does nothing)
|
| |
|
virtual | ~TimeStepper () |
| | Default destructor (does nothing)
|
| |
| void | setAmr (const RefCountedPtr< AmrMesh > &a_amr) |
| | Set AmrMesh. More...
|
| |
| void | setComputationalGeometry (const RefCountedPtr< ComputationalGeometry > &a_computationalGeometry) |
| | Set the computational geometry. More...
|
| |
| virtual bool | needToRegrid () |
| | Fuction which can have Driver do regrids at arbitrary points in the simulation. More...
|
| |
|
|
virtual void | parseAlgorithm () noexcept |
| | Parse advancement algorithm.
|
| |
|
virtual void | parseCheckpointParticles () noexcept |
| | Parse checkpoint-restart functionality.
|
| |
|
virtual void | setOldPositions () noexcept |
| | Set the starting positions for the ItoSolver particles.
|
| |
| virtual void | barrier () const noexcept |
| | Set an MPI barrier if using debug mode. More...
|
| |
| virtual void | remapPointParticles (Vector< RefCountedPtr< ParticleContainer< PointParticle >>> &a_particles, const SpeciesSubset a_subset) noexcept |
| | Remap the input point particles. More...
|
| |
| virtual void | depositPointParticles (const Vector< RefCountedPtr< ParticleContainer< PointParticle >>> &a_particles, const SpeciesSubset a_subset) noexcept |
| | Deposit the input point particles on the mesh. More...
|
| |
| virtual void | clearPointParticles (const Vector< RefCountedPtr< ParticleContainer< PointParticle >>> &a_particles, const SpeciesSubset a_subset) noexcept |
| | Clear the input particle data holders. More...
|
| |
| virtual void | computeConductivities (const Vector< RefCountedPtr< ParticleContainer< PointParticle >>> &a_particles) noexcept |
| | Compute all conductivities (cell, face, and EB) from the input point particles. More...
|
| |
| virtual void | computeCellConductivity (EBAMRCellData &a_conductivityCell, const Vector< RefCountedPtr< ParticleContainer< PointParticle >>> &a_particles) noexcept |
| | Compute the cell-centered conductivity. More...
|
| |
| virtual void | computeFaceConductivity () noexcept |
| | Compute the cell-centered conductivity. More...
|
| |
|
virtual void | setupSemiImplicitPoisson (const Real a_dt) noexcept |
| | Set up the semi-implicit Poisson solver.
|
| |
| virtual void | removeCoveredPointParticles (Vector< RefCountedPtr< ParticleContainer< PointParticle >>> &a_particles, const EBRepresentation a_representation, const Real a_tolerance) const noexcept |
| | Remove covered particles. More...
|
| |
| virtual void | copyConductivityParticles (Vector< RefCountedPtr< ParticleContainer< PointParticle >>> &a_conductivityParticles) noexcept |
| | Copy particles from the ItoSolver into PointParticles whose weight are ItoParticle::m_weight * ItoParticle::m_mobility. More...
|
| |
| virtual void | advanceParticlesEulerMaruyama (const Real a_dt) noexcept |
| | Advance the particles using the Euler-Maruyama scheme. More...
|
| |
| virtual void | diffuseParticlesEulerMaruyama (Vector< RefCountedPtr< ParticleContainer< PointParticle >>> &a_rhoDaggerParticles, const Real a_dt) noexcept |
| | Perform the diffusive advance in the Euler-Maruyama step. More...
|
| |
| virtual void | stepEulerMaruyama (const Real a_dt) noexcept |
| | Step the particles according to the regular Euler-Maruyama scheme. More...
|
| |
|
virtual void | setupIto () |
| | Set up the Ito particle solvers.
|
| |
|
virtual void | setupPoisson () |
| | Set up the electrostatic field solver.
|
| |
|
virtual void | setupRadiativeTransfer () |
| | Set up the radiative transfer solver.
|
| |
|
virtual void | setupSigma () |
| | Set up the surface charge solver.
|
| |
| virtual void | intersectParticles (const SpeciesSubset a_speciesSubset, const EBIntersection a_interactionAlg, const bool a_delete) noexcept |
| | Intersect a subset of the particles with the domain and embedded boundary. More...
|
| |
| virtual void | intersectParticles (const SpeciesSubset a_speciesSubset, const ItoSolver::WhichContainer a_containerBulk, const ItoSolver::WhichContainer a_containerEB, const ItoSolver::WhichContainer a_containerDomain, const EBIntersection a_intersectionAlg, const bool a_delete) noexcept |
| | Intersect a subset of the particles with the domain and embedded boundary. More...
|
| |
| virtual void | removeCoveredParticles (const SpeciesSubset a_which, const EBRepresentation a_representation, const Real a_tolerance) noexcept |
| | Remove covered particles (i.e., particles inside the EB) More...
|
| |
| virtual void | removeCoveredParticles (const SpeciesSubset a_which, const ItoSolver::WhichContainer a_container, const EBRepresentation a_representation, const Real a_tolerance) noexcept |
| | Remove covered particles (i.e., particles inside the EB) More...
|
| |
| virtual void | transferCoveredParticles (const SpeciesSubset a_speciesSubset, const EBRepresentation a_representation, const Real a_tolerance) noexcept |
| | Transfer covered particles (i.e., particles inside the EB) from the ItoSolver bulk container to EB container. More...
|
| |
| virtual void | transferCoveredParticles (const SpeciesSubset a_speciesSubset, const ItoSolver::WhichContainer a_containerFrom, const ItoSolver::WhichContainer a_containerTo, const EBRepresentation a_representation, const Real a_tolerance) noexcept |
| | Transfer covered particles (i.e., particles inside the EB) from the ItoSolver bulk container to EB container. More...
|
| |
| virtual void | writeNumParticlesPerPatch (EBAMRCellData &a_output, int &a_icomp) const |
| | Write number of particles per patch to output holder. More...
|
| |
| virtual void | getMaxMinItoDensity (Real &a_maxDensity, Real &a_minDensity, std::string &a_maxSolver, std::string &a_minSolver) const noexcept |
| | Get maximum density of the Ito species. More...
|
| |
| virtual void | getParticleStatistics (Real &a_avgParticles, Real &a_sigma, Real &a_minParticles, Real &a_maxParticles, int &a_minRank, int &a_maxRank) |
| | Compute some particle statistics. More...
|
| |
| virtual void | loadBalanceParticleRealm (Vector< Vector< int >> &a_procs, Vector< Vector< Box >> &a_boxes, const std::string a_realm, const Vector< DisjointBoxLayout > &a_grids, const int a_lmin, const int a_finestLevel) noexcept |
| | Routine called by loadBalanceBoxes and used for particle-based load balancing. More...
|
| |
| virtual void | loadBalanceFluidRealm (Vector< Vector< int >> &a_procs, Vector< Vector< Box >> &a_boxes, const std::string a_realm, const Vector< DisjointBoxLayout > &a_grids, const int a_lmin, const int a_finestLevel) noexcept |
| | Routine called by loadBalanceBoxes and used for particle-based load balancing. More...
|
| |
| virtual Vector< RefCountedPtr< ItoSolver > > | getLoadBalanceSolvers () const noexcept |
| | Get the solvers used for load balancing. More...
|
| |
| virtual Real | computeMaxElectricField (const phase::which_phase a_phase) noexcept |
| | Compute the maximum electric field (norm) More...
|
| |
| virtual void | computeSpaceChargeDensity () noexcept |
| | Compute the space charge. Calls the other version. More...
|
| |
| virtual void | computeSpaceChargeDensity (MFAMRCellData &a_rho, const Vector< EBAMRCellData * > &a_densities) noexcept |
| | Compute the space charge density (both phases) More...
|
| |
| virtual void | computeConductivityCell (EBAMRCellData &a_conductivity) noexcept |
| | Compute the cell-centered conductiivty. More...
|
| |
| virtual void | computeConductivityCell (EBAMRCellData &a_conductivity, const Vector< ParticleContainer< ItoParticle > * > &a_particles) noexcept |
| | Compute the cell-centered conductiivty. More...
|
| |
| virtual void | computeCurrentDensity (EBAMRCellData &a_J) noexcept |
| | Compute the current density. More...
|
| |
|
virtual Real | computeRelaxationTime () noexcept |
| | Compute the dielectric relaxation time.
|
| |
| virtual bool | solvePoisson () noexcept |
| | Solve the electrostatic problem. More...
|
| |
| virtual void | depositParticles (const SpeciesSubset a_speciesSubset) noexcept |
| | Deposit a subset of the ItoSolver particles on the mesh. More...
|
| |
| virtual void | depositParticles (const SpeciesSubset a_speciesSubset, const ItoSolver::WhichContainer a_container) noexcept |
| | Deposit a subset of the ItoSolver particles on the mesh. More...
|
| |
| virtual void | remapParticles (const SpeciesSubset a_speciesSubset) noexcept |
| | Remap a subset of ItoSolver particles. More...
|
| |
| virtual void | remapParticles (const SpeciesSubset a_speciesSubset, const ItoSolver::WhichContainer a_container) noexcept |
| | Remap a subset of ItoSolver particles. More...
|
| |
| virtual void | setItoVelocityFunctions () noexcept |
| | Set the Ito velocity functions. This is sgn(charge) * E. More...
|
| |
| virtual void | computeItoVelocities () noexcept |
| | Compute ItoSolver velocities. More...
|
| |
| virtual void | computeItoDiffusion () noexcept |
| | Compute ItoSolver velocities. More...
|
| |
| virtual void | computeItoMobilitiesLFA () noexcept |
| | Compute mesh-based mobilities for LFA coupling. More...
|
| |
| virtual void | computeItoMobilitiesLFA (Vector< EBAMRCellData * > &a_meshMobilities, const EBAMRCellData &a_electricField, const Real a_time) noexcept |
| | Compute mesh-based mobilities for LFA coupling. More...
|
| |
| virtual void | computeItoMobilitiesLFA (Vector< LevelData< EBCellFAB > * > &a_meshMobilities, const LevelData< EBCellFAB > &a_E, const int a_level, const Real a_time) noexcept |
| | Level-routine when computing mesh-based mobilities for LFA coupling. More...
|
| |
| virtual void | computeItoMobilitiesLFA (Vector< EBCellFAB * > &a_meshMobilities, const EBCellFAB &a_electricField, const int a_level, const DataIndex a_dit, const Box a_cellBox, const Real a_time) noexcept |
| | Patch-routine when computing mesh-based mobilities for LFA coupling. More...
|
| |
| virtual void | computeItoMobilitiesLEA () noexcept |
| | Compute the IonSolver particle mobilities in the LEA coupling regime. More...
|
| |
| virtual void | computeItoDiffusionLFA () noexcept |
| | Compute mesh-based diffusion coefficients for LFA coupling. More...
|
| |
| virtual void | computeItoDiffusionLFA (Vector< EBAMRCellData * > &a_diffusionCoefficient, const EBAMRCellData &a_electricField, const Real a_time) noexcept |
| | Compute mesh-based diffusion coefficients for LFA coupling. More...
|
| |
| virtual void | computeItoDiffusionLFA (Vector< LevelData< EBCellFAB > * > &a_diffusionCoefficient, const LevelData< EBCellFAB > &a_electricField, const int a_level, const Real a_time) noexcept |
| | Level-routine when computing mesh-based mobilities for LFA coupling. More...
|
| |
| virtual void | computeItoDiffusionLFA (Vector< EBCellFAB * > &a_diffusionCoefficient, const EBCellFAB &a_E, const int a_level, const DataIndex a_dit, const Box a_box, const Real a_time) noexcept |
| | Patch-routine when computing mesh-based diffusion coefficients in the LFA coupling. More...
|
| |
| virtual void | computeItoDiffusionLEA () noexcept |
| | Compute the IonSolver particle diffusion coefficients in the LEA coupling regime. More...
|
| |
| virtual void | getPhysicalParticlesPerCell (EBAMRCellData &a_ppc) const noexcept |
| | Get the physical number of particles per cell. More...
|
| |
| virtual void | computeReactiveParticlesPerCell (EBAMRCellData &a_ppc) noexcept |
| | Compute the number of reactive particles per cell. More...
|
| |
| virtual void | computeReactiveParticlesPerCell (LevelData< EBCellFAB > &a_ppc, const int a_level) noexcept |
| | Compute the number of reactive particles per cell. More...
|
| |
| virtual void | computeReactiveParticlesPerCell (EBCellFAB &a_ppc, const int a_level, const DataIndex a_dit, const Box a_box, const EBISBox &a_ebisbox) noexcept |
| | Compute the number of reactive particles per cell. More...
|
| |
| virtual void | computeReactiveMeanEnergiesPerCell (EBAMRCellData &a_meanEnergies) noexcept |
| | Compute the mean particle energy in all grid cells. More...
|
| |
| virtual void | computeReactiveMeanEnergiesPerCell (LevelData< EBCellFAB > &a_meanEnergies, const int a_level) noexcept |
| | Compute the mean particle energy in all grid cells. Level version. More...
|
| |
| virtual void | computeReactiveMeanEnergiesPerCell (EBCellFAB &a_meanEnergies, const int a_level, const DataIndex a_dit, const Box a_box, const EBISBox &a_ebisbox) noexcept |
| | Compute the mean particle energy in all grid cells. Patch version. More...
|
| |
| virtual void | advanceReactionNetwork (const Real a_dt) noexcept |
| | Chemistry advance over time a_dt. More...
|
| |
| virtual void | advanceReactionNetwork (const EBAMRCellData &a_E, const EBAMRCellData &a_EdotJ, const Real a_dt) noexcept |
| | Chemistry advance over time a_dt. AMR version. More...
|
| |
| virtual void | advanceReactionNetwork (LevelData< EBCellFAB > &a_particlesPerCell, LevelData< EBCellFAB > &a_newPhotonsPerCell, LevelData< EBCellFAB > &a_meanParticleEnergies, const LevelData< EBCellFAB > &a_electricField, const LevelData< EBCellFAB > &a_EdotJ, const int a_level, const Real a_dt) noexcept |
| | Chemistry advance over time a_dt. Level version. More...
|
| |
| virtual void | advanceReactionNetwork (EBCellFAB &a_particlesPerCell, EBCellFAB &a_newPhotonsPerCell, EBCellFAB &a_meanParticleEnergies, const EBCellFAB &a_electricField, const EBCellFAB &a_EdotJ, const int a_level, const DataIndex a_dit, const Box a_box, const Real a_dx, const Real a_dt) noexcept |
| | Chemistry advance over time a_dt. Patch version. More...
|
| |
| virtual void | reconcileParticles (const EBAMRCellData &a_newParticlesPerCell, const EBAMRCellData &a_oldParticlesPerCell, const EBAMRCellData &a_meanParticleEnergies, const EBAMRCellData &a_newPhotonsPerCell) noexcept |
| | Reconcile particles. At the bottom, this will call the physics interface for particle reconciliation. More...
|
| |
| virtual void | reconcileParticles (const LevelData< EBCellFAB > &a_newParticlesPerCell, const LevelData< EBCellFAB > &a_oldParticlesPerCell, const LevelData< EBCellFAB > &a_meanParticleEnergies, const LevelData< EBCellFAB > &a_newPhotonsPerCell, const int a_level) noexcept |
| | Reconcile particles. At the bottom, this will call the physics interface for particle reconciliation. More...
|
| |
| virtual void | reconcileParticles (const EBCellFAB &a_newParticlesPerCell, const EBCellFAB &a_oldParticlesPerCell, const EBCellFAB &a_meanParticleEnergies, const EBCellFAB &a_newPhotonsPerCell, const int a_level, const DataIndex a_dit, const Box a_box, const Real a_dx) noexcept |
| | Reconcile particles. At the bottom, this will call the physics interface for particle reconciliation. More...
|
| |
| virtual void | resolveParticlesEB (const Real a_dt) noexcept |
| | Resolve particle injection at EBs. More...
|
| |
| virtual void | resolveParticlesEB (Vector< ParticleContainer< ItoParticle > * > &a_inOutParticles, Vector< ParticleContainer< Photon > * > &a_inOutPhotons, const EBAMRCellData &a_electricField, const Real a_dt) noexcept |
| | Resolve particle injection at EBs. More...
|
| |
| virtual void | injectParticlesEB () noexcept |
| | Inject particles through the EB. More...
|
| |
|
virtual void | injectParticlesEB (Vector< ParticleContainer< ItoParticle > * > a_bulkParticles, Vector< ParticleContainer< ItoParticle > * > a_injectedParticles) noexcept |
| | Inject particles through the EB.
|
| |
| virtual Real | computePhysicsDt () noexcept |
| | Compute a maximum time step from the physics interface. More...
|
| |
| virtual Real | computePhysicsDt (const EBAMRCellData &a_electricField) noexcept |
| | Compute a maximum time step from the physics interface. More...
|
| |
| virtual Real | computePhysicsDt (const LevelData< EBCellFAB > &a_electricField, const LevelData< EBCellFAB > &a_particlesPerCell, const int a_level) noexcept |
| | Compute a maximum time step from the physics interface. More...
|
| |
| virtual Real | computePhysicsDt (const EBCellFAB &a_electricField, const EBCellFAB &a_particlesPercCell, const int a_level, const DataIndex a_dit, const Box a_box) noexcept |
| | Compute a maximum time step from the physics interface. More...
|
| |
| virtual void | advancePhotons (const Real a_dt) noexcept |
| | Photon advancement routine. More...
|
| |
| virtual void | sortPhotonsByCell (const McPhoto::WhichContainer a_which) noexcept |
| | Sort photons by cells. More...
|
| |
| virtual void | sortPhotonsByPatch (const McPhoto::WhichContainer a_which) noexcept |
| | Sort photons by patch. More...
|
| |
| virtual void | computeEdotJSource (const Real a_dt) noexcept |
| | Compute the energy source term for the various plasma species. More...
|
| |
|
virtual void | initialSigma () |
| | Fill surface charge solver with initial data.
|
| |
| virtual void | parseVerbosity () noexcept |
| | Parse chattiness. More...
|
| |
|
virtual void | parseAbort () noexcept |
| | Parse abort on failure.
|
| |
| virtual void | parseSuperParticles () noexcept |
| | Parse the desired number of particles per cell. More...
|
| |
| virtual void | parseDualGrid () noexcept |
| | Parse dual or single realm calculations. More...
|
| |
|
virtual void | parseLoadBalance () noexcept |
| | Parse load balancing.
|
| |
|
virtual void | parseTimeStepRestrictions () noexcept |
| | Parse time step restrictions.
|
| |
|
virtual void | parseParametersEB () noexcept |
| | Parse things related to the EB.
|
| |
|
virtual void | parsePlotVariables () noexcept |
| | Parse plot variables.
|
| |