chombo-discharge
Loading...
Searching...
No Matches
Class List
Here are the classes, structs, unions and interfaces with brief descriptions:
[detail level 1234]
 NPhysicsName containing various physics models for running chombo-discharge code
 CAerosolSimple class for making a bunch of (manually constructored) dielectric sphere
 CAmrMeshClass for handling spatial operations
 CBoundedNoisePlaneInfinite plane with spatially bounded surface noise (Perlin noise)
 CBoxSdfClass for defining a two- or three-dimensional box with arbitrary centroid and orientation
 CCdrCTUClass that uses a slope limited method for advection, in combination with corner transport upwind (CTU)
 CCdrDomainBCClass for encapsulating possible domain boundary conditions for CdrSolver
 CCdrFactoryFactory class for CdrLayout. T is (usually) CdrSolver and S is the implementation class (e.g., CdrCTU)
 CCdrGodunovGodunov implementation for advection
 CCdrIteratorIterator class for CdrLayout. This allows iteration through solvers (or subsets of solvers)
 CCdrLayoutClass for holding a set of CdrSolvers
 CCdrMultigridExtension class of CdrSolver that uses multigrid for diffusion part. Can also solve for stochastic diffusion
 CCdrSolverBase class for solving convection-diffusion-reaction equations
 CCdrSpeciesAbstract class that describes the scalar quantity that is advected in CdrSolver
 CCellInfoClass for the cell-information that is often queried when merging particles inside a cell
 CCellTaggerBase class for tagging cells across an AMR hierarchy
 CCentroidInterpolationStencilClass which can take cell-centered data and interpolate it to cell centroids
 CCoarseInterpQuadCFClass for computing the required Taylor terms for doing the orthogonal extrapolation to the ghost cell position. This is used in conjuction with EBLeastSquaresMultigridInterpolator.H, and should be understood in that context only
 CCoaxialCableThis is a class that defines a coaxial cable geometry
 CComputationalGeometryAbstract base class for geometries
 CCylinderThis is a class that defines a cylinder geometry
 CCylinderSdfDeclaration of a cylinder IF class
 CDataOpsAgglomeration of useful data operations
 CDielectricDielectric class. Simple tuple
 CDiskProfiledPlaneCD_DiskProfiledPlane.H
 CDomainFluxIFFABClass for holding fluxes on domain boundaries
 CDomainFluxIFFABFactoryFactory class for making DomainFluxIFFAB
 CDoubleRodThis is a class that defines two dielectric rods
 CDriverMain class for time/space advancement of streamer equations
 CEBAddOpA Copier class for making copying between BoxLayoutData<EBCellFAB> easier. This increments EBCellFABs when calling copyTo (with the correct Copier)
 CEBAMRDataDefault class for holding LevelData<T> data across an EBAMR realm
 CEBAMRParticleMeshClass for handling particle-mesh operations with AMR
 CEBAMRSurfaceDepositionClass for handling surface deposition of particles with EB and AMR
 CEbCentroidInterpolationStencilClass which can take cell-centered data and interpolate it to embedded boundary centroids
 CEBCoarAveClass which replaces data at coarse level of refinement with average at fine level of refinement
 CEBCoarseFineParticleMeshA class for handling particle deposition clouds that hang over refinement boundaries. This class does not include any deposition functionality but provides buffers for moving mass between two levels
 CEBCoarseToFineInterpClass for interpolating data to fine grids. Can use constant interpolation or include limiters
 CEBFluxRedistributionClass for redistribution ala Chombo's flux redistribution
 CEBGeometryIFShallow binding of EBGeometry signed distance functions to Chombo
 CEBGhostCellInterpolatorClass which can interpolate ghost cells across the coarse-fine interface. To select an interpolation method, use the type argument
 CEBGradientClass for computing gradients in an EBAMR context
 CEBHelmholtzDirichletDomainBCBoundary condition class for passing Dirichlet domain boundary conditions into EBHelmholtzOp
 CEBHelmholtzDirichletDomainBCFactoryFactory class for passing Dirichlet domain boundary conditions into EBHelmholtzOp
 CEBHelmholtzDirichletEBBCBase class for passing Dirichlet EB boundary conditions into EBHelmholtzOp
 CEBHelmholtzDirichletEBBCFactoryFactory class for making Dirichlet BCs on EBs in EBHelmholtzOp
 CEBHelmholtzDomainBCBase class for passing domain boundary conditions into EBHelmholtzOp
 CEBHelmholtzDomainBCFactoryBase class for passing domain boundary conditions into EBHelmholtzOp
 CEBHelmholtzEBBCBase class for passing EB boundary conditions into EBHelmholtzOp
 CEBHelmholtzEBBCFactoryFactory class for making EBHelmholtzEBBCs
 CEBHelmholtzEddingtonSP1DomainBCClass for passing EddingtonSP1 domain boundary conditions into EBHelmholtzOp
 CEBHelmholtzEddingtonSP1DomainBCFactoryBase class for passing EddingtonSP1 domain boundary conditions into EBHelmholtzOp
 CEBHelmholtzElectrostaticDomainBCClass for passing electrostatic domain boundary conditions into EBHelmholtzOp
 CEBHelmholtzLarsenDomainBCBase class for passing Larsen domain boundary conditions into EBHelmholtzOp
 CEBHelmholtzLarsenDomainBCFactoryClass for making Larsen boundary conditions
 CEBHelmholtzLarsenEBBCFactoryClass for making Larsen boundary conditions
 CEBHelmholtzNeumannDomainBCBoundary condition class for passing Neumann domain boundary conditions into EBHelmholtzOp
 CEBHelmholtzNeumannDomainBCFactoryClass for passing Neumann boundary domain boundary conditions into EBHelmholtzOp
 CEBHelmholtzNeumannEBBCBase class for passing Neumann EB boundary conditions into EBHelmholtzOp
 CEBHelmholtzNeumannEBBCFactoryFactory class which generates EBHelmholtzNeumannEBBC
 CEBHelmholtzOpHelmholtz operator for equations like alpha*a(x)*phi(x) + beta*div(b(x)*grad(phi(x))) = rho
 CEBHelmholtzOpFactoryFactory class for making variable-coefficient Helmholtz operators
 CEBHelmholtzRobinDomainBCBase class for passing Robin domain boundary conditions into EBHelmholtzOp
 CEBHelmholtzRobinDomainBCFactoryBase class for making Robin domain boundary conditions with EBHelmholtzOp
 CEBHelmholtzRobinEBBCBase class for passing Robin EB boundary conditions into EBHelmholtzOp
 CEBHelmholtzRobinEBBCFactoryBase class for making Robin boundary conditions with EBHelmholtzOp
 CEBLeastSquaresMultigridInterpolatorMultigrid interpolator class
 CEBMGProlongClass for prolongation of multigrid residual onto a finer grid
 CEBMGRestrictClass for restricting multigrid residual onto a coarser grid
 CEBMultigridInterpolatorMultigrid interpolator class
 CEBParticleMeshA class for depositing and interpolating particles. Contains various useful routines for interpolation of different fields in the base particle class (e.g., mass, "mobility"). This class also contains functions for depositing particles with 2/4 times the usual particle width, which is included because we want to support deposition of particles over refinement boundaries
 CEBRefluxClass which can do refluxing across a coarse-fine interface
 CEddingtonSP1Radiative tranfer equation solver in the SP1 (diffusion) approximation
 CEddingtonSP1DomainBcClass which maps boundary condition types to a side and direction
 CElectrodeElectrode class for encapsulating the concept of an electrical conductor
 CElectrodeArrayThis is a class that defines an array of electrodes
 CElectrostaticDomainBcClass which maps boundary condition types to a side and direction
 CElectrostaticEbBcClass which maps boundary condition types to a side and direction
 CFieldSolverBase class for electrostatic solvers
 CFieldSolverFactoryFactory class for poisson solvers. Used to instantiate any FieldSolver-derived classes with automatic casting to the base class
 CFieldSolverMultigridImplementation of FieldSolver which uses multigrid
 CGenericParticleA generic particle class, holding the position and a specified number of real and vector values
 CGeoCoarsenerUtility class for removing geometrically tagged cells
 CGradedPerlinSphereSdfGradedPerlinSphereSdf function
 CHollowCylinderIFThis class is used to generate a hollow cylinder with rounded edges
 CHyperboloidIFDeclaration of a two-sheet hyperboloid
 CHyperboloidOneIFDeclaration of a one-sheet hyperboloid
 CHyperboloidTwoIFDeclaration of a two-sheet hyperboloid
 CIrregAddOpA Copier class for making copying between LevelData<BaseIVFAB<Real>> easier. This is an incrementation operator
 CIrregAmrStencilClass for holding VoFStencils on irregular cells over an entire AMR hierarchy. The template parameter must inherit from IrregStencil. The stencil can only be applied to EBCellFABs
 CIrregStencilClass for holding stencils on irregular cells over a single AMR level
 CItoFactoryFactory class for making ItoLayout
 CItoIterator"Iterator" class for going through solvers in an ItoLayout
 CItoLayoutClass for holding a set of ItoSolvers
 CItoParticleA particle class for use with ItoSolvers, i.e. drifting Brownian walkers
 CItoSolverBase class for Ito diffusion particle models
 CItoSpeciesClass that acts as user interface for parsing initial data and mobility/diffusion kernels into ItoSolver
 CKDNodeNode in a particle-merging KD-tree
 CKMCDualStateDeclaration of a "dual state" for advancing with the Kinetic Monte Carlo module
 CKMCDualStateReactionReaction type for advancing a KMCDualState for Kinetic Monte Carlo
 CKMCSingleStateDeclaration of a straightforward state for advancing with the Kinetic Monte Carlo module
 CKMCSingleStateReactionReaction type for advancing a KMCSingleState for Kinetic Monte Carlo
 CKMCSolverClass for running Kinetic Monte-Carlo simulations
 CLeastSquaresStatic class containing useful routines for (weighted) least squares polynomial reconstruction
 CLevelTilesClass for storing the AMR hierarchy as a collection of tiles
 CLinearStencilClass which computes a bi/tri-linear stencil in cut-cells. This class makes appropriate modifications if one of the cells don't exist, and even if there are multivalued cells present
 CLoadBalancingStatic class which contains various load balancing routines
 CLoadsClass for holding computational loads
 CLookupTable1DClass for interpolation of f = f(x) data in one independent variable x
 CMcPhotoRadiative tranfer equation solver using Monte-Carlo simulation
 CMechanicalShaftMechanical shaft class. Consists of a single ring electrode and an infinitely long> shaft with various shapes
 CMeshODESolverClass for solving dy/dt = f on an AMR hierarchy
 CMFBaseIVFABMultiphase BaseIVFAB<Real>
 CMFBaseIVFABFactoryFactory class for creating MFBaseIVFABs
 CMFCoarAveClass for coarsening data in a multifluid context
 CMFHelmholtzDirichletDomainBCFactoryFactory class for passing Dirichlet domain boundary conditions into MFHelmholtzOp
 CMFHelmholtzDirichletEBBCClass for making Dirichlet boundary conditions on the EB in a multifluid context
 CMFHelmholtzDirichletEBBCFactoryClass for making Dirichlet boundary conditions on the EB in a multifluid context
 CMFHelmholtzDomainBCFactoryBase class for creating domain boundary condition objects in MFHelmholtzOp
 CMFHelmholtzEBBCClass for making boundary conditions on the EB in a multifluid context
 CMFHelmholtzEBBCFactoryBase class for making boundary conditions on the EB in a multifluid context
 CMFHelmholtzElectrostaticDomainBCFactoryClass for passing electrostatic boundary conditions into MFHelmholtzOp
 CMFHelmholtzElectrostaticEBBCClass for making Electrostatic boundary conditions on the EB in a multifluid context
 CMFHelmholtzElectrostaticEBBCFactoryClass for making electrostatic boundary conditions on EBs in an MFHelmholtzOp context
 CMFHelmholtzJumpBCClass for computing "jump interface" boundary conditions for multifluid code
 CMFHelmholtzJumpBCFactoryFactory class for making jump boundary condition objects in a multifluid MFHelmholtzOp context
 CMFHelmholtzNeumannDomainBCFactoryClass for passing Neumann boundary domain boundary conditions into MFHelmholtzOp
 CMFHelmholtzNeumannEBBCBase class for passing Neumann MF boundary conditions into MFHelmholtzOp
 CMFHelmholtzNeumannEBBCFactoryClass for making Neumann boundary conditions on the EB in a multifluid context
 CMFHelmholtzOpOperator for solving multifluid Helmholtz on a grid level
 CMFHelmholtzOpFactoryFactory class for making MFHelmholtzOp
 CMFHelmholtzRobinDomainBCFactoryBase class for making Robin domain boundary conditions with MFHelmholtzOp
 CMFHelmholtzRobinEBBCBase class for passing Robin MF boundary conditions into MFHelmholtzOp
 CMFHelmholtzRobinEBBCFactoryClass for making Robin boundary conditions on the EB in a multifluid context
 CMFHelmholtzSaturationChargeJumpBCClass for computing matching the saturation charge boundary condition in an MFHelmholtzOp context
 CMFHelmholtzSaturationChargeJumpBCFactoryFactory class for making saturation charge jump boundary condition objects in multifluid Helmholtz context
 CMFInterfaceFABClass for holding BaseIVFAB<T> on the interface between two phases
 CMFLevelGridWrapper class for holding multifluid EBLevelGrids
 CMFMultigridInterpolatorWrapper class for holding multifluid EBMultigridInterpolators
 CMFRefluxClass which wraps EBRefluxs in multiphase
 CMultifluidAliasClass with static public interface for aliasing multifluid data into single-phase data
 CMultiFluidIndexSpaceTwo-fluid index space
 CMultiIndexSpaceDim multi-index type for use with higher order Taylor series
 CMushroomIF"Mushroom" implicit function. Consists of a cylinder with a circular plate on top
 CNeedleIFCylinder with one pointed end and one circular end
 CNewIntersectionIFNew intersection IF which does not mess up the return value function when there are no implicit functions
 CNoisePlaneThis is a class that a rough sphere (either electrode or dielectric)
 CNonCommParticleA generic non-communicated particle class
 CNonConservativeDivergenceStencilStencil class for computing non-conservative divergences using neighborhood algorithms
 CParticleContainerTemplated class for holding particles on an AMR hierarchy with particle remapping
 CParticleOpsA shallow static class for doing various kinds of particle-related operations
 CPerlinPlaneSdfInfinite plane with surface noise (Perlin noise)
 CPerlinRodSdfA rod geometry, but with noise on one of the end caps
 CPerlinSdfClass that implements the improved Perlin noise function
 CPerlinSlabSdfImplicit function class describing a slab (box) with surface noise on the top
 CPerlinSphereSdfNoisy sphere geometry (with Perlin noise)
 CPhaseRealmClass that holds important things for doing AMR over a specific phase and processor distribution
 CPhotonParticle class for usage with Monte Carlo radiative transfer
 CPointParticleA particle class that only has a position and a weight
 CPolygonRodIFImplicit function class describing a rod with a polygonal cross scetion
 CProfileCylinderIFImplicit function which takes the form of a cylinder with a surface profiles (grooves)
 CProfilePlaneIFImplicit function which represents an infinite half-plane with "holes"
 CRandomClass for encapsulating random number generation. This class is MPI and OpenMP safe
 CRandomInterfaceClass that represents two random interface smooshed together
 CRealBoxRectangular box in real space
 CRealmClass for holding multifluid Realms, which are the Realms that we actually use
 CRegularGeometryThis class implements an empty geometry
 CRodDielectricClass that defines an electrode rod and a dielectric (some shapes supported)
 CRodIFCylinder with rounded caps at its ends
 CRodNeedleDiskA class that defines a rod electrode with a needle out of the tip, and a plane (electrode) a set distance from the needle tip
 CRodPlaneProfileGeometry class which defines an electrode blade and a dielectric slab with various surface profiles
 CRoughRodClass that describes a rod electrode with surface roughness
 CRoughSphereThis is a class that a rough sphere (either electrode or dielectric)
 CRoundedBoxIFA box with rounded corners and edges
 CRoundedCylinderIFCylinder object with rounded edges (no endcaps)
 CRtFactoryFactory class for RtLayout
 CRtIteratorIterator class for RtLayout
 CRtLayoutClass for holding a set of RtSolvers. T must derive from RtSolver
 CRtSolverAbstract RTE solver class for doing various kinds of radiative transfer equations. This class is a pure class and it is basically just an interface
 CRtSpeciesDeclaration of a class that defines an interface to radiative transfer solvers, i.e. RtSolver
 CScanShopDerived version of GeometryShop that load balances based on the cut cells themselves
 CSignedDistanceBVHSigned distance function for a DCEL mesh
 CSignedDistanceDCELSigned distance function from a DCEL mesh
 CSimpleItoParticleA particle class for reducing HDF5 I/O file sizes when using ItoSolver
 CSphereArrayA Cartesian array of spheres
 CSphereSdfSigned distance function for sphere
 CSurfaceODESolverSurface ODE solver
 CTesselationA geometry consisting of a single polygon grid
 CTiledMeshRefineClass for generation AMR boxes using a tiling algorithm
 CTileIClass for representing a tile (used in, e.g., TiledMeshRefine)
 CTimerClass which is used for run-time monitoring of events
 CTimeStepperBase class for advancing equations
 CTorusSdfSigned distance function for a torus (oriented along z)
 CTracerParticleA tracer particle class. This is templated for holding extra storage (useful for kernels)
 CTracerParticleSolverBase class for a tracer particle solver. This solver can advance particles in a pre-defined velocity field
 CVesselHigh-voltage vessel geometry
 CVofUtilsStatic class which contains some routines for fetching VoFs using various algorithms. Very useful in combination with least squares
 CWedgeIFImplicit function for a wedge
 CWireWireThis is a class that defines a wire-wire geometry