Merzbild.jl public API reference
Particles
Merzbild.Particle
— TypeParticle
A structure to store information about a single particle.
Fields
w
: the computational weight of the particlev
: the 3-dimensional velocity vector of the particlex
: the 3-dimensional position of the particle
Merzbild.ParticleVector
— TypeParticleVector
The structure used to store particles, sort and keep track of particle indices, and keep track of unused particles. The lengths of the particles
, index
, cell
, and buffer
vectors are all the same (and stay the same during resizing of a ParticleVector
instance). Only the first nbuffer
elements of the buffer
vector store indices of the actually unused particles.
Accessing ParticleVector[i]
will return a Particle
, with the actual particle returned being ParticleVector.particles[ParticleVector.index[i]]
.
Fields
particles
: the vector of particles of a single speciesindex
: the vector of indices of the particles (these are sorted in grid sorting, not the particles themselves)cell
: the vector storing information in which cell a particle is located (used in grid sorting routines)buffer
: a last-in-first-out (LIFO) queue keeping track of pre-allocated but unused particlesnbuffer
: the number of elements in the buffer
Merzbild.ParticleVector
— MethodParticleVector(np)
Create an empty ParticleVector
instance of length np
(all vectors will have length np
).
Positional arguments
np
: the length of theParticleVector
instance to create
Base.getindex
— MethodBase.getindex(pv::ParticleVector, i)
Returns the underlying particle in a ParticleVector
instance with index i
.
Is usually called as ParticleVector[i]
.
Positional arguments
pv
:ParticleVector
instancei
: the index of the particle to be selected
Base.setindex!
— MethodBase.setindex!(pv::ParticleVector, p::Particle, i::Integer)
Set the underlying particle in a ParticleVector
instance with index i
to a new particle.
Is usually called as ParticleVector[i] = p
.
Positional arguments
pv
:ParticleVector
instancep
: theParticle
instance to writei
: the index of the particle to be written to
Base.length
— MethodBase.length(pv::ParticleVector)
Returns the length of a ParticleVector
instance.
Is usually called as length(ParticleVector)
.
Positional arguments
pv
:ParticleVector
instance
Base.resize!
— MethodBase.resize!(pv::ParticleVector, n::Integer)
Resize a ParticleVector
instance.
Is usually called as resize!(ParticleVector, n)
.
Positional arguments
pv
:ParticleVector
instancen
: the new length of theParticleVector
instance (i.e. the length of all the vector fields of the instance)
Particle indexing
Merzbild.ParticleIndexer
— TypeParticleIndexer
The structure used to index particles of a given species in a given cell. It is assumed that the particle indices are contiguous; they may be split across two groups of contiguous indices.
Fields
n_local
: the number of particles in the cellstart1
: the first index in the first group of particle indicesend1
: the last index in the first group of particle indicesn_group1
: the number of particles in the first group (n_group1 = end1 - start1 + 1
)start2
: the first index in the second group of particle indices, if no particles are present in the group, it should be <= 0end2
: the last index in the second group of particle indicesn_group2
: the number of particles in the second group (n_group2 = end2 - start2 + 1
, unless no particles are present in the second group)
Merzbild.ParticleIndexer
— MethodParticleIndexer()
Create an empty ParticleIndexer. end1
and end2
are set to -1, the other fields are set to 0.
Merzbild.ParticleIndexer
— MethodParticleIndexer(n_particles)
Create a ParticleIndexer given a number of particles. All particles are in group 1, with indices starting from 1.
Positional arguments
n_particles
: the number of particles
Merzbild.ParticleIndexerArray
— TypeParticleIndexerArray
A structure to store an array of ParticleIndexer
instances for each species in each cell. It also stores information about the whether the ParticleIndexer instances for each species are "contiguous". A set of ParticleIndexer instances (for a specific species) are "contiguous" if the following conditions are fulfilled (assuming all cells contain particles and in all cells have both n_group1>0
and n_group2>0
, for a more detailed explanation, one is referred to the documentation on contiguous indexing):
pia.indexer[cell,species].end1 + 1 == pia.indexer[cell+1,species].start1
,cell = 1,...,n_cells - 1
pia.indexer[n_cells,species].end1 + 1 == pia.indexer[1,species].start2
pia.indexer[cell,species].end2 + 1 == pia.indexer[cell+1,species].start2
,cell = 1,...,n_cells - 1
Fields
indexer
: the array of size(n_cells, n_species)
(number of grid cells * number of species in the simulation) storing theParticleIndexer
instancesn_total
: vector of lengthn_species
storing the total number of particles of each speciescontiguous
: vector of lengthn_species
storing a boolean flag whether the ParticleIndexer instances for a species are "contiguous"
Merzbild.ParticleIndexerArray
— MethodParticleIndexerArray(indexer_arr::Array{ParticleIndexer,2}, n_total)
Creates a ParticleIndexerArray
from a 2-D array of ParticleIndexer
instances.
Positional arguments
indexer_arr
: the 2-D array ofParticleIndexer
instancesn_total
: the vector of the total number of particles of each species
Merzbild.ParticleIndexerArray
— MethodParticleIndexerArray(n_cells::Integer, n_species::Integer)
Create an empty ParticleIndexerArray
given the number of cells and species
Positional arguments
n_cells
: the number of grid cellsn_species
: the number of species
Merzbild.ParticleIndexerArray
— MethodParticleIndexerArray(n_particles::Integer)
Create a single-species/single-cell ParticleIndexerArray
.
Positional arguments
n_particles
: the number of particles (integer number)
Merzbild.ParticleIndexerArray
— MethodParticleIndexerArray(n_particles::T) where T<:AbstractVector
Create a multi-species/single-cell ParticleIndexerArray
.
Positional arguments
n_particles
: the number of particles of each species (vector-like)
Merzbild.ParticleIndexerArray
— MethodParticleIndexerArray(grid, species_data::Array{Species}) where T<:AbstractVector
Create an empty multi-species/multi-cell ParticleIndexerArray
.
Positional arguments
grid
: the simulation gridspecies_data
: array ofSpecies
data for all of the species in the simulation
Loading species and interaction data
Merzbild.Species
— TypeSpecies
A structure to store information about a chemical species.
Fields
name
: the name of the speciesmass
: the molecular mass of the speciescharge
: the charge of the species in terms of elementary charge (i.e. 1, -1, etc.)charge_div_mass
: the charge of the species divided by its mass, C/kg
Merzbild.Interaction
— TypeInteraction
Structure to store interaction parameters for a 2-species interaction. The VHS model uses the following power law: $\sigma_{VHS} = C g^(1 - 2 \omega_{VHS})$, where $omega$ is the exponent of the VHS potential, and $C$ is the pre-computed factor: $C = \pi D_{VHS}^2 (2 T_{ref,VHS}/m_r)^{(\omega_{VHS} - 0.5)} \frac{1}{\Gamma(2.5 - \omega_{VHS})}$.
Fields
m_r
: collision-reduced massμ1
: relative mass of the first speciesμ2
: relative mass of the second speciesvhs_d
: diameter for the VHS potentialvhs_o
: exponent for the VHS potentialvhs_Tref
: reference temperature for the VHS potentialvhs_muref
: reference viscosity for the VHS potentialvhs_factor
: pre-computed factor for calculation of the VHS cross-section
Merzbild.load_species_data
— Functionload_species_data(species_filename, species_names)
Load a vector of species data (mass, charge, etc.) from a TOML file.
Positional arguments
species_filename
: the path to the TOML file containing the dataspecies_names
: a list of the names of the species for which to load the data
load_species_data(species_filename, species_name::String)
Load a vector of species data (mass, charge, etc.) from a TOML file for a single species.
Positional arguments
species_filename
: the path to the TOML file containing the dataspecies_name
: the name of the species for which to load the data
Merzbild.load_interaction_data
— Functionload_interaction_data(interactions_filename, species_data)
Load interaction data from a TOML file given a list of species' data (list of Species
instances). It will load interaction data for all possible pair-wise interactions of the species in the list.
The resulting 2-D array has the interaction data for Species[i]
with Species[k]
in position [i,k]
. It is not symmetric, as the relative collision masses μ1
and μ2
are swapped when comparing the Interaction
instances in positions [i,k]
and [k,i]
. If no data is found, the function throws an error.
Positional arguments
interactions_filename
: the path to the TOML file containing the dataspecies_data
: list ofSpecies
instances for which to search for the interaction data
Returns
- 2-dimensional array of
Interaction
instances of size(n_species, n_species)
load_interaction_data(interactions_filename, species_data)
Load interaction data from a TOML file given a list of species' data (list of Species
instances), filling in dummy VHS data in case no entry is found in the TOML file. Useful for interactions where the VHS model doesn't make sense, for example electron-neutral interactions.
It will load interaction data for all possible pair-wise interactions of the species in the list. The resulting 2-D array has the interaction data for Species[i]
with Species[k]
in position [i,k]
. It is not symmetric, as the relative collision masses μ1
and μ2
are swapped when comparing the Interaction
instances in positions [i,k]
and [k,i]
.
Positional arguments
interactions_filename
: the path to the TOML file containing the dataspecies_data
: list ofSpecies
instances for which to search for the interaction datadummy_vhs_d
: value to use for the VHS diameter if no interaction data found in the filedummy_vhs_o
: value to use for the VHS exponent if no interaction data found in the filedummy_vhs_Tref
: value to use for the VHS reference temperature if no interaction data found in the file
Returns
- 2-dimensional array of
Interaction
instances of size(n_species, n_species)
Merzbild.load_interaction_data_with_dummy
— Functionload_interaction_data_with_dummy(interactions_filename, species_data)
Load interaction data from a TOML file given a list of species' data (list of Species
instances), filling in dummy VHS data in case no entry is found in the TOML file. Useful for interactions where the VHS model doesn't make sense, for example electron-neutral interactions. Uses a value of 1e-10
for the dummy VHS diameter, 1.0
for the dummy VHS exponent, and 273.0
for the dummy VHS reference temperature.
It will load interaction data for all possible pair-wise interactions of the species in the list. The resulting 2-D array has the interaction data for Species[i]
with Species[k]
in position [i,k]
. It is not symmetric, as the relative collision masses μ1
and μ2
are swapped when comparing the Interaction
instances in positions [i,k]
and [k,i]
.
Positional arguments
interactions_filename
: the path to the TOML file containing the dataspecies_data
: list ofSpecies
instances for which to search for the interaction data
Returns
- 2-dimensional array of
Interaction
instances of size(n_species, n_species)
Merzbild.load_species_and_interaction_data
— Functionload_species_and_interaction_data(species_filename, interactions_filename, species_names; fill_dummy=true)
Given a list of species' names, load the species and interaction data (filling with dummy data if needed).
Positional arguments
species_filename
: the path to the TOML file containing the species' datainteractions_filename
: the path to the TOML file containing the interaction dataspecies_name
: the name of the species for which to load the data
Keyword arguments
fill_dummy
: iftrue
, fill interaction data with computed dummy values if no entry found for a species pair in the interaction file
Returns
Vector
ofSpecies
instances- 2-dimensional array of
Interaction
instances of size(n_species, n_species)
Merzbild.load_electron_neutral_interactions
— Functionload_electron_neutral_interactions(species_data, filename, databases, scattering_laws, energy_splits)
Load electron-neutral interaction data from an LXCAT format XML file for a set of given neutral species.
Positional arguments
species_data
: vector ofSpecies
data for the neutral speciesfilename
: path to XML filedatabases
: dictionary of(species.name => database)
pairs, specifying the name
of the cross-section database in the XML file to use for the species
scattering_laws
: vector ofScatteringLaw
instances to use for each speciesenergy_splits
: vector ofElectronEnergySplit
instances to use for each species
Returns
ElectronNeutralInteractions
structure containing the electron-neutral interaction data.
Throws
DataMissingException
if data not found or not all required data present.
Sampling
Merzbild.maxwellian
— Functionmaxwellian(vx, vy, vz, m, T)
Evaluate the Maxwell distribution with temperature T
for a species with mass m
at a velocity (vx, vy, vz)
Positional arguments
vx
: x velocityvy
: y velocityvz
: z velocitym
: species' massT
: temperature
Merzbild.bkw
— Functionbkw(vx, vy, vz, m, T, scaled_time)
Evaluate the Bobylev-Krook-Wu (BKW) distribution with temperature T
for a species with mass m
at a velocity (vx, vy, vz)
and scaled time scaled_time
Positional arguments
vx
: x velocityvy
: y velocityvz
: z velocitym
: species' massT
: temperaturescaled_time
: the scaled_time
Merzbild.sample_on_grid!
— Functionsample_on_grid!(rng, vdf_func, particles, nv, m, T, n_total,
xlo, xhi, ylo, yhi, zlo, zhi; v_mult=3.5, cutoff_mult=3.5, noise=0.0,
v_offset=[0.0, 0.0, 0.0])
Sample particles by evaluating a distribution on a discrete velocity grid, considering only points inside a sphere of a given radius (the value of the VDF at points outside of the sphere will be 0.0). The values of the VDF at the grid points will then be the computational weights of the particles, and the particles velocities are taken to be the velocities of the corresponding grid nodes (with additional uniformly distributed noise). Note: this can produce a large amount of particles for fine grids (as the number of grid nodes scales as nv^3
.) The grid is assumed to have the same number of nodes nv
in each direction, and the extent is computed as v_mult * v_thermal
, where v_thermal
is the thermal velocity $\sqrt(2kT/m)$, and v_mult
is a user-defined parameter. The positions of the particles are assumed to be randomly distributed in a cuboid.
Positional arguments
rng
: The random number generatorvdf_func
: the distribution function to be evaluated which takes the x, y, and z velocities as parametersparticles
: theVector
-like structure holding the particlesnv
: the number of grid nodes in each directionm
: the molecular mass of the speciesT
: the temperature used to compute the thermal velocityn_total
: the total computational weight (number of physical particles) to be sampledxlo
: the lower bound of the x coordinates of the particlesxhi
: the upper bound of the x coordinates of the particlesylo
: the lower bound of the y coordinates of the particlesyhi
: the upper bound of the y coordinates of the particleszlo
: the lower bound of the z coordinates of the particleszhi
: the upper bound of the z coordinates of the particles
Keyword arguments
v_mult
: the value by which the thermal velocity is multiplied to compute the extent of the velocity gridcutoff_mult
: the value by which the thermal velocity is multiplied to compute the radius for the sphere used to cut-off the higher velocitiesnoise
: controls the amount of noise added to the particle velocities (the noise is uniformly distributed on the interval[-noise*dv, noise*dv]
, wheredv
is the grid spacing)v_offset
: the streaming velocity vector to be added to the particle velocities
Returns
- The number of particles created
Merzbild.sample_maxwellian_on_grid!
— Functionsample_maxwellian_on_grid!(rng, particles, nv, m, T, n_total,
xlo, xhi, ylo, yhi, zlo, zhi; v_mult=3.5, cutoff_mult=3.5, noise=0.0,
v_offset=[0.0, 0.0, 0.0])
Sample particles by evaluating a Maxwellian on a discrete velocity grid, considering only points inside a sphere of a given radius (the value of the VDF at points outside of the sphere will be 0.0). The values of the VDF at the grid points will then be the computational weights of the particles, and the particles velocities are taken to be the velocities of the corresponding grid nodes (with additional uniformly distributed noise). Note: this can produce a large amount of particles for fine grids (as the number of grid nodes scales as nv^3
.) The grid is assumed to have the same number of nodes nv
in each direction, and the extent is computed as v_mult * v_thermal
, where v_thermal
is the thermal velocity $\sqrt(2kT/m)$, and v_mult
is a user-defined parameter. The positions of the particles are assumed to be randomly distributed in a cuboid.
Positional arguments
rng
: The random number generatorparticles
: theVector
-like structure holding the particlesnv
: the number of grid nodes in each directionm
: the molecular mass of the speciesT
: the temperature used to compute the thermal velocityn_total
: the total computational weight (number of physical particles) to be sampledxlo
: the lower bound of the x coordinates of the particlesxhi
: the upper bound of the x coordinates of the particlesylo
: the lower bound of the y coordinates of the particlesyhi
: the upper bound of the y coordinates of the particleszlo
: the lower bound of the z coordinates of the particleszhi
: the upper bound of the z coordinates of the particles
Keyword arguments
v_mult
: the value by which the thermal velocity is multiplied to compute the extent of the velocity gridcutoff_mult
: the value by which the thermal velocity is multiplied to compute the radius for the sphere used to cut-off the higher velocitiesnoise
: controls the amount of noise added to the particle velocities (the noise is uniformly distributed on the interval[-noise*dv, noise*dv]
, wheredv
is the grid spacing)v_offset
: the streaming velocity vector to be added to the particle velocities
Returns
The function returns the number of particles created
Merzbild.sample_particles_equal_weight!
— Functionsample_particles_equal_weight!(rng, particles, pia, cell, species,
nparticles, m, T, Fnum, xlo, xhi, ylo, yhi, zlo, zhi;
distribution=:Maxwellian, vx0=0.0, vy0=0.0, vz0=0.0)
Sample equal-weight particles of a specific species in a specific cell from a distribution. The positions of the particles are assumed to be randomly distributed in a cuboid. Note: this does not work if applied twice in a row to the same cell
Positional arguments
rng
: the random number generatorparticles
: theVector
-like structure holding the particlespia
: theParticleIndexerArray
cell
: the cell indexspecies
: the species indexnparticles
: the number of particles to samplem
: species' massT
: temperatureFnum
: the computational weight of the particlesxlo
: the lower bound of the x coordinates of the particlesxhi
: the upper bound of the x coordinates of the particlesylo
: the lower bound of the y coordinates of the particlesyhi
: the upper bound of the y coordinates of the particleszlo
: the lower bound of the z coordinates of the particleszhi
: the upper bound of the z coordinates of the particles
Keyword arguments
distribution
: the distribution to sample from (either:Maxwellian
or:BKW
)vx0
: the x-velocity offset to add to the particle velocitiesvy0
: the y-velocity offset to add to the particle velocitiesvz0
: the z-velocity offset to add to the particle velocities
sample_particles_equal_weight!(rng, grid1duniform, particles, pia, species, species_data, ppc::Integer, T, Fnum)
Sample particles from a Maxwellian distribution in each cell of 1-D uniform grid given the number of particles per cell
Positional arguments
rng
: the random number generatorgrid1duniform
: the 1-D uniform gridparticles
: theParticleVector
of particlespia
: theParticleIndexerArray
species
: the index of the species to be sampled forspecies_data
:Vector
ofSpecies
datappc
: number of particles per cell to be sampledT
: the temperatureFnum
: the computational weight of the particles
sample_particles_equal_weight!(rng, grid1duniform, particles, pia, species, species_data, ndens::Float64, T, Fnum)
Sample particles from a Maxwellian distribution in each cell of 1-D uniform grid given the target number density. If the computed number of particles is not an integer value, the fractional remainder is used to probabilistically sample an extra particle, so that on average, the expected number density is achieved.
Positional arguments
rng
: the random number generatorgrid1duniform
: the 1-D uniform gridparticles
: theParticleVector
of particlespia
: theParticleIndexerArray
species
: the index of the species to be sampled forspecies_data
:Vector
ofSpecies
datandens
: target number densityT
: the temperatureFnum
: the computational weight of the particles
Computing macroscopic properties
Merzbild.PhysProps
— TypePhysProps
Structure to store computed physical properties in a physical cell.
Fields
ndens_not_Np
: whether then
field stores number density and not the number of physical particles in a celln_cells
: number of physical cellsn_species
: number of speciesn_moments
: number of total moments computedlpa
: length of the particle array (vector of lengthn_species
)np
: number of particles (array of shape(n_cells, n_species)
)n
: number density or number of physical particles in a cell (array of shape(n_cells, n_species)
)v
: per-species flow velocity in a cell (array of shape(3, n_cells, n_species)
)T
: per-species temperature in a cell (array of shape(n_cells, n_species)
)moment_powers
: powers of the total moments computed (vector of lengthn_moments
)moments
: values of the total moments computed (array of shape(n_moments, n_cells, n_species)
)Tref
: reference temperature used to scale moments
Merzbild.PhysProps
— MethodPhysProps(n_cells, n_species, moments_list; Tref=300.0)
Construct physical properties given the number of cells and species, as well as the list of the orders of total moments to compute. The total moment of order $M$ is defined as $\int \sqrt{v_x^2+v_y^2+v_z^2}^M f(v_x,v_y,v_z)dv_x dv_y dv_z$.
Positional arguments
n_cells
: number of cellsn_species
: number of species
Keyword arguments
Tref
: reference temperature used to compute the total moments of a Maxwellian distribution which are used to scale the total moments
Merzbild.PhysProps
— MethodPhysProps(pia, moments_list; Tref=300.0)
Construct physical properties given a ParticleIndexerArray
instance, as well as the list of the orders of total moments to compute. The total moment of order $M$ is defined as $\int \sqrt{v_x^2+v_y^2+v_z^2}^M f(v_x,v_y,v_z)dv_x dv_y dv_z$.
Positional arguments
pia
: theParticleIndexerArray
instancen_species
: number of species
Keyword arguments
Tref
: reference temperature used to compute the total moments of a Maxwellian distribution which are used to scale the total moments
Merzbild.PhysProps
— MethodPhysProps(pia)
Construct physical properties given a ParticleIndexerArray
instance, with no computation of the total moments.
Positional arguments
pia
: theParticleIndexerArray
instance
Merzbild.compute_props!
— Functioncompute_props!(particles, pia, species_data, phys_props)
Compute the physical properties of all species in all cells and store the result in a PhysProps
instance. This function does not compute the total moments, even if phys_props.n_moments > 0
.
Positional arguments
particles
: theVector
ofParticleVector
s containing all the particles in a simulationpia
: theParticleIndexerArray
instancespecies_data
: theVector
ofSpeciesData
phys_props
: thePhysProps
instance in which the computed physical properties are stored
Merzbild.compute_props_with_total_moments!
— Functioncompute_props_with_total_moments!(particles, pia, species_data, phys_props)
Compute the physical properties of all species in all cells and store the result in a PhysProps
instance. This function computes the total moments.
Positional arguments
particles
: theVector
ofParticleVector
s containing all the particles in a simulationpia
: theParticleIndexerArray
instancespecies_data
: theVector
ofSpeciesData
phys_props
: thePhysProps
instance in which the computed physical properties are stored
Merzbild.compute_props_sorted!
— Functioncompute_props!(particles, pia, species_data, phys_props)
Compute the physical properties of all species in all cells and store the result in a PhysProps
instance, assuming the particles are sorted. This function does not compute the total moments, even if phys_props.n_moments > 0
.
Positional arguments
particles
: theVector
ofParticleVector
s containing all the particles in a simulationpia
: theParticleIndexerArray
instancespecies_data
: theVector
ofSpeciesData
phys_props
: thePhysProps
instance in which the computed physical properties are stored
Merzbild.avg_props!
— Functionavg_props!(phys_props_avg, phys_props, n_avg_timesteps)
Used to time-average computed physical properties, not including the total moments. For each instantaneous value of a property computed and stored in phys_props
, it is divided by n_avg_timesteps
and added to phys_props_avg
.
Positional arguments
phys_props_avg
: thePhysProps
instance used to store the time-averaged propertiesphys_props
: thePhysProps
instance holding the current values of the properties to be used for the averaging at the current timestepn_avg_timesteps
: the number of timesteps over which the averaging is performed
Merzbild.clear_props!
— Functionclear_props!(phys_props)
Clear all data from PhysProps, for use when physical properties are averaged over timesteps and averaging over a new set of timesteps needs to be started.
Positional arguments
phys_props
: thePhysProps
instance to be cleared
Collision computations
Merzbild.CollisionData
— TypeCollisionData
Structure to store temporary collision data for a specific collision (relative velocity, collision energy, post-collision velocities, etc.)
Fields
v_com
: vector of center-of-mass velocityg
: magnitude of relative velocityE_coll
: relative translational energy of the colliding particlesE_coll_eV
: relative translational energy of the colliding particles in electron-voltE_coll_electron_eV
: collisional energy of the an electron in electron-volt for electron-neutral collisionsg_vec
: vector of pre-collisional relative velocityg_vec_new
: vector of post-collisional relative velocityg_new_1
: magnitude of post-collisional relative velocity of the first particle in the collision pairg_new_2
: magnitude of post-collisional relative velocity of the second particle in the collision pair
Merzbild.CollisionData
— MethodCollisionData()
Create an empty CollisionData instance.
Merzbild.CollisionFactors
— TypeCollisionFactors
Structure to store NTC-related collision factors for collisions between particles of two species in a given cell.
Fields
n1
: the number of particles of the first species in the celln2
: the number of particles of the second species in the cellsigma_g_w_max
: estimate of the $(\sigma g w)_{max}$ ($\sigma$ is the total collision cross-section, $g$ is the relative collision velocity, $w$ is the computational weight of the particles)n_coll
: number of collisions to be testedn_coll_performed
: number of collisions actually performedn_eq_w_coll_performed
: number of collisions between particles with equal weights actually performed
Merzbild.CollisionFactors
— MethodCollisionFactors()
Create an empty CollisionFactors instance (all values set to 0).
Merzbild.CollisionDataFP
— TypeCollisionData
Structure to store temporary collision data for the particle Fokker-Planck approach.
Fields
vel_ave
: average velocity of the particles in the cellmean
: mean value of the sampled velocitiesstddev
: standard deviation of the sampled velocities
Merzbild.CollisionDataFP
— MethodCollisionDataFP()
Create an empty CollisionDataFP instance.
Merzbild.create_collision_factors_array
— Methodcreate_collision_factors_array(n_species)
Create a 3-dimensional array of collision factors for all interaction pairs for a 0-D case (1 spatial cell), with shape (n_species,n_species,1)
.
Positional arguments
n_species
: number of species in the flow
Returns
3-dimensional array of CollisionFactors
instances with shape (n_species,n_species,1)
.
Merzbild.create_collision_factors_array
— Methodcreate_collision_factors_array(n_species, n_cells)
Create a 3-dimensional array of collision factors for all interaction pairs for all cells in the simulation, with shape (n_species,n_species,n_cells)
.
Positional arguments
n_species
: number of species in the flown_cells
: number of cells in the simulation
Returns
3-dimensional array of CollisionFactors
instances with shape (n_species,n_species,n_cells)
.
Merzbild.create_computed_crosssections
— Functioncreate_computed_crosssections(electron_neutral_interactions)
Create a vector of ComputedCrossSection
instances for the electron-neutral interactions.
Positional arguments
electron_neutral_interactions
: theElectronNeutralInteractions
instance for which the cross-sections will be computed
Returns
Vector of ComputedCrossSection
of length electron_neutral_interactions.n_neutrals
.
Merzbild.estimate_sigma_g_w_max
— Functionestimate_sigma_g_w_max(interaction, species1, species2, T1, T2, Fnum; mult_factor=1.0)
Estimate $(\sigma g w)_{max}$ for a two-species interaction, assuming a constant particle computational weight Fnum
and a VHS cross-section. The relative velocity $g$ is estimated as $g = 0.5 (\sqrt{2T_1 k_B / m_1} + \sqrt{2T_2 k_B / m_2})$, where $T_1$ and $m_1$ are the temperature and mass of the first species (species1
), and $T_2$ and $m_2$ are the temperature and mass of the second species (species2
). This relative velocity estimate is then plugged into the VHS cross-section model to compute $\sigma$. The result is then multiplied by Fnum
and an (optional) factor mult_factor
.
Positional arguments
interaction
: theInteraction
instance for the interacting speciesspecies1
: theSpecies
instance of the first interacting speciesspecies2
: theSpecies
instance of the second interacting speciesT1
: the temperature of the first interacting speciesT2
: the temperature of the second interacting speciesFnum
: the constant computational weight of the particles
Keyword arguments
mult_factor
: a factor by which to multiply the result (default value is 1.0)
Returns
- the estimate of $(\sigma g w)_{max}$
estimate_sigma_g_w_max(interaction, species, T, Fnum; mult_factor=1.0)
Estimate $(\sigma g w)_{max}$ for a single-species interaction, assuming a constant particle computational weight Fnum
and a VHS cross-section. Uses the same methodology as the estimate for a two-species interaction.
Positional arguments
interaction
: theInteraction
instance for the interacting speciesspecies
: theSpecies
instance of the interacting speciesT
: the temperature of the interacting speciesFnum
: the constant computational weight of the particles
Keyword arguments
mult_factor
: a factor by which to multiply the result (default value is 1.0)
Returns
- the estimate of $(\sigma g w)_{max}$
Merzbild.estimate_sigma_g_w_max!
— Functionestimate_sigma_g_w_max!(collision_factors, interactions, species_data, T_list, Fnum; mult_factor=1.0)
Estimate $(\sigma g w)_{max}$ for all species in all cells, assuming a constant particle computational weight Fnum
, a VHS cross-section, and that each species' temperature is constant across all cells. Uses the same methodology as the estimate for a two-species interaction.
Positional arguments
collision_factors
: 3-dimensional array ofCollisionFactors
of shape(n_species, n_species, n_cells)
interactions
: the 2-dimensional array ofInteraction
instances (of shape(n_species, n_species)
) of all the pair-wise interactionsspecies_data
: the vectorsSpecies
instances of the species in the flowT_list
: the list of temperatures of the speciesFnum
: the constant computational weight of the particles
Keyword arguments
mult_factor
: a factor by which to multiply the result (default value is 1.0)
Merzbild.estimate_sigma_g_w_max_ntc_n_e!
— FunctionEstimate $(\sigma g w)_{max}$ for an electron-neutral interaction by stochastically choosing particle pairs
Merzbild.ntc!
— Methodntc!(rng, collision_factors, collision_data, interaction, particles, pia,
cell, species, Δt, V)
Perform elastic collisions between particles of same species using the NTC algorithm and the VHS cross-section model.
Positional arguments
rng
: the random number generatorcollision_factors
: theCollisionFactors
for the species in question in the cellcollision_data
:CollisionData
instance used for storing collisional quantitiesinteraction
: 2-dimensional array ofInteraction
instances for all possible species pairsparticles
:ParticleVector
of the particles being collidedpia
: theParticleIndexerArray
cell
: the index of the cell in which collisions are performedspecies
: the index of the species for which collisions are performedΔt
: timestepV
: cell volume
Merzbild.ntc!
— Methodntc!(rng, collision_factors, collision_data, interaction,
particles_1, particles_2, pia,
cell, species1, species2, Δt, V)
Perform elastic collisions between particles of different species using the NTC algorithm and the VHS cross-section model.
Positional arguments
rng
: the random number generatorcollision_factors
: theCollisionFactors
for the species in question in the cellcollision_data
:CollisionData
instance used for storing collisional quantitiesinteraction
: 2-dimensional array ofInteraction
instances for all possible species pairsparticles_1
:ParticleVector
of the particles of the first species being collidedparticles_2
:ParticleVector
of the particles of the second species being collidedpia
: theParticleIndexerArray
cell
: the index of the cell in which collisions are performedspecies1
: the index of the first species for which collisions are performedspecies1
: the index of the second species for which collisions are performedΔt
: timestepV
: cell volume
Merzbild.ntc_n_e!
— FunctionPerform elastic scattering and ionizing collisions for electron-neutral interactions
Merzbild.ntc_n_e_es!
— FunctionPerform elastic scattering and ionizing collisions for electron-neutral interactions using the event splitting approach of Oblapenko et al. (2022)
Merzbild.fp!
— FunctionModel single-species elastic collisions using a linear Fokker-Planck approximation
Electron-neutral interactions
Merzbild.ElectronNeutralInteractions
— TypeElectronNeutralInteractions
Structure to hold data on electron-neutral interactions. The neutral_indexer
field is used to obtain the index of the species inside the structure, given an index of the neutral species in the full list of species in the simulation. For example, if we have a following list of species in the simulation: [e-, He, Ar+, He+, Ar]
, n_neutrals=2
, the ElectronNeutralInteractions
instance stores data for interactions of electrons with [He, Ar]
, and neutral_indexer[2] = 1
, neutral_indexer[5] = 2
.
Fields
n_neutrals
: number of neutral species for which the data has been loadedneutral_indexer
: array that maps indices of neutral species in the full list of species to local indices in theElectronNeutralInteractions
structureelastic
: an array ofElasticScattering
instances (of lengthn_neutrals
) holding the cross-section data on elastic scattering for each neutral speciesionization
: an array ofIonization
instances (of lengthn_neutrals
) holding the cross-section data on electron-impact ionization for each neutral speciesexcitation_sink
: an array ofExcitationSink
instances (of lengthn_neutrals
) holding the cross-section data on electron-impact electronic excitation for each neutral species
Merzbild.ComputedCrossSections
— TypeComputedCrossSections
Structure to hold data on computed cross-sections of electron-neutral interactions for a specific neutral species.
Fields
n_excitations
: number of electron-impact excitation reactionscs_total
: the computed total cross-section (sum of cross-sections of all processes)cs_elastic
: the computed elastic scattering cross-sectioncs_ionization
: the computed electron-impact ionization cross-sectioncs_excitation
: the computed electron-impact electronic excitation cross-sectionprob_vec
: a vector of probabilities of the processes (of length2+n_excitations
).prob_vec[1]
is the probability of elastic scattering,prob_vec[2]
is the probability of electron-impact ionization,prob_vec[3:2+n_excitations]
are the probabilities of thcdf_prob_vec
: a vector of cumulative probabilities of the processes (of length3+n_excitations
), used for sampling a specific process:cfd_prob_vec[1] = 0.0
,cfd_prob_vec[n] = cfd_prob_vec[n-1] + prob_vec[n-1], n>1
Merzbild.ElectronEnergySplit
— TypeElectronEnergySplit ElectronEnergySplitEqual=1 ElectronEnergySplitZeroE=2
Enum for various splittings of electron energy in electron-impact ionization reactions. ElectronEnergySplitEqual
corresponds to energy being shared equally amongst the electrons, ElectronEnergySplitZeroE
corresponds to the one-takes-all sharing model.
Merzbild.ScatteringLaw
— TypeScatteringLaw ScatteringIsotropic=1 ScatteringOkhrimovskyy=2
Enum for various scattering laws in electron-neutral interactions. ScatteringIsotropic
corresponds to isotropic scattering, ScatteringOkhrimovskyy
to the scattering model of A. Okhrimovskyy et al., 2002.
Merging
Grid merging
Merzbild.GridN2Merge
— TypeStruct for merging on a velocity grid
Fields
Nx
: number of cells
Merzbild.GridN2Merge
— MethodGridN2Merge(Nx::Int, Ny::Int, Nz::Int, extent_multiplier::T) where T <: AbstractArray
Create velocity grid-based merging
Positional arguments
Nx
: number of cells in vx directionNy
: number of cells in vy direction
Merzbild.GridN2Merge
— MethodGridN2Merge(N::Int, extent_multiplier::T) where T <: AbstractArray
Create velocity grid-based merging with equal number of cells in each direction
Merzbild.GridN2Merge
— MethodGridN2Merge(Nx::Int, Ny::Int, Nz::Int, extent_multiplier::Float64)
Create velocity grid-based merging with single multiplier
Merzbild.GridN2Merge
— MethodGridN2Merge(Nx::Int, Ny::Int, Nz::Int,
extent_multiplier_x::Float64,
extent_multiplier_y::Float64,
extent_multiplier_z::Float64)
Create velocity grid-based merging
Merzbild.GridN2Merge
— MethodGridN2Merge(N::Int, extent_multiplier::Float64)
Create velocity grid-based merging with equal number of cells in each direction, single multiplier
Merzbild.merge_grid_based!
— FunctionMerge particles using a velocity grid-based merging approach
NNLS merging
Merzbild.NNLSMerge
— TypeStruct for keeping track of merging-related quantities for NNLS merging
Merzbild.NNLSMerge
— MethodNNLSMerge(multi_index_moments, init_np; rate_preserving=false)
Create NNLS-based merging
Positional arguments
multi_index_moments
: vector of mixed moments to preserve, [(i1, j1, k1), (i2, j2, k2), ...] Mass/momentum/directionalenergy are always conserved! (Added automatically if not in list)init_np
: initial number of particles to pre-allocated memory for
Keyword arguments:
rate_preserving
: used for rate-preserving merging of electrons, preserves approximate elastic collision and ionization rates
Merzbild.compute_multi_index_moments
— FunctionCompute all mixed moments of total order up to n
Merzbild.merge_nnls_based!
— FunctionPerform NNLS-based merging
Merzbild.merge_nnls_based_rate_preserving!
— FunctionPerform NNLS-based merging, rate-preserving version
Octree merging
Merzbild.OctreeBinSplit
— TypeOctreeBinSplit OctreeBinMidSplit=1 OctreeBinMeanSplit=2 OctreeBinMedianSplit=3
Enum for octree bin splitting types
Merzbild.OctreeInitBin
— TypeOctreeInitBin OctreeInitBinMinMaxVel=1 OctreeInitBinMinMaxVelSym=2 OctreeInitBinC=3
Enum for initial bin bounds
Merzbild.OctreeBinBounds
— TypeOctreeBinBounds OctreeBinBoundsInherit=1 OctreeBinBoundsRecompute=2
Computation of bounds of split bin
Merzbild.OctreeN2Merge
— TypeStruct for N:2 Octree merging
Merzbild.OctreeN2Merge
— MethodOctreeN2Merge(split::OctreeBinSplit; init_bin_bounds=OctreeInitBinMinMaxVel, bin_bounds_compute=OctreeBinBoundsInherit,
max_Nbins=4096, max_depth=10)
Create Octree N:2 merging
Grids and particle sorting
Merzbild.Grid1DUniform
— TypeGrid1DUniform
1-D Uniform grid for a domain $[0,L]$
Fields
L
: length of the domainnx
: number of cellsΔx
: cell sizeinv_Δx
: inverse of cell sizecells
:Vector
ofCell1D
elementsmin_x
: minimum allowedx
coordinate for particles (slightly larger than $0$)max_x
: maximum allowedx
coordinate for particles (slightly smaller than $L$)
Merzbild.Grid1DUniform
— MethodGrid1DUniform(L, nx; wall_offset=1e-12)
Create 1-D uniform grid for a domain $[0, L]$ with nx
cells
Positional arguments
L
: length of the domainnx
: number of cells
Keyword arguments
wall_offset
: specifies a small relative offset from the walls so that particles never end up with a coordinate of exactly $0$ or $L$, otherwise some sorting routines may produce cell indices outside of the1:nx
range. The offset is computed asΔx * wall_offset
, whereΔx
is the cell size.
Merzbild.GridSortInPlace
— TypeGridSortInPlace
Struct for in-place sorting of particles.
Fields
cell_counts
: vector to store the number of particles in each cell + number of particles in all previous cellssorted_indices
: vector to store sorted particle indicesnon_contiguous_indices
: vector to store non-contiguous indices of the particles used in sorting in a contiguous array, in case the indices pointed to by aParticleIndexerArray
are not contiguous
Merzbild.GridSortInPlace
— MethodGridSortInPlace(grid, n_particles::Integer)
Create a GridSortInPlace
instance given a grid and number of particles.
Positional arguments
grid
: the grid on which to sort the particlesn_particles
: the (expected) number of particles in the simulation (to pre-allocate thesorted_indices
vector) - it is recommended to set this to the maximum expected number of particles in the simulation to avoid resizing of arrays during a simulation
Merzbild.sort_particles!
— Functionsort_particles!(gridsort::GridSortInPlace, grid, particles, pia, species)
Sort particles on a grid using an in-place sorting algorithm. The pia
instance is allowed to have non-contiguous indices (arising for example from merging).
Positional arguments
gridsort
: theGridSortInPlace
structuregrid
: the grid (should have ann_cells
field, and aget_cell
function has to be defined for the grid type)particles
: theParticleVector
of particles to be sortedpia
: theParticleIndexerArray
instancespecies
: the index of the species being sorted
Particle movement
Merzbild.convect_particles!
— Functionconvect_particles!(rng, grid::Grid1DUniform, boundaries::MaxwellWalls1D, particles, pia, species, species_data, Δt)
Convect particles on a 1-D uniform grid.
Positional arguments
rng
: the random number generatorgrid
: the grid on which the convection is performedboundaries
: theMaxwellWalls1D
struct describing the boundaries (it is assumed that the wall with index 1 is the left wall and the wall with index 2 is the right wall)particles
: theParticleVector
of particles to be convectedpia
: theParticleIndexerArray
instancespecies
: the index of the species being convectedspecies_data
: the vector ofSpecies
dataΔt
: the convection timestep
Particle-surface interactions
Merzbild.MaxwellWallBC
— TypeMaxwellWallBC
A struct to hold information about a diffuse reflecting wall.
Fields
T
: temperaturev
: wall velocity vectoraccommodation
: accommodation coefficient (a value of 0 corresponds to specular reflection, a value of 1 corresponds to purely diffuse reflection)
Merzbild.MaxwellWalls1D
— TypeMaxwellWalls1D
A struct to hold information about all diffuse reflecting walls in the simulation.
Fields
boundaries
: a vector ofMaxwellWallBC
wallsreflection_velocities_sq
: array of pre-computed squared thermal reflection velocities (nwalls x nspecies)
Merzbild.MaxwellWalls1D
— MethodMaxwellWalls1D(species_data, T_l::Float64, T_r::Float64, vy_l::Float64, vy_r::Float64, accomodation_l::Float64, accomodation_r::Float64)
Create a MaxwellWalls1D
struct for a 1-D simulation with 2 walls ("left" and "right") with a velocity in the y-direction only.
Positional arguments
species_data
: vector ofSpecies
dataT_l
: temperature of left wallT_r
: temperature of right wallvy_l
: y-velocity of left wallvy_r
: y-velocity of right wallaccomodation_l
: accommodation coefficient of left wallaccomodation_r
: accommodation coefficient of right wall
I/O
Merzbild.write_grid
— Functionwrite_grid(nc_filename, grid::Grid1DUniform; global_attributes=Dict{Any,Any}())
Write grid info to a NetCDF file
Positional arguments
nc_filename
: path to the NetCDF filegrid
: the grid to be written out to a file
Keyword arguments
global_attributes
: dictionary of additional global attributes to be written to the netCDF file
Merzbild.IOSkipList
— TypeStruct that holds track of which variables are not to be written to NetCDF file
Merzbild.IOSkipList
— MethodIOSkipList(list_of_variables_to_skip)
Construct an IOSkipList
from a list of variable names
Merzbild.IOSkipList
— MethodIOSkipList()
Construct an empty IOSkipList
Merzbild.NCDataHolder
— TypeStruct that holds NetCDF-output related data
Merzbild.NCDataHolder
— MethodNCDataHolder(nc_filename, names_skip_list, species_data, phys_props; global_attributes=Dict{Any,Any}())
Construct a NCDataHolder
instance
Merzbild.NCDataHolder
— MethodNCDataHolder(nc_filename, species_data, phys_props; global_attributes=Dict{Any,Any}())
Construct a NCDataHolder
instance with an empty list of variable to skip
Merzbild.close_netcdf
— FunctionClose NetCDF file
Merzbild.write_netcdf_phys_props
— FunctionWrite PhysProps to NetCDF file
Particle-in-Cell
Merzbild.accelerate_constant_field_x!
— Functionaccelerate_constant_field_x!(particles, pia, cell, species, species_data, E, Δt)
Accelerate particles with a constant electric field in the X direction
Positional arguments
particles
: vector-like structure of particles to be acceleratedpia
: ParticleIndexerArray instancecell
: index of the cell in which particles are being acceleratedspecies
: index of the species of the particles being acceleratedspecies_data
: aVector{Species}
instance with the species' dataE
: value of the electric field in V/mΔt
: timestep for which the acceleration is performed
Constants
Merzbild.k_B
— ConstantBoltzmann constant, J/K
Misc
Merzbild.DataMissingException
— TypeDataMissingException
Exception for the case of missing tabulated cross-section data
Fields
msg
: error message