|
|
| ItoKMCGodunovStepper ()=delete |
| | Disallowed default constructor. Use the full constructor.
|
| |
| | ItoKMCGodunovStepper (RefCountedPtr< ItoKMCPhysics > &a_physics) |
| | Full constructor.
|
| |
|
virtual | ~ItoKMCGodunovStepper () |
| | Destructor. Does nothing.
|
| |
| virtual Real | computeDt () override |
| | Compute a time step used for the advance method.
|
| |
| virtual Real | advance (const Real a_dt) override |
| | Advance the Ito-Poisson-KMC system over a_dt.
|
| |
| virtual void | allocate () noexcept override |
| | Allocate storage required for advancing the equations.
|
| |
| virtual void | parseOptions () noexcept override |
| | Parse options.
|
| |
| virtual void | parseRuntimeOptions () noexcept override |
| | Parse run-time options.
|
| |
| virtual void | preRegrid (const int a_lmin, const int a_oldFinestLevel) noexcept override |
| | Perform pre-regrid operations.
|
| |
| virtual void | registerOperators () noexcept override |
| | Register operators used for the simulation.
|
| |
| virtual void | regrid (const int a_lmin, const int a_oldFinestLevel, const int a_newFinestLevel) noexcept override |
| | Regrid methods – puts all data on the new mesh.
|
| |
| virtual void | postPlot () noexcept override |
| | Perform post-plot operations.
|
| |
|
| ItoKMCStepper () noexcept |
| | Default constructor. Sets default options.
|
| |
| | ItoKMCStepper (RefCountedPtr< ItoKMCPhysics > &a_physics) noexcept |
| | Full constructor. Calls the other constructor.
|
| |
|
virtual | ~ItoKMCStepper () noexcept |
| | Destructor.
|
| |
| virtual void | setupSolvers () noexcept override |
| | Set up solvers.
|
| |
| virtual void | initialData () noexcept override |
| | Fill solvers with initial data.
|
| |
| virtual void | postCheckpointSetup () noexcept override |
| | Perform post-checkpoint operations.
|
| |
| virtual void | postInitialize () noexcept override |
| | Post-initialization operations. Default does nothing.
|
| |
| virtual int | getNumberOfPlotVariables () const noexcept override |
| | Get number of plot variables for the output file.
|
| |
| virtual Vector< std::string > | getPlotVariableNames () const noexcept override |
| | Get plot variable names.
|
| |
| virtual void | writePlotData (LevelData< EBCellFAB > &a_output, int &a_icomp, const std::string a_outputRealm, const int a_level) const noexcept override |
| | Write plot data to output holder.
|
| |
| virtual Vector< long int > | getCheckpointLoads (const std::string a_realm, const int a_level) const override |
| | Get computational loads to be checkpointed.
|
| |
| virtual void | synchronizeSolverTimes (const int a_step, const Real a_time, const Real a_dt) noexcept override |
| | Synchronize solver times for all the solvers.
|
| |
| virtual void | printStepReport () noexcept override |
| | Print a step report. Used by Driver for user monitoring of simulation.
|
| |
| virtual void | registerRealms () noexcept override |
| | Register realms used for the simulation.
|
| |
| virtual void | prePlot () noexcept override |
| | Perform pre-plot operations.
|
| |
| virtual void | postRegrid () noexcept override |
| | Perform post-regrid operations.
|
| |
| 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.
|
| |
| 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.
|
| |
| virtual void | setVoltage (const std::function< Real(const Real a_time)> &a_voltage) noexcept |
| | Set voltage used for the simulation.
|
| |
| virtual Real | getTime () const noexcept |
| | Get current simulation time.
|
| |
| virtual void | computeElectricField (EBAMRCellData &a_electricField, const phase::which_phase a_phase) const noexcept |
| | Recompute the electric field onto the specified data holder.
|
| |
|
| TimeStepper () |
| | Default constructor (does nothing)
|
| |
|
virtual | ~TimeStepper () |
| | Default destructor (does nothing)
|
| |
| void | setAmr (const RefCountedPtr< AmrMesh > &a_amr) |
| | Set AmrMesh.
|
| |
| void | setComputationalGeometry (const RefCountedPtr< ComputationalGeometry > &a_computationalGeometry) |
| | Set the computational geometry.
|
| |
| virtual bool | needToRegrid () |
| | Fuction which can have Driver do regrids at arbitrary points in the simulation.
|
| |
|
| virtual void | allocateInternals () noexcept override |
| | Allocate "internal" storage.
|
| |
|
virtual void | parseAlgorithm () noexcept |
| | Parse advancement algorithm.
|
| |
|
virtual void | parseFiltering () noexcept |
| | Parse filter settings.
|
| |
|
virtual void | parseCheckpointParticles () noexcept |
| | Parse checkpoint-restart functionality.
|
| |
|
virtual void | parseSecondaryEmissionSpecification () noexcept |
| | Parse when secondary particles are emitted.
|
| |
|
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.
|
| |
| virtual void | remapPointParticles (Vector< RefCountedPtr< ParticleContainer< PointParticle > > > &a_particles, const SpeciesSubset a_subset) noexcept |
| | Remap the input point particles.
|
| |
| virtual void | depositPointParticles (const Vector< RefCountedPtr< ParticleContainer< PointParticle > > > &a_particles, const SpeciesSubset a_subset) noexcept |
| | Deposit the input point particles on the mesh.
|
| |
| virtual void | clearPointParticles (const Vector< RefCountedPtr< ParticleContainer< PointParticle > > > &a_particles, const SpeciesSubset a_subset) noexcept |
| | Clear the input particle data holders.
|
| |
| virtual void | computeConductivities (const Vector< RefCountedPtr< ParticleContainer< PointParticle > > > &a_particles) noexcept |
| | Compute all conductivities (cell, face, and EB) from the input point particles.
|
| |
| virtual void | computeCellConductivity (EBAMRCellData &a_conductivityCell, const Vector< RefCountedPtr< ParticleContainer< PointParticle > > > &a_particles) noexcept |
| | Compute the cell-centered conductivity.
|
| |
| virtual void | computeFaceConductivity () noexcept |
| | Compute the cell-centered conductivity.
|
| |
|
virtual void | computeSemiImplicitRho () noexcept |
| | Set up the space charge density for the regrid operation.
|
| |
|
virtual void | setupSemiImplicitPoisson (const Real a_dt) noexcept |
| | Set up the semi-implicit Poisson solver.
|
| |
| virtual bool | solvePoisson () noexcept override |
| | Solve the electrostatic problem.
|
| |
| virtual void | removeCoveredPointParticles (Vector< RefCountedPtr< ParticleContainer< PointParticle > > > &a_particles, const EBRepresentation a_representation, const Real a_tolerance) const noexcept |
| | Remove covered particles.
|
| |
| 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.
|
| |
| virtual void | advanceEulerMaruyama (const Real a_dt) noexcept |
| | Advance the particles using the Euler-Maruyama scheme.
|
| |
| virtual void | diffuseParticlesEulerMaruyama (Vector< RefCountedPtr< ParticleContainer< PointParticle > > > &a_rhoDaggerParticles, const Real a_dt) noexcept |
| | Perform the diffusive Ito advance in the Euler-Maruyama step.
|
| |
| virtual void | computeDiffusionTermCDR (EBAMRCellData &m_semiImplicitRhoCDR, const Real a_dt) noexcept |
| | Compute the diffusion term for the CDR equations as well as the resulting CDR-contributions to the space charge density.
|
| |
| virtual void | stepEulerMaruyamaParticles (const Real a_dt) noexcept |
| | Step the particles according to the regular Euler-Maruyama scheme.
|
| |
| virtual void | stepEulerMaruyamaCDR (const Real a_dt) noexcept |
| | Step the CDR equations according to the regular Euler-Maruyama scheme.
|
| |
|
virtual void | plotParticles () const noexcept |
| | Utility function for plotting the ItoSolver particles. These are written in a particles folder.
|
| |
|
virtual void | setupIto () noexcept |
| | Set up the Ito particle solvers.
|
| |
|
virtual void | setupCdr () noexcept |
| | Set up the CDR solvers.
|
| |
|
virtual void | setupRadiativeTransfer () noexcept |
| | Set up the radiative transfer solver.
|
| |
|
virtual void | setupPoisson () noexcept |
| | Set up the electrostatic field solver.
|
| |
|
virtual void | setupSigma () noexcept |
| | Set up the surface charge solver.
|
| |
| virtual void | intersectParticles (const SpeciesSubset a_speciesSubset, const bool a_delete, const std::function< void(ItoParticle &)> a_nonDeletionModifier=[](ItoParticle &) -> void { return;}) noexcept |
| | Intersect a subset of the particles with the domain and embedded boundary.
|
| |
| virtual void | intersectParticles (const SpeciesSubset a_speciesSubset, const ItoSolver::WhichContainer a_containerBulk, const ItoSolver::WhichContainer a_containerEB, const ItoSolver::WhichContainer a_containerDomain, const bool a_delete, const std::function< void(ItoParticle &)> a_nonDeletionModifier=[](ItoParticle &) -> void { return;}) noexcept |
| | Intersect a subset of the particles with the domain and embedded boundary.
|
| |
| 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)
|
| |
| 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)
|
| |
| 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.
|
| |
| 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.
|
| |
| virtual void | writeData (LevelData< EBCellFAB > &a_output, int &a_comp, const EBAMRCellData &a_data, const std::string a_outputRealm, const int a_level, const bool a_interpToCentroids, const bool a_interpGhost) const noexcept |
| | Write data to output. Convenience function.
|
| |
| virtual void | writeNumberOfParticlesPerPatch (LevelData< EBCellFAB > &a_output, int &a_icomp, const std::string a_outputRealm, const int a_level) const noexcept |
| | Write number of particles per patch to output holder.
|
| |
| virtual void | getMaxMinRelativeItoDensity (Real &a_maxDensity, Real &a_minDensity, std::string &a_maxSolver, std::string &a_minSolver) const noexcept |
| | Get maximum density of the Ito species (only for charged species)
|
| |
| virtual void | getMaxMinRelativeCDRDensity (Real &a_maxDensity, Real &a_minDensity, std::string &a_maxSolver, std::string &a_minSolver) const noexcept |
| | Get maximum density of the CDR species (only for charged species)
|
| |
| 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.
|
| |
| 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.
|
| |
| 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.
|
| |
| virtual Vector< RefCountedPtr< ItoSolver > > | getLoadBalanceSolvers () const noexcept |
| | Get the solvers used for load balancing.
|
| |
| virtual void | fillNeutralDensity () noexcept |
| | Compute the neutral density on the mesh.
|
| |
| virtual Real | computeMaxReducedElectricField (const phase::which_phase a_phase) const noexcept |
| | Compute the maximum electric field (norm)
|
| |
| virtual void | computeSpaceChargeDensity () noexcept |
| | Compute the space charge. Calls the other version.
|
| |
| virtual void | computeSpaceChargeDensity (MFAMRCellData &a_rho, const Vector< EBAMRCellData * > &a_itoDensities, const Vector< EBAMRCellData * > &a_cdrDensities) noexcept |
| | Compute the space charge density.
|
| |
| virtual void | computeConductivityCell (EBAMRCellData &a_conductivity) noexcept |
| | Compute the cell-centered conductiivty.
|
| |
| virtual void | computeConductivityCell (EBAMRCellData &a_conductivity, const Vector< ParticleContainer< ItoParticle > * > &a_particles) noexcept |
| | Compute the cell-centered conductiivty.
|
| |
| virtual void | computeDensityGradients () noexcept |
| | Compute grad(phi) and phi for both CDR and Ito species and put the result on the fluid realm.
|
| |
| virtual void | computeCurrentDensity (EBAMRCellData &a_J) noexcept |
| | Compute the current density.
|
| |
|
virtual Real | computeRelaxationTime () noexcept |
| | Compute the dielectric relaxation time.
|
| |
| virtual void | depositParticles (const SpeciesSubset a_speciesSubset) noexcept |
| | Deposit a subset of the ItoSolver particles on the mesh.
|
| |
| virtual void | depositParticles (const SpeciesSubset a_speciesSubset, const ItoSolver::WhichContainer a_container) noexcept |
| | Deposit a subset of the ItoSolver particles on the mesh.
|
| |
| virtual void | remapParticles (const SpeciesSubset a_speciesSubset) noexcept |
| | Remap a subset of ItoSolver particles.
|
| |
| virtual void | remapParticles (const SpeciesSubset a_speciesSubset, const ItoSolver::WhichContainer a_container) noexcept |
| | Remap a subset of ItoSolver particles.
|
| |
| virtual void | computeDriftVelocities () noexcept |
| | Compute ItoSolver velocities.
|
| |
| virtual void | setItoVelocityFunctions () noexcept |
| | Set the Ito velocity functions. This is sgn(charge) * E.
|
| |
| virtual void | setCdrVelocityFunctions () noexcept |
| | Set the Cdr velocities to be sgn(charge) * E.
|
| |
|
virtual void | multiplyCdrVelocitiesByMobilities () noexcept |
| | Multiply CDR solver velocities by mobilities.
|
| |
| virtual void | computeMobilities () noexcept |
| | Compute mesh-based mobilities for LFA coupling.
|
| |
| virtual void | computeMobilities (Vector< EBAMRCellData * > &a_itoMobilities, Vector< EBAMRCellData > &a_cdrMobilities, const EBAMRCellData &a_electricField, const Real a_time) noexcept |
| | Compute mesh-based mobilities for LFA coupling.
|
| |
| virtual void | computeMobilities (Vector< LevelData< EBCellFAB > * > &a_itoMobilities, Vector< LevelData< EBCellFAB > * > &a_cdrMobilities, const LevelData< EBCellFAB > &a_E, const int a_level, const Real a_time) noexcept |
| | Level-routine when computing mesh-based mobilities for LFA coupling.
|
| |
| virtual void | computeMobilities (Vector< EBCellFAB * > &a_itoMobilities, Vector< EBCellFAB * > &a_cdrMobilities, const EBCellFAB &a_electricField, const int a_level, const DataIndex a_din, const Box a_cellBox, const Real a_time) noexcept |
| | Patch-routine when computing mesh-based mobilities for LFA coupling.
|
| |
| virtual void | computeDiffusionCoefficients () noexcept |
| | Compute mesh-based diffusion coefficients for LFA coupling.
|
| |
| virtual void | computeDiffusionCoefficients (Vector< EBAMRCellData * > &a_itoDiffusionCoefficients, Vector< EBAMRCellData * > &a_cdrDiffusionCoefficients, const EBAMRCellData &a_electricField, const Real a_time) noexcept |
| | Compute mesh-based diffusion coefficients for LFA coupling.
|
| |
| virtual void | computeDiffusionCoefficients (Vector< LevelData< EBCellFAB > * > &a_itoDiffusionCoefficients, Vector< LevelData< EBCellFAB > * > &a_cdrDiffusionCoefficients, const LevelData< EBCellFAB > &a_electricField, const int a_level, const Real a_time) noexcept |
| | Level-routine when computing mesh-based mobilities for LFA coupling.
|
| |
| virtual void | computeDiffusionCoefficients (Vector< EBCellFAB * > &a_itoDiffusionCoefficients, Vector< EBCellFAB * > &a_cdrDiffusionCoefficients, const EBCellFAB &a_E, const int a_level, const DataIndex a_din, const Box a_box, const Real a_time) noexcept |
| | Patch-routine when computing mesh-based diffusion coefficients in the LFA coupling.
|
| |
|
virtual void | averageDiffusionCoefficientsCellToFace () noexcept |
| | Average cell-centered diffusion coefficient to faces.
|
| |
| virtual void | getPhysicalParticlesPerCell (EBAMRCellData &a_ppc) const noexcept |
| | Get the physical number of particles per cell.
|
| |
| virtual void | computeReactiveItoParticlesPerCell (EBAMRCellData &a_ppc) noexcept |
| | Compute the number of reactive particles per cell.
|
| |
| virtual void | computeReactiveItoParticlesPerCell (LevelData< EBCellFAB > &a_ppc, const int a_level) noexcept |
| | Compute the number of reactive particles per cell.
|
| |
| virtual void | computeReactiveItoParticlesPerCell (EBCellFAB &a_ppc, const int a_level, const DataIndex a_din, const Box a_box, const EBISBox &a_ebisbox) noexcept |
| | Compute the number of reactive particles per cell.
|
| |
| virtual void | computeReactiveCdrParticlesPerCell (EBAMRCellData &a_ppc) noexcept |
| | Compute the number of reactive particles per cell for the CDR solvers.
|
| |
| virtual void | computeReactiveCdrParticlesPerCell (LevelData< EBCellFAB > &a_ppc, const int a_level) noexcept |
| | Compute the number of reactive particles per cell for the CDR solvers.
|
| |
| virtual void | computeReactiveCdrParticlesPerCell (EBCellFAB &a_ppc, const int a_level, const DataIndex a_din, const Box a_box, const EBISBox &a_ebisbox) noexcept |
| | Compute the number of reactive particles per cell for the CDR solvers.
|
| |
| virtual void | computeReactiveMeanEnergiesPerCell (EBAMRCellData &a_meanEnergies) noexcept |
| | Compute the mean particle energy in all grid cells.
|
| |
| virtual void | computeReactiveMeanEnergiesPerCell (LevelData< EBCellFAB > &a_meanEnergies, const int a_level) noexcept |
| | Compute the mean particle energy in all grid cells. Level version.
|
| |
| virtual void | computeReactiveMeanEnergiesPerCell (EBCellFAB &a_meanEnergies, const int a_level, const DataIndex a_din, const Box a_box, const EBISBox &a_ebisbox) noexcept |
| | Compute the mean particle energy in all grid cells. Patch version.
|
| |
| virtual void | advanceReactionNetwork (const Real a_dt) noexcept |
| | Chemistry advance over time a_dt.
|
| |
| virtual void | advanceReactionNetwork (const EBAMRCellData &a_E, const Real a_dt) noexcept |
| | Chemistry advance over time a_dt. AMR version.
|
| |
| void | advanceReactionNetwork (LevelData< EBCellFAB > &a_particlesPerCell, LevelData< EBCellFAB > &a_newPhotonsPerCell, const LevelData< EBCellFAB > &a_electricField, const int a_level, const Real a_dt) const noexcept |
| | Chemistry advance over time a_dt. Level version.
|
| |
| void | advanceReactionNetwork (EBCellFAB &a_particlesPerCell, EBCellFAB &a_newPhotonsPerCell, const EBCellFAB &a_electricField, const int a_level, const DataIndex a_din, const Box a_box, const Real a_dx, const Real a_dt) const noexcept |
| | Chemistry advance over time a_dt. Patch version.
|
| |
| void | reconcileParticles (const EBAMRCellData &a_newParticlesPerCell, const EBAMRCellData &a_oldParticlesPerCell, const EBAMRCellData &a_newPhotonsPerCell, const EBAMRCellData &a_electricField) const noexcept |
| | Reconcile particles. At the bottom, this will call the physics interface for particle reconciliation.
|
| |
| void | reconcileParticles (const LevelData< EBCellFAB > &a_newParticlesPerCell, const LevelData< EBCellFAB > &a_oldParticlesPerCell, const LevelData< EBCellFAB > &a_newPhotonsPerCell, const LevelData< EBCellFAB > &a_electricField, const int a_level) const noexcept |
| | Reconcile particles. At the bottom, this will call the physics interface for particle reconciliation.
|
| |
| void | reconcileParticles (const EBCellFAB &a_newParticlesPerCell, const EBCellFAB &a_oldParticlesPerCell, const EBCellFAB &a_newPhotonsPerCell, const EBCellFAB &a_electricField, const int a_level, const DataIndex a_din, const Box a_box, const Real a_dx) const noexcept |
| | Reconcile particles. At the bottom, this will call the physics interface for particle reconciliation.
|
| |
| virtual void | reconcilePhotoionization () noexcept |
| | Reconcile the results from photoionization reactions.
|
| |
| virtual void | reconcileCdrDensities (const EBAMRCellData &a_newParticlesPerCell, const EBAMRCellData &a_oldParticlesPerCell, const Real a_dt) noexcept |
| | Reconcile the CDR densities after the reaction network.
|
| |
| virtual void | reconcileCdrDensities (const LevelData< EBCellFAB > &a_newParticlesPerCell, const LevelData< EBCellFAB > &a_oldParticlesPerCell, const int a_level, const Real a_dt) noexcept |
| | Reconcile the CDR densities after the reaction network.
|
| |
| virtual void | reconcileCdrDensities (const EBCellFAB &a_newParticlesPerCell, const EBCellFAB &a_oldParticlesPerCell, const int a_level, const DataIndex a_din, const Box a_box, const Real a_dx, const Real a_dt) noexcept |
| | Reconcile the CDR densities after the reaction network.
|
| |
|
virtual void | coarsenCDRSolvers () noexcept |
| | Coarsen data for CDR solvers.
|
| |
| virtual void | fillSecondaryEmissionEB (const Real a_dt) noexcept |
| | Resolve particle injection at EBs.
|
| |
| virtual void | fillSecondaryEmissionEB (Vector< ParticleContainer< ItoParticle > > &a_secondaryParticles, Vector< EBAMRIVData > &a_cdrFluxes, Vector< ParticleContainer< Photon > > &a_secondaryPhotons, Vector< ParticleContainer< ItoParticle > * > &a_primaryParticles, Vector< EBAMRIVData > &a_cdrFluxesExtrap, Vector< ParticleContainer< Photon > * > &a_primaryPhotons, const EBAMRCellData &a_electricField, const Real a_dt) noexcept |
| | Compute secondary emission at the EB.
|
| |
| virtual void | resolveSecondaryEmissionEB (const Real a_dt) noexcept |
| | Resolve secondary emission at the EB.
|
| |
| virtual void | resolveSecondaryEmissionEB (Vector< ParticleContainer< ItoParticle > * > &a_secondaryParticles, Vector< ParticleContainer< ItoParticle > * > &a_primaryParticles, Vector< EBAMRIVData * > &a_cdrFluxes, EBAMRIVData &a_surfaceChargeDensity, const Real a_dt) noexcept |
| | Resolve secondary emission at the EB.
|
| |
| virtual void | computePhysicsDt () noexcept |
| | Compute a physics-based maximum time step.
|
| |
| virtual void | computeDummyPhysicsDt () noexcept |
| | Special routine which performs a dummy KMC advance over a zero time step.
|
| |
|
virtual Real | computeTotalCharge () const noexcept |
| | Compute total charge.
|
| |
|
virtual Real | computeQplus () const noexcept |
| | Compute positive charge.
|
| |
|
virtual Real | computeQminu () const noexcept |
| | Compute negative charge.
|
| |
|
virtual Real | computeQsurf () const noexcept |
| | Compute surface charge.
|
| |
| virtual void | advancePhotons (const Real a_dt) noexcept |
| | Photon advancement routine.
|
| |
| virtual void | sortPhotonsByCell (const McPhoto::WhichContainer a_which) noexcept |
| | Sort photons by cells.
|
| |
| virtual void | sortPhotonsByPatch (const McPhoto::WhichContainer a_which) noexcept |
| | Sort photons by patch.
|
| |
| virtual void | postCheckpointPoisson () noexcept |
| | Do some post-checkpoint operations for the electrostatic part.
|
| |
| virtual void | computeEdotJSource (const Real a_dt) noexcept |
| | Compute the energy source term for the various plasma species.
|
| |
|
virtual void | initialSigma () noexcept |
| | Fill surface charge solver with initial data taken from the physics interface.
|
| |
| virtual void | parseVerbosity () noexcept |
| | Parse chattiness.
|
| |
|
virtual void | parseExitOnFailure () noexcept |
| | Parse exit on failure.
|
| |
|
virtual void | parseRedistributeCDR () noexcept |
| | Parse CDR mass redistribution when assigning reactive products.
|
| |
| virtual void | parseSuperParticles () noexcept |
| | Parse the desired number of particles per cell.
|
| |
| virtual void | parseDualGrid () noexcept |
| | Parse dual or single realm calculations.
|
| |
|
virtual void | parseLoadBalance () noexcept |
| | Parse load balancing.
|
| |
|
virtual void | parseTimeStepRestrictions () noexcept |
| | Parse time step restrictions.
|
| |
|
virtual void | parseParametersEB () noexcept |
| | Parse parameters related to how we treat particle-EB interaction.
|
| |
|
virtual void | parsePlotVariables () noexcept |
| | Parse plot variables.
|
| |
| virtual void | computePhysicsPlotVariables (EBAMRCellData &a_physicsPlotVars) noexcept |
| | Compute physics plot variables.
|
| |