WarpX
Loading...
Searching...
No Matches
Class List
Here are the classes, structs, unions and interfaces with brief descriptions:
[detail level 1234]
 Nablastr
 NMagnetostaticSolver
 NParticleBoundaryProcess
 Nutils
 Nwarpx
 NWarpXLaserProfiles
 CAcceleratorLattice
 CAMReXGMRESWrapper for AMReX's GMRES solver
 CBackgroundMCCCollision
 CBackgroundStopping
 CBackTransformFunctorFunctor to back-transform cell-centered data and store result in mf_out
 CBackTransformParticleFunctorBackTransform functor to select particles and Lorentz Transform them and store in particle buffers
 CBackwardEulerAlgoThis struct contains only static functions to compute the coefficients for the BackwardEuler scheme of macroscopic Maxwells equations using macroscopic properties, namely, conductivity (sigma) and permittivity (epsilon). Permeability of the material, mu, is used as (beta/mu) for the E-update defined in MacroscopicEvolveECartesian()
 CBeamRelevant
 CBilinearFilter
 CBinaryCollisionThis class performs generic binary collisions
 CBoundaryScrapingDiagnostics
 CBreitWheelerEngine
 CBreitWheelerEvolveOpticalDepth
 CBreitWheelerGeneratePairs
 CBreitWheelerGetOpticalDepth
 CBremsstrahlungFuncThis functor does binary Bremsstrahlung reactions in a single cell. Particles of the two interacting species are paired with each other and for each pair we compute the energy of the resulting photon if Bremsstrahlung happens. We fill p_mask with true if it happens so that the new photon corresponding to a given pair can be effectively created in the particle creation functor
 CBTDiagnostics
 CBTDMultiFabHeaderImplClass to read, modify, and write MultiFab header in Level_0/Cell_H when back-transformed diag format is selected as plotfile. This class enables multiple fabs to be interweaved and stitched into a single plotfile with a single Header, Cell_H
 CBTDParticleDataHeaderImplClass to read, modify, and write particle header file, Particle_H, when back-transformed diag format is selected as plotfile. This class enables multiple particle buffers to be interweaved and stitched into a single plotfile with a single Particle_H file
 CBTDPlotfileHeaderImplClass to read, modify, and write plotfile header when back-transformed diag format is selected as plotfile. This class enables multiple BTD buffers to be interweaved and stitched into a single plotfile with a single Header
 CBTDSpeciesHeaderImplClass to read, modify, and write species header when back-transformed diag format is selected as plotfile. This class enables multiple BTD particle buffers to be interweaved and stitched into a single plotfile with a single Header
 Cbw_pair_production_table_wrapper
 CCartesianCKCAlgorithm
 CCartesianNodalAlgorithm
 CCartesianYeeAlgorithm
 CCellCenterFunctorFunctor to cell-center MF and store result in mf_out
 CChargeOnEB
 CColliderRelevant
 CCollisionBase
 CCollisionHandler
 CCompute_shape_factor
 CCompute_shape_factor_pair
 CCompute_shifted_shape_factor
 CComputeDiagFunctorFunctor to compute a diagnostic and store the result in existing MultiFab
 CComputeParticleDiagFunctorFunctor to compute a diagnostic and store the result in existing ParticleContainer
 CcopyAndReorderFunctor that copies the elements of src into dst, while reordering them according to indices
 CCopyAndTimestamp
 CCopyParticleAttribsFunctor that creates copies of the current particle positions and momenta for later use. This is needed by the back-transformed diagnostics
 CCurlCurlMLMGPCCurl-curl Preconditioner
 CCylindricalYeeAlgorithm
 CDiagIdx
 CDiagnosticsBase class for diagnostics. Contains main routines to filter, compute and flush diagnostics
 CDifferentialLuminosity
 CDifferentialLuminosity2D
 CDirection
 CDivBFunctorFunctor to compute divB into mf_out
 CDivEFunctorFunctor to compute divE into mf_out
 CDrift
 CDSMCFuncThis class performs DSMC (direct simulation Monte Carlo) collisions within a cell. Particles are paired up and for each pair a stochastic process determines whether a collision occurs. The algorithm is similar to the one used for binary Coulomb collisions and the nuclear fusion module
 CEBCalcEfromPhiPerLevel
 CEBCoveredFunctorFunctor to indicate the fraction of the cell that is covered by the embedded boundary
 CEffectivePotentialES
 CElectronPressureThis struct contains only static functions to compute the electron pressure using the particle density at a given point and the user provided reference density and temperatures
 CElectrostaticSolverBase class for Electrostatic Solver
 CExternalFieldParamsStruct to store data related to external electromagnetic fields (flags, field values, and field parsers)
 CExternalFieldReader
 CExternalFieldView
 CExternalVectorPotentialThis class contains the parameters needed to evaluate a time varying external vector potential, leading to external E/B fields to be applied in Hybrid Solver. This class is used to break up the passed in fields into a spatial and time dependent solution
 CFaceInfoBox
 CFieldAccessorMacroscopicFunctor that returns the division of the source m_field Array4 value by macroparameter obtained using m_parameter, at the respective (i,j,k)
 CFieldEnergy
 CFieldMaximum
 CFieldMomentumThis class mainly contains a function that computes the field momentum
 CFieldPoyntingFluxThis class mainly contains a function that computes the field Poynting flux, S = E cross B, integrated over each face of the domain
 CFieldProbe
 CFieldProbeParticleContainer
 CFieldProbePIdx
 CFieldReduction
 CfillBufferFlagFunctor that fills the elements of the particle array inexflag with the value of the spatial array bmasks, at the corresponding particle position
 CfillBufferFlagRemainingParticlesFunctor that fills the elements of the particle array inexflag with the value of the spatial array bmasks, at the corresponding particle position
 CFilter
 CFindEmbeddedBoundaryIntersection
 CFiniteDifferenceSolverTop-level class for the electromagnetic finite-difference solver
 CFlushFormat
 CFlushFormatAscentThis class aims at dumping performing in-situ diagnostics with ASCENT. In particular, function WriteToFile takes fields and particles as input arguments, and calls amrex functions to do the in-situ visualization
 CFlushFormatCatalystThis class aims at dumping performing in-situ analysis and visualization with Catalyst. Catalyst initialize and finalize are called in the constructor and destructor respectivelyThe function WriteToFile takes in the particles, meshes, and fields, and formats them to be used by given pipeline scripts. All exports are defined and executed externally through the given catalyst pipeline and implementation
 CFlushFormatCheckpoint
 CFlushFormatInSituThis class is a wrapper for the two single-backend in-situ formats, those being Catalyst and Ascent. They both use the exact same code for writing particles and this class aims to reduce redundancy by defining the method only once
 CFlushFormatOpenPMDThis class aims at dumping diags data to disk using the openPMD standard. In particular, function WriteToFile takes fields and particles as input arguments, and writes data to file
 CFlushFormatPlotfileThis class aims at dumping diags data to disk using the AMReX Plotfile format. In particular, function WriteToFile takes fields and particles as input arguments, and writes data to file
 CFlushFormatSenseiThis class aims at dumping performing in-situ diagnostics with SENSEI. In particular, function WriteToFile takes fields and particles as input arguments, and calls amrex functions to do the in-situ visualization
 CFullDiagnostics
 CGeometryFilterFunctor that returns 1 if the particle is inside a given axis-aligned region defined by amrex::RealBox, 0 otherwise
 CGetExternalEBFieldFunctor class that assigns external field values (E and B) to particles
 CGetParticlePositionFunctor that can be used to extract the positions of the macroparticles inside a ParallelFor kernel
 CGetTemperatureGet temperature at a point on the grid
 CGetVelocity
 CguardCellManagerThis class computes and stores the number of guard cells needed for the allocation of the MultiFabs and required for each part of the PIC loop
 CHankelTransform
 CHardEdgedPlasmaLens
 CHardEdgedPlasmaLensDevice
 CHardEdgedQuadrupole
 CHardEdgedQuadrupoleDevice
 CHybridPICModelThis class contains the parameters needed to evaluate hybrid field solutions (kinetic ions with fluid electrons)
 CImpactIonizationFilterFuncFilter functor for impact ionization
 CImpactIonizationTransformFuncTransform functor for impact ionization
 CImplicitOptions
 CImplicitSolver
 CIndependentPairHelper
 CInjectorDensity
 CInjectorDensityConstant
 CInjectorDensityDeleter
 CInjectorDensityFromFile
 CInjectorDensityParser
 CInjectorDensityPredefined
 CInjectorFlux
 CInjectorFluxConstant
 CInjectorFluxDeleter
 CInjectorFluxParser
 CInjectorMomentum
 CInjectorMomentumBoltzmann
 CInjectorMomentumConstant
 CInjectorMomentumDeleter
 CInjectorMomentumGaussian
 CInjectorMomentumGaussianFlux
 CInjectorMomentumGaussianParser
 CInjectorMomentumJuttner
 CInjectorMomentumParser
 CInjectorMomentumRadialExpansionStruct whose getMomentum returns momentum for 1 particle, for radial expansion
 CInjectorMomentumUniform
 CInjectorPosition
 CInjectorPositionRandom
 CInjectorPositionRandomPlane
 CInjectorPositionRegular
 CIntIdx
 CIonizationFilterFunc
 CIonizationTransformFunc
 CIsOutsideDomainBoundary
 CJacobianFunctionMFThis is a linear function class for computing the action of a Jacobian on a vector using a matrix-free finite-difference method. This class has all of the required functions to be used as the linear operator template parameter in AMReX_GMRES
 CJacobiPCPoint-Jacobi Preconditioner
 CJdispFunctorFunctor to cell-center MF for displacement current density and store result in mf_out
 CJFunctorFunctor to cell-center MF for current density and store result in mf_out
 CLabFrameExplicitES
 CLaserParticleContainer
 CLatticeElementBase
 CLatticeElementFinder
 CLatticeElementFinderDeviceThe lattice element finder class that can be trivially copied to the device. This only has simple data and pointers
 CLaxWendroffAlgoThis struct contains only static functions to compute the coefficients for the Lax-Wendroff scheme of macroscopic Maxwells equations using macroscopic properties, namely, conductivity (sigma), permittivity (epsilon). Permeability of the material, mu, is used as (beta/mu) for the E-update defined in MacroscopicEvolveECartesian()
 CLevelingThinningThis class implements the leveling thinning algorithm as defined in Muraviev, A., et al. arXiv:2006.08593 (2020). The main steps of the algorithm are the following: for every cell we calculate a level weight, defined by the average weight of the species particles in that cell multiplied by the target ratio. Then, particles with a weight lower than the level weight are either removed, with a probability 1 - particle_weight/level_weight, or have their weight set to the level weight
 CLinearBreitWheelerCollisionFuncThis functor does two-photon binary collisions on a single cell. Particles of the two colliding species are paired with each other and for each pair we compute if a pair-production event occurs. If so, we fill a mask (input parameter p_mask) with true so that product particles corresponding to a given pair can be effectively created in the particle creation functor. This functor also reads and stores the event multiplier
 CLinearComptonCollisionFuncThis functor does perform linear Compton scattering on a single cell. Particles of the two colliding species (a photon species and a electron/positron species) are paired with each other and for each pair we compute if a Compton-scattering event occurs. If so, we fill a mask (input parameter p_mask) with true so that product particles corresponding to a given pair can be effectively created in the particle creation functor. This functor also reads and stores the event multiplier
 CLinearFunctionThis is a base class for defining a linear function class to use with WarpX implicit solvers
 CLinearSolverTop-level class for the linear solver
 CLoadBalanceCosts
 CLoadBalanceEfficiency
 CLorentzTransformParticlesTransform functor to Lorentz-transform particles and obtain lab-frame data
 CMacroscopicPropertiesThis class contains the macroscopic properties of the medium needed to evaluate macroscopic Maxwell equation
 CMatrixPCMatrix Preconditione
 CMultiDiagnosticsThis class contains a vector of all diagnostics in the simulation
 CMultiFluidContainer
 CMultiParticleContainer
 CMultiReducedDiags
 CMultiSigmaBox
 CNCIGodfreyFilterClass for Godfrey's filter to suppress Numerical Cherenkov Instability
 CNewtonSolverNewton method to solve nonlinear equation of form: F(U) = U - b - R(U) = 0. U is the solution vector, b is a constant, and R(U) is some nonlinear function of U, which is computed in the ComputeRHS() Ops function
 CNonlinearSolverTop-level class for the nonlinear solver
 CNoParticleCreationFuncThis class does nothing and is used as second template parameter for binary collisions that do not create particles
 CNormalizationType
 CNuclearFusionFuncThis functor does binary nuclear fusions on a single cell. Particles of the two reacting species are paired with each other and for each pair we compute if a fusion event occurs. If so, we fill a mask (input parameter p_mask) with true so that product particles corresponding to a given pair can be effectively created in the particle creation functor. This functor also reads and contains the fusion multiplier
 CPairGenerationFilterFuncFilter functor for the Breit Wheeler process
 CPairGenerationTransformFuncTransform functor for the Breit-Wheeler process
 CPairWiseCoulombCollisionFuncThis functor performs pairwise Coulomb collision on a single cell by calling the function ElasticCollisionPerez. It also reads and contains the Coulomb logarithm
 CParserFilterFunctor that returns 0 or 1 depending on a parser selection
 CParticleBoundaries
 CParticleBoundaryBuffer
 CParticleCreationFuncThis functor creates particles produced from a binary collision and sets their initial properties (position, momentum, weight)
 CParticleDiag
 CParticleEnergy
 CParticleExtrema
 CParticleHistogram
 CParticleHistogram2D
 CParticleMomentumThis class mainly contains a function that computes the particle relativistic momentum of each species
 CParticleNumber
 CParticleReductionFunctorFunctor to calculate per-cell averages of particle properties
 CPartPerCellFunctorFunctor to cell-center MF and store result in mf_out
 CPartPerGridFunctorFunctor to cell-center MF and store result in mf_out
 CPDim3
 CPEC_Insulator
 CPhiFunctorFunctor to compute electrostatic potential into mf_out
 CPhotonCreationFuncThis functor creates photons produced from a binary collision and sets their initial properties (position, momentum, weight)
 CPhotonEmissionFilterFuncFilter functor for the QED photon emission process
 CPhotonEmissionTransformFuncTransform functor for the QED photon emission process
 CPhotonParticleContainer
 CPhysicalParticleContainer
 CPicardSolverPicard fixed-point iteration method to solve nonlinear equation of form: U = b + R(U). U is the solution vector. b is a constant. R(U) is some nonlinear function of U, which is computed in the Ops function ComputeRHS()
 CPicsarBreitWheelerCtrl
 CPicsarQuantumSyncCtrl
 CPIdx
 CPlasmaInjector
 CPlasmaParserHelper
 CPlasmaParserWrapper
 CPML
 CPML_RZ
 CPMLComp
 CPoissonBoundaryHandler
 CPoyntingCellCentered
 CPoyntingNodal
 CPoyntingStaggered
 CPreconditionerBase class for preconditioners
 CProcessNumberFunctorFunctor to store the process each Box is assigned to in mf_out
 CPsatdAlgorithmComoving
 CPsatdAlgorithmGalilean
 CPsatdAlgorithmGalileanRZ
 CPsatdAlgorithmJRhomFirstOrder
 CPsatdAlgorithmJRhomSecondOrder
 CPsatdAlgorithmPml
 CPsatdAlgorithmPmlRZ
 CPsatdAlgorithmRZ
 CQEDHelper
 Cqs_photon_emission_table_wrapper
 CQuantumSynchrotronEngine
 CQuantumSynchrotronEvolveOpticalDepth
 CQuantumSynchrotronGetOpticalDepth
 CQuantumSynchrotronPhotonEmission
 CRandomFilterFunctor that returns 0 or 1 depending on a random draw per particle
 CReducedDiags
 CRelativisticExplicitES
 CResamplingThis is a general class used for resampling that is instantiated as a member of MultiParticleContainer. It contains a ResamplingTrigger object used to determine if resampling should be done at a given timestep for a given species and a pointer to a ResamplingAlgorithm object used to carry out the resampling
 CResamplingAlgorithmAn empty base class from which specific resampling algorithms are derived
 CResamplingTriggerThis class is used to determine if resampling should be done at a given timestep for a given species. Specifically resampling is performed if the current timestep is included in the IntervalsParser m_resampling_intervals or if the average number of particles per cell of the considered species exceeds the threshold m_max_avg_ppc
 CRhoFunctorFunctor to compute charge density rho into mf_out
 CRhoMaximum
 CRigidInjectedParticleContainer
 CScaleFieldsFunctor that scales E and B by a factor before pushing the particles. This is used for rigid injection
 CScatteringProcess
 CSchwingerFilterFunc
 CSchwingerTransformFunc
 CSelectParticlesFilter to select particles that correspond to a z-slice of the corresponding lab-frame
 CSemiImplicitEM
 CSetParticlePositionFunctor that can be used to modify the positions of the macroparticles, inside a ParallelFor kernel
 CSigma
 CSigmaBox
 CSigmaBoxFactory
 CSignalHandlingSignal handling
 CSmartCopyThis is a functor for performing a "smart copy" that works in both host and device code
 CSmartCopyFactoryA factory for creating SmartCopy functors
 CSmartCopyTag
 CSmartCreateThis is a functor for performing a "smart create" that works in both host and device code
 CSmartCreateFactoryA factory for creating SmartCreate functors
 CSpectralBaseAlgorithm
 CSpectralBaseAlgorithmRZ
 CSpectralBinomialFilterClass that sets up binomial filtering in k space
 CSpectralFieldDataClass that stores the fields in spectral space, and performs the Fourier transforms between real space and spectral space
 CSpectralFieldDataRZ
 CSpectralFieldIndex
 CSpectralHankelTransformer
 CSpectralKSpaceClass that represents the spectral space
 CSpectralKSpaceRZ
 CSpectralSolverTop-level class for the electromagnetic spectral solver
 CSpectralSolverRZ
 CSphericalYeeAlgorithm
 CSplitAndScatterFuncThis class defines an operator to create product particles from DSMC collisions and sets the particle properties (position, momentum, weight)
 CStrangImplicitSpectralEM
 CTemperatureFunctorFunctor to calculate per-cell averages of particle temperature
 CTemperaturePropertiesStruct to store temperature properties, for use in momentum initialization
 CThetaImplicitEM
 CTimestep
 CUniformFilterFunctor that returns 1 if stride divide particle_id, 0 otherwise
 CVelocityCoincidenceThinningThis class implements a particle merging scheme wherein particles are clustered in phase space and particles in the same cluster is merged into two remaining particles. The scheme conserves linear momentum and kinetic energy within each cluster
 CVelocityPropertiesStruct to store velocity properties, for use in momentum initialization
 CWarpX
 CWarpXFluidContainer
 CWarpXOpenPMDPlot
 CWarpXParIter
 CWarpXParticleContainer
 CWarpXParticleCounter
 CWarpXSolverDOFThis is contains the local and global DOF data that maps each grid location and component to its position in a serialized vector
 CWarpXSolverVecThis is a wrapper class around a Vector of pointers to MultiFabs that contains basic math operators and functionality needed to interact with nonlinear solvers in WarpX and linear solvers in AMReX, such as GMRES. The size of the Vector is the number of amr levels. Hardcoded for 1 right now