Merzbild.jl internal API reference
The public API functions are exported by the module
Particle indexing
Merzbild.map_cont_index
— Functionmap_cont_index(particle_indexer, i)
Maps a continuous index in the range [0, n_local-1]
to an index in the particle array given a ParticleIndexer
instance describing how particle indices are split across 2 groups.
Positional arguments
particle_indexer
: theParticleIndexer
instancei
: the index to map
map_cont_index(pia, cell, species, i)
Maps a continuous index in the range [0, n_local-1]
to an index in the particle array for particles of a specific species in a specific cell.
Positional arguments
pia
: theParticleIndexerArray
instancecell
: the index of the cell in which the particles are locatedspecies
: the index of the particles' speciesi
: the index to map
Merzbild.update_particle_indexer_new_lower_count
— Functionupdate_particle_indexer_new_lower_count(pia, cell, species, new_lower_count)
Update a ParticleIndexerArray
instance when the particle count of a given species in a given cell is reduced.
Positional arguments
pia
: theParticleIndexerArray
instancecell
: the index of the cell in which the particles are locatedspecies
: the index of the particles' speciesnew_lower_count
: the new number of particles of the given species in the given cell
Merzbild.update_particle_indexer_new_particle
— Functionupdate_particle_indexer_new_particle(pia, cell, species)
Update a ParticleIndexerArray
instance when a particle of a given species in a given cell is created. This places the particle index in the 2-nd group of particle indices in the ParticleIndexer
instance.
Positional arguments
pia
: theParticleIndexerArray
instancecell
: the index of the cell in which the particle is createdspecies
: the index of the species of which the particle is created
Base.getindex
— FunctionBase.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!
— FunctionBase.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
— FunctionBase.length(pv::ParticleVector)
Returns the length of a ParticleVector
instance.
Is usually called as length(ParticleVector)
.
Positional arguments
pv
:ParticleVector
instance
Base.resize!
— FunctionBase.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)
Merzbild.update_particle_buffer_new_particle
— Methodupdate_particle_buffer_new_particle(pv::ParticleVector, position)
Update the buffer in a ParticleVector
instance when a new particle is created. This writes the index of the new particle (the last index stored in the active part of the buffer) to the index
vector at position position
, and reduces the length of the active part of the buffer by 1.
Positional arguments
pv
:ParticleVector
instanceposition
: the position in theindex
vector to which to write the index of the new particle
Merzbild.update_particle_buffer_new_particle
— Methodupdate_particle_buffer_new_particle(pv::ParticleVector, pia, species)
Update the buffer in a ParticleVector
instance when a new particle is created at the end of the particle array, and reduces the length of the active part of the buffer by 1. This assumes that the pia
structure has already an updated particle count (that accounts for the newly created particle), as the index of the new particle taken from the buffer is written to pv.index.[pia.n_total[species]]
.
Positional arguments
pv
:ParticleVector
instancepia
: theParticleIndexerArray
instancespecies
: the index of the species of which a new particle is created
Merzbild.update_particle_buffer_new_particle
— Methodupdate_particle_buffer_new_particle(pv::Vector{Particle}, pia, species)
Dummy function in case Vector{Particle}
is used and not a ParticleVector
, just to make the simplest 0-D examples work.
Merzbild.update_particle_buffer_new_particle
— Methodupdate_particle_buffer_new_particle(pv::Vector{Particle}, position)
Dummy function in case Vector{Particle}
is used and not a ParticleVector
, just to make the simplest 0-D examples work.
Merzbild.delete_particle!
— Functiondelete_particle!(pv::ParticleVector, pia, cell, species, i)
Delete particle with index i of species species
in cell cell
and update the particle indexers and buffers accordingly. This changes the ordering of the non-deleted particles in the cell.
Positional arguments
pv
:ParticleVector
instancepia
: theParticleIndexerArray
instancecell
: the index of the cell in which the particle is deletedspecies
: the index of the species of which the particle is deletedi
: the index of the particle to delete
Merzbild.delete_particle_end!
— Functiondelete_particle_end!(pv::ParticleVector, pia, cell, species)
Delete the last particle of species species
in cell cell
: if particles are present in the 2nd group of the indices stored in the ParticleIndexer
instance, it will delete the last particle in that group; otherwise it will delete the last particle in the 1st group of particles pointed to by the ParticleIndexer
instance. If no particles are present in the cell, the function does nothing.
Positional arguments
pv
:ParticleVector
instancepia
: theParticleIndexerArray
instancecell
: the index of the cell in which the particle is deletedspecies
: the index of the species of which the particle is deleted
Merzbild.delete_particle_end_group1!
— Functiondelete_particle_end_group1!(pv::ParticleVector, pia, cell, species)
Delete particle with index pia.indexer[cell, species].end1
of species
speciesin cell
cell` and update the particle indexers and buffers accordingly (i.e. delete the last particle in the 1st group of particles of a given species in a given cell). This also sets the weight of the deleted particle to 0. If no particles are present in the 1st group of particles, the function does nothing.
Positional arguments
pv
:ParticleVector
instancepia
: theParticleIndexerArray
instancecell
: the index of the cell in which the particle is deletedspecies
: the index of the species of which the particle is deleted
Merzbild.delete_particle_end_group2!
— Functiondelete_particle_end_group2!(pv::ParticleVector, pia, cell, species)
Delete particle with index pia.indexer[cell, species].end2
of species
speciesin cell
cell` and update the particle indexers and buffers accordingly (i.e. delete the last particle in the 2nd group of the particles of a given species in a given cell). This also sets the weight of the deleted particle to 0. If no particles are present in the 2nd group of particles, the function does nothing.
Positional arguments
pv
:ParticleVector
instancepia
: theParticleIndexerArray
instancecell
: the index of the cell in which the particle is deletedspecies
: the index of the species of which the particle is deleted
Loading species and interaction data
Merzbild.compute_mu_ref
— Functioncompute_mu_ref(m_r, vhs_o, vhs_Tref, vhs_d)
Compute reference viscosity for the VHS model.
Positional arguments
m_r
: collision-reduced massvhs_o
: exponent for the VHS potentialvhs_Tref
: reference temperature for the VHS potentialvhs_d
: diameter for the VHS potential
Returns
- reference viscosity
Sampling
Merzbild.UnitDVGrid
— TypeUnitDVGrid
Stores information about a uniform discrete 3-dimensional velocity grid with extent $[-1.0,1.0]\times[-1.0,1.0]\times[-1.0,1.0]$.
Fields
nx
: number of cells in x directionny
: number of cells in y directionnz
: number of cells in z directiondx
: grid spacing in x directiondy
: grid spacing in y directiondz
: grid spacing in z directionvx_grid
:Vector
of grid nodes in x directionvy_grid
:Vector
of grid nodes in y directionvz_grid
:Vector
of grid nodes in z direction
Merzbild.DVGrid
— TypeDVGrid
Stores information about a uniform discrete 3-dimensional velocity grid with extent $[-v_{x,max},v_{x,max}]\times[-v_{y,max},v_{y,max}]\times[-v_{z,max},v_{z,max}]$.
Fields
base_grid
: the underlying unit (non-scaled)UnitDVGrid
uniform gridvx_max
: extent of the grid in the x directionvy_max
: extent of the grid in the y directionvz_max
: extent of the grid in the z directiondy
: grid spacing in x directiondy
: grid spacing in y directiondz
: grid spacing in z directionvx_grid
:Vector
of grid nodes in x directionvy_grid
:Vector
of grid nodes in y directionvz_grid
:Vector
of grid nodes in z direction
Merzbild.VDF
— TypeVDF
Stores the values of a function evaluated on 3-dimensional velocity grid.
Fields
nx
: the number of grid elements in the x directionny
: the number of grid elements in the y directionnz
: the number of grid elements in the z directionw
: the 3-dimensional array of values
Merzbild.create_unit_dvgrid
— Functiongenerate a grid with extent [-1.0,1.0]x[-1.0,1.0]x[-1.0,1.0]
Merzbild.create_noiseless_dvgrid
— Functiongenerate a grid [-vxmax, vxmax]x[-vymax, vymax]x[-vzmax, vzmax]
Merzbild.create_vdf
— Functioncreate an empty VDF of size nx * ny * nz
Merzbild.sample_bkw!
— Functionsample_bkw!(rng, particles, nparticles, offset, m, T, v0)
Sample particle velocities from the BKW distribution with temperature T
for a species with mass m
at t=0
and add a velocity offset. Note: This does not update the particle weights, positions, or any indexing structures.
Positional arguments
rng
: the random number generatorparticles
: theVector
-like structure holding the particlesnparticles
: the number of particles to sampleoffset
: offset the starting position for writing the sampled particles to theparticles
arraym
: species' massT
: temperaturev0
: the 3-dimensional velocity to add to the sampled velocities
sample_bkw!(rng, particles, nparticles, m, T, v0)
Sample particles' velocities from the BKW distribution with temperature T
for a species with mass m
at t=0
and add a velocity offset. This does not update the particle weights, positions, or any indexing structures. The sampled particles are written to the start of the particles
array.
Positional arguments
rng
: the random number generatorparticles
: theVector
-like structure holding the particlesnparticles
: the number of particles to samplem
: species' massT
: temperaturev0
: the 3-dimensional velocity to add to the sampled velocities
Merzbild.evaluate_distribution_on_grid!
— Functionevaluate_distribution_on_grid!(vdf, distribution_function, grid, w_total, cutoff_v; normalize=true)
Evaluate 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 can be re-normalized so that the distribution has the prescribed computational weight/density.
Positional arguments
vdf
: TheVDF
instance where the evaluated values will be storeddistribution_function
: the distribution function to be evaluated which takes the x, y, and z velocities as parametersgrid
: theDVGrid
on which the distribution function is evaluatedw_total
: the total weight used in the re-normalizationcutoff_v
: the radius of the sphere used to cut off high velocities: on grid points outside the sphere the VDF will be 0
Keyword arguments
normalize
: iftrue
, the resulting values of the VDF will be renormalized so that their sum is equal tow_total
Merzbild.sample_maxwellian_single!
— Functionsample_maxwellian_single!(rng, v, m, T, v0)
Sample a single particle from a Maxwellian distribution with temperature T for a species with mass m and add a velocity offset.
Positional arguments
rng
: The random number generatorv
: the 3-dimensional vector to store the sampled velocitym
: the molecular mass of the speciesT
: the temperaturev_offset
: the offset velocity vector to be added to the sampled velocity
Merzbild.sample_maxwellian!
— Functionsample_maxwellian!(rng, particles, nparticles, offset, m, T, v0)
Sample nparticles
particles from a Maxwellian with temperature T for a species with mass m and add a velocity offset. Note: This does not update the particle weights, positions, or any indexing structures.
Positional arguments
rng
: the random number generatorparticles
: theVector
-like structure holding the particlesnparticles
: the number of particles to sampleoffset
: offset the starting position for writing the sampled particles to theparticles
arraym
: species' massT
: temperaturev0
: the 3-dimensional velocity to add to the sampled velocities
sample_maxwellian!(rng, particles, nparticles, m, T, v0)
Sample nparticles
particles from a Maxwellian with temperature T for a species with mass m and add a velocity offset. Note: This does not update the particle weights, positions, or any indexing structures. The sampled particles are written to the start of the particles
array.
Positional arguments
rng
: the random number generatorparticles
: theVector
-like structure holding the particlesnparticles
: the number of particles to samplem
: species' massT
: temperaturev0
: the 3-dimensional velocity to add to the sampled velocities
Collision computations
Merzbild.compute_n_coll_single_species
— Functioncompute_n_coll_single_species(rng, collision_factors, np, Δt, V)
Compute the non-integer number of collisions between particles of same species.
Positional arguments
rng
: the random number generatorcollision_factors
: theCollisionFactors
holding the estimate of $(\sigma g w)_{max}$ for the species in question in the cellnp
: number of particles in the cellΔt
: timestepV
: cell volume
Returns
The non-integer number of collisions.
Merzbild.compute_n_coll_two_species
— Functioncompute_n_coll_two_species(rng, collision_factors, np1, np2, Δt, V)
Compute number of collisions between particles of different species
Positional arguments
rng
: the random number generatorcollision_factors
: theCollisionFactors
holding the estimate of $(\sigma g w)_{max}$ for the species in question in the cellnp1
: number of particles of the first species in the cellnp2
: number of particles of the second species in the cellΔt
: timestepV
: cell volume
Returns
The non-integer number of collisions.
Merzbild.compute_vhs_factor
— Functioncompute_vhs_factor(vhs_Tref, vhs_d, vhs_o, m_r)
Compute interaction-specific factor $\pi D_{VHS}^2 (2 T_{ref,VHS}/m_r)^{(\omega_{VHS} - 0.5)} \frac{1}{\Gamma(2.5 - \omega_{VHS})}$.
Positional arguments
vhs_Tref
: reference temperature for the VHS potentialvhs_d
: diameter for the VHS potentialvhs_o
: exponent for the VHS potentialm_r
: collision-reduced mass
Returns
- computed VHS cross-section factor
Merzbild.compute_com!
— Functioncompute_com!(collision_data::CollisionData, interaction::Interaction, p1, p2)
Compute center of mass velocity of two particles.
Positional arguments
collision_data
: theCollisionData
instance where the computed velocity will be storedinteraction
: theInteraction
instance for the species of the colliding particlesp1
: the first particlep2
: the second particle
Merzbild.compute_g!
— Functioncompute_g!(collision_data::CollisionData, p1, p2)
Compute relative velocity (vector and its magnitude) of two particles.
Positional arguments
collision_data
: theCollisionData
instance where the computed velocity will be storedp1
: the first particlep2
: the second particle
Merzbild.compute_g_new_ionization!
— Functioncompute_g_new_ionization!(collision_data, interaction, E_i, energy_splitting)
Compute post-ionization magnitudes of the relative velocities of the impacting and newly created electrons.
Positional arguments
collision_data
: theCollisionData
instance where the computed velocity will be storedinteraction
: theInteraction
instance for the electron-neutral interaction which produced the ionE_i
: ionization energy of the neutral species in electron-voltenergy_splitting
: how the energy is divided among the electrons: ifElectronEnergySplitEqual
, the energy is split equally, ifElectronEnergySplitZeroE
, one electron takes all of the energy
Merzbild.scatter_vhs!
— Functionscatter_vhs!(rng, collision_data, interaction, p1, p2)
Scatter two particles using VHS (isotropic) scattering.
Positional arguments
rng
: the random number generatorcollision_data
: theCollisionData
instance to which stores the center-of-mass velocity, the magnitude of the pre-collisional relative velocity of the particles and to which the new post-collisional velocity will be writteninteraction
: theInteraction
instance for the colliding particlesp1
: the first colliding particlep2
: the second colliding particle
Merzbild.scatter_electron_vhs!
— Functionscatter_vhs!(rng, collision_data, interaction, p1, p2)
Scatter an electron off of a neutral particle using VHS (isotropic) scattering and re-scale its relative velocity to g_new
.
Positional arguments
rng
: the random number generatorcollision_data
: theCollisionData
instance to which stores the center-of-mass velocity and the magnitude of the pre-collisional relative velocity of the electron and the neutralparticles_electron
: the electron particle to scatter off of the neutral particleg_new
: the magnitude of the post-collisional relative velocity
Merzbild.scatter_ionization_electrons!
— Functionscatter_ionization_electrons!(rng, collision_data, particles_electron, i1, i2)
Scatter two electrons off of a neutral using VHS (isotropic) scattering.
Positional arguments
rng
: the random number generatorcollision_data
: theCollisionData
instance to which stores the center-of-mass velocity the magnitude of the pre-collisional relative velocity of the electron and the neutral, and the post-collisional magnitudes of the velocities of the electronsparticles_electron
: the vector of electron particles to scatter off of the neutral particlei1
: the index of the first electron particle to scatter off of the neutrali2
: the index of the second electron particle to scatter off of the neutral
Merzbild.sigma_vhs
— Functionsigma_vhs(interaction, g)
Computes the VHS cross-section.
Positional arguments
interaction
: theInteraction
instanceg
: the relative velocity of the collision
Returns
The value of the computed cross-section.
Merzbild.compute_tabulated_cs_constant_continuation
— Functioncompute_tabulated_cs_constant_continuation(tabulated_cs_data, E_coll)
Compute an energy-dependent cross-section from tabulated data using linear interpolation. If the energy is smaller than the minimum energy used for the tabulation, return first element of the table; if energy is larger than the maximum energy used for the tabulation, return last element of the table.
Positional arguments
tabulated_cs_data
: aTabulatedCSData
instance with the tabulated energies and cross-section valuesE_coll
: the collision energy for which to compute the cross-section
Returns
The value of the cross-section.
Merzbild.compute_tabulated_cs_zero_continuation
— Functioncompute_tabulated_cs_zero_continuation(tabulated_cs_data, E_coll)
Compute an energy-dependent cross-section from tabulated data using linear interpolation. If the energy is outside of the range of energies used for the tabulation, returns 0.0.
Positional arguments
tabulated_cs_data
: aTabulatedCSData
instance with the tabulated energies and cross-section valuesE_coll
: the collision energy for which to compute the cross-section
Returns
The value of the cross-section.
Merzbild.compute_cross_sections_only!
— Functioncompute_cross_sections_only!(computed_cs, interaction, g, electron_neutral_interactions, neutral_species_index)
Compute electron-impact ionization and excitation cross-sections, and electron-neutral elastic scattering crosss-sections, and return collision energy in eV. Here neutral_species_index
is the index of the neutral species being considered in the overall array of the Species
instances that includes all species in the simulation and was used to construct the ElectronNeutralInteractions
instance.
Positional arguments
computed_cs
: the vector ofComputedCrossSection
instances in which the computed values will be storedinteraction
: theInteraction
instance describing the electron-neutral interaction being consideredg
: the magnitude of the relative collision velocityelectron_neutral_interactions
: theElectronNeutralInteractions
instance storing the tabulated cross-section dataneutral_species_index
: the index of the neutral species being considered
Returns
The electron-neutral collision energy in eV.
Merzbild.compute_cross_sections!
— Functioncompute_cross_sections!(computed_cs, interaction, g, electron_neutral_interactions, neutral_species_index)
Compute electron-impact ionization and excitation cross-sections, electron-neutral elastic scattering cross-sections, total collision cross-section, probabilities of the different processes, and return collision energy in eV. Here neutral_species_index
is the index of the neutral species being considered in the overall array of the Species
instances that includes all species in the simulation and was used to construct the ElectronNeutralInteractions
instance.
Positional arguments
computed_cs
: the vector ofComputedCrossSection
instances in which the computed values will be storedinteraction
: theInteraction
instance describing the electron-neutral interaction being consideredg
: the magnitude of the relative collision velocityelectron_neutral_interactions
: theElectronNeutralInteractions
instance storing the tabulated cross-section dataneutral_species_index
: the index of the neutral species being considered
Returns
The electron-neutral collision energy in eV.
Merzbild.get_cs_total
— Functionget_cs_total(electron_neutral_interactions, computed_cs, neutral_species_index)
Get the value of a computed total collision cross-section for electron-neutral interactions. Here neutral_species_index
is the index of the neutral species being considered in the overall array of the Species
instances that includes all species in the simulation and was used to construct the ElectronNeutralInteractions
instance.
Positional arguments
electron_neutral_interactions
: theElectronNeutralInteractions
instance storing the tabulated cross-section datacomputed_cs
: the vector ofComputedCrossSection
instances holding the computed cross-section valuesneutral_species_index
: the index of the neutral species being considered
Returns
The value of the total collision cross-section.
Merzbild.get_cs_elastic
— Functionget_cs_elastic(electron_neutral_interactions, computed_cs, neutral_species_index)
Get the value of a computed electron-neutral elastic scattering cross-section. Here neutral_species_index
is the index of the neutral species being considered in the overall array of the Species
instances that includes all species in the simulation and was used to construct the ElectronNeutralInteractions
instance.
Positional arguments
electron_neutral_interactions
: theElectronNeutralInteractions
instance storing the tabulated cross-section datacomputed_cs
: the vector ofComputedCrossSection
instances holding the computed cross-section valuesneutral_species_index
: the index of the neutral species being considered
Returns
The value of the elastic scattering cross-section.
Merzbild.get_cs_ionization
— Functionget_cs_ionization(electron_neutral_interactions, computed_cs, neutral_species_index)
Get the value of a computed electron-impact ionization cross-section. Here neutral_species_index
is the index of the neutral species being considered in the overall array of the Species
instances that includes all species in the simulation and was used to construct the ElectronNeutralInteractions
instance.
Positional arguments
electron_neutral_interactions
: theElectronNeutralInteractions
instance storing the tabulated cross-section datacomputed_cs
: the vector ofComputedCrossSection
instances holding the computed cross-section valuesneutral_species_index
: the index of the neutral species being considered
Returns
The value of the electron-impact ionization scattering cross-section.
Merzbild.get_ionization_threshold
— Functionget_ionization_threshold(electron_neutral_interactions, neutral_species_index)
Get the ionization threshold energy. Here neutral_species_index
is the index of the neutral species being considered in the overall array of the Species
instances that includes all species in the simulation and was used to construct the ElectronNeutralInteractions
instance.
Positional arguments
electron_neutral_interactions
theElectronNeutralInteractions
instance storing the tabulated cross-section dataneutral_species_index
: the index of the neutral species being considered
Returns
The ionization threshold energy of a specific neutral species.
Merzbild.get_electron_energy_split
— Functionget_electron_energy_split(electron_neutral_interactions, neutral_species_index)
Get the way electron energy is split during ionization for a specific electron-neutral interaction. Here neutral_species_index
is the index of the neutral species being considered in the overall array of the Species
instances that includes all species in the simulation and was used to construct the ElectronNeutralInteractions
instance.
Positional arguments
electron_neutral_interactions
theElectronNeutralInteractions
instance storing the tabulated cross-section dataneutral_species_index
: the index of the neutral species being considered
Returns
The ElectronEnergySplit
value for the specific electron-neutral interaction.
Electron-neutral interactions
Merzbild.TabulatedCSData
— TypeTabulatedCSData
Structure for storing tabulated cross-section data as a function of relative collision energy
Fields
n_vals
: number of values storedE
: array of relative collision energiessigma
: array of cross-section values at these energiesΔE
: how much energy is lost (gained) in the collision in case it is inelastic
Merzbild.ElasticScattering
— TypeElasticScattering
Structure to hold data on an elastic scattering cross-section.
Fields
data
: aTabulatedCSData
instance holding the cross-section valuesscattering
: theScatteringLaw
model for the scattering of the particles
Merzbild.ExcitationSink
— TypeIonization
Structure to hold data on electron-impact electronic excitation cross-sections for a specific species.
Fields
n_reactions
: number of electron-impact electronic excitation reactionsdata
: an array ofTabulatedCSData
instances (of lengthn_reactions
) holding the cross-section values for each reactionscattering
: theScatteringLaw
model for the scattering of the particles
Merzbild.Ionization
— TypeIonization
Structure to hold data on an electron-impact ionization cross-section.
Fields
data
: aTabulatedCSData
instance holding the cross-section valuesscattering
: theScatteringLaw
model for the scattering of the electronssplit
: theElectronEnergySplit
model for energy splitting across the primary and secondary electrons
Merzbild.find_species_in_db
— FunctionFind a chemical species in an LXCat-format XML; returns the first instance of the species found and the id of the "Groups" element in which the species was found. The following conditions need to be satisfied for a tuple (i,j)
for it to be returned: tag(xml_data[i]) == "Groups"
and attributes(xml_data[i][j])["id"] == species_name
.
Positional arguments
xml_data
: the LXCat-format XML data to be searchedspecies_name
: the name of the species to search for
Returns
Tuple (i,j)
denoting the index of the group and group element in which the species is located
Merzbild.load_elastic_data
— Functionload_elastic_data(xml_data)
Load electron-neutral elastic scattering data from the part of an LXCat-format XML file for a specific species. The following should hold for the data to be loaded: tag(xml_data[i]) == "Processes"
, attributes(xml_data[i][j])["type"] == "Ionization"
. This will load the first set of data found for the ionization process.
Positional arguments
xml_data
: the LXCat-format XML data to be searched
Returns
TabulatedCSData
structure containing the electron-neutral elastic scattering cross-section data.
Throws
DataMissingException
if data not found or not all required data present.
Merzbild.load_ionization_data
— Functionload_ionization_data(xml_data)
Load electron-impact ionization data from the part of an LXCat-format XML file for a specific species. The following should hold for the data to be loaded: tag(xml_data[i]) == "Processes"
, attributes(xml_data[i][j])["type"] == "Ionization"
. This will load the first set of data found for the ionization process.
Positional arguments
xml_data
: the LXCat-format XML data to be searched
Returns
TabulatedCSData
structure containing the electron-impact ionization cross-section data.
Throws
DataMissingException
if data not found or not all required data present.
Merging
Merzbild.GridCell
— TypeStruct for keeping track of merging-related quantities in a velocity grid cell
Merzbild.compute_velocity_extent!
— FunctionCompute extent of velocity grid based on temperature in the cell
Merzbild.compute_grid_index
— FunctionCompute index of particle on the merging grid
Merzbild.clear_merging_grid!
— FunctionReset merging grid
Merzbild.compute_grid!
— FunctionCompute properties for all cells on the merging grid
Merzbild.compute_new_particles!
— FunctionCompute new particles based on the grid cell properties without checking particle locations
Compute post-merge particles
Merzbild.vx_sign
— FunctionReturn sign of velocity vx of an octant in velocity space
Merzbild.vy_sign
— FunctionReturn sign of velocity vy of an octant in velocity space
Merzbild.vz_sign
— FunctionReturn sign of velocity vz of an octant in velocity space
Merzbild.check_speed_bound
— FunctionCheck speed bound
Check speed bound with multiplier
Merzbild.base_multi_index_moments
— FunctionBase multi indices corresponding to conservation of mass momentum and energy components
Merzbild.compute_w_total_v0!
— FunctionCompute total computational weight of particles and mean velocity, as well as velocity bounds
Merzbild.ccm
— FunctionCompute unweighted centered moment
Compute unweighted centered moment
Merzbild.compute_lhs_and_rhs!
— FunctionCompute LHS matrix and RHS vector for NNLS merging
Merzbild.compute_lhs_and_rhs_rate_preserving!
— FunctionCompute LHS matrix and RHS vector for NNLS merging, rate-preserving version
Merzbild.compute_lhs_particles_additional!
— FunctionCompute additional LHS columns for additional particles
Merzbild.compute_lhs_particles_additional_rate_preserving!
— FunctionCompute additional LHS columns for additional particles, rate preserving
Merzbild.scale_lhs_rhs!
— FunctionScale LHS and RHS
Merzbild.scale_lhs_rhs_rate_preserving!
— FunctionScale LHS and RHS, rate-preserving version
Merzbild.compute_post_merge_particles_nnls!
— FunctionCompute post-merge particles
Merzbild.OctreeCell
— TypeStruct holding data needed for refinement of an octree bin
Merzbild.OctreeFullCell
— TypeOctree bin properties required to merge the particles in a bin
Merzbild.fill_bins
— FunctionFill the octree bins struct with zero data
Merzbild.fill_full_bins
— FunctionFill the octree full bins struct with zero data
Merzbild.clear_octree!
— FunctionReset octree
Merzbild.resize_octree_buffers!
— FunctionResize octree buffers
Merzbild.compute_octant
— FunctionCompute octant of particle velocity relative to a v_middle
`
Merzbild.bin_bounds_inherit!
— FunctionCompute new bin bounds of sub-bin inheriting bounds of parent bin
Merzbild.bin_bounds_recompute!
— FunctionRecompute bin bounds based on particle velocities
Merzbild.compute_v_mean!
— FunctionCompute mean velocity of bin
Merzbild.compute_v_median!
— FunctionCompute median velocity of bin
Merzbild.get_new_bin_id
— FunctionGet index of a newly created bin
Merzbild.split_bin!
— FunctionSort particles into sub-bins, split bin, keeping track of which sub-bins particles end up in
Merzbild.compute_bin_props!
— FunctionCompute properties in a bin required for merging
Merzbild.get_bin_post_merge_np
— FunctionGet number of post-merge particles in a bin
Merzbild.init_octree!
— FunctionInitialize the top bin in an octree
Merzbild.merge_octree_N2_based!
— FunctionPerform N:2 merging
Grids
Merzbild.Cell1D
— TypeCell1D
Cell element of a 1-D grid
Fields
xlo
: coordinate of the left end of the elementxhi
: coordinate of the right end of the elementV
: cell volume
Merzbild.get_cell
— Functionget_cell(grid1duniform::Grid1DUniform, x_pos)
Find in which cell of 1-D uniform grid the coordinate is located
Positional arguments
grid1duniform
: the 1-D uniform gridx_pos
: the 3-D coordinate vector for the which the cell index is to be determined (only the first component is used)
Particle movement
Merzbild.convect_single_particle!
— Functionconvect_single_particle!(rng, grid::Grid1DUniform, boundaries::MaxwellWalls1D, particle, species, Δt)
Convect a singe particle 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
: the particle to be convectedspecies
: the index of the species being convectedΔt
: the convection timestep
Particle-surface interactions
Merzbild.specular_reflection_x!
— Functionspecular_reflection_x!(particle)
Perform specular reflection of a particle in the x direction.
Positional arguments
particle
: theParticle
instance for which the velocity is reflected
Merzbild.diffuse_reflection_x!
— Functionspecular_reflection_x!(particle)
Perform diffuse reflection of a particle, assuming the wall is orthogonal to the x axis.
Positional arguments
rng
: the random number generatorparticle
: theParticle
instance for which the velocity is reflectedwall_reflection_v_sq
: the squared thermal velocity of the species reflected at the wall temperaturewall_normal_sign
: sign of the wall normalwall_v
: wall velocity vector
Merzbild.reflect_particle_x!
— Functionreflect_particle_x!(rng, particle, wall_reflection_v_sq, wall_normal_sign, wall_v, wall_accommodation)
Reflect particle from a Maxwell wall orthogonal to the x axis.
Positional arguments
rng
: the random number generatorparticle
: theParticle
instance for which the velocity is reflectedwall_reflection_v_sq
: the squared thermal velocity of the species reflected at the wall temperaturewall_normal_sign
: sign of the wall normalwall_v
: wall velocity vectorwall_accommodation
: wall accommodation coefficient
Constants
Merzbild.c_light
— ConstantSpeed of light, m/s
Merzbild.eV
— ConstantElectron-Volt, K
Merzbild.eV_J
— ConstantElectron-Volt, J
Merzbild.eV_J_inv
— Constant1.0/eV[J], 1/J (or equivalent to how much 1 J is equal to expressed in eV)
Merzbild.twopi
— Constant$2 \pi$
Merzbild.e_mass_div_electron_volt
— ConstantElectron mass divided by 1 eV, kg/J
Merzbild.direction_signs
— ConstantPositive and negative direction signs
Merzbild.q_e
— ConstantElementary charge, C
Misc
Merzbild.compute_thermal_velocity
— Functioncompute_thermal_velocity(m, T)
Compute the thermal velocity $\sqrt(2kT/m)$.
Positional arguments
m
: the molecular mass of the speciesT
: the temperature
Returns
The thermal velocity
Merzbild.binary_search
— Functionbinary_search(x, val)
Binary search for value val
in a sorted array x
. Finds the position mid
such that x[mid] < val < x[mid+1]
.
Positional arguments
x
: the sorted array to be searchedval
: the value to search for
Returns
-1
ifval < x[1]
0
ifval > x[end]
- Otherwise, returns the index
mid
satisfyingx[mid] < val < x[mid+1]
Merzbild.linear_interpolation
— Functionlinear_interpolation(x, y, val, pos, lower_limit, upper_limit)
Perform linear interpolation of a tabulated function y(x)
, given a parameter value val
, a sorted array of values of x
and corresponding values of y
, as well as the index of the closest values of x
to val
. In case val
is outside of the limits of x
, return placeholder values. That is, given that x[pos] < val < x[pos+1]
, we want to interpolate y(val)
given that y[x[pos]] = y[pos], y[x[pos+1]] = y[pos+1]
.
Positional arguments
x
: the vector of values of the parameter of the function to be interpolatedy
: the vector of the corresponding function valuesval
: the value of the parameter at which the function is to be interpolatedpos
: the index of the element inx
such thatx[pos] < val < x[pos+1]
, or-1
ifval < x[1]
,0
ifval > x[end]
lower_limit
: the value to return ifval < x[1]
upper_limit
: the value to return ifval > x[end]
Returns
- The linearly interpolated value of
y(val)
ifx[1] <= val <= x[end]
lower_limit
, ifval < x[1]
upper_limit
, ifval > x[end]
Merzbild.compute_mixed_moment
— Functioncompute_mixed_moment(particles, pia, cell, species, powers; sum_scaler=1.0, res_scaler=1.0)
Compute mixed velocity moment of particles in a cell: $\sum_i w_i v_{x,i}^{p_x} v_{y,i}^{p_y} v_{z,i}^{p_z}$
Positional arguments
particles
: theVector
ofParticleVector
s containing all the particles in a simulationpia
: theParticleIndexerArray
instancecell
: the cell in which the moment is being computedspecies
: the species for which the mixed moment is being computedpowers
: aVector
of the powers to which the x-, y-, and z-components of the velocity are to be raised
Keyword arguments
sum_scaler
: during the summation over the particles, scale each summand by this factor potentially reduce round-off issuesres_scaler
: scaling factor by which to multiply the result at the end
NNLS
Merzbild.solve!
— FunctionAlgorithm NNLS: NONNEGATIVE LEAST SQUARES
The original version of this code was developed by Charles L. Lawson and Richard J. Hanson at Jet Propulsion Laboratory 1973 JUN 15, and published in the book "SOLVING LEAST SQUARES PROBLEMS", Prentice-HalL, 1974. Revised FEB 1995 to accompany reprinting of the book by SIAM.
GIVEN AN M BY N MATRIX, A, AND AN M-VECTOR, B, COMPUTE AN N-VECTOR, X, THAT SOLVES THE LEAST SQUARES PROBLEM A * X = B SUBJECT TO X .GE. 0
Merzbild.construct_householder!
— FunctionCONSTRUCTION AND/OR APPLICATION OF A SINGLE HOUSEHOLDER TRANSFORMATION.. Q = I + U*(U**T)/B
The original version of this code was developed by Charles L. Lawson and Richard J. Hanson at Jet Propulsion Laboratory 1973 JUN 12, and published in the book "SOLVING LEAST SQUARES PROBLEMS", Prentice-HalL, 1974. Revised FEB 1995 to accompany reprinting of the book by SIAM.
Merzbild.fastview
— FunctionUnsafeVectorView only works for isbitstype types. For other types, we're already allocating lots of memory elsewhere, so creating a new View is fine.
This function looks type-unstable, but the isbitstype(T) test can be evaluated by the compiler, so the result is actually type-stable.
Fallback for non-contiguous arrays, for which UnsafeVectorView does not make sense.
Merzbild.solve_triangular_system!
— FunctionThe original version of this code was developed by Charles L. Lawson and Richard J. Hanson at Jet Propulsion Laboratory 1973 JUN 15, and published in the book "SOLVING LEAST SQUARES PROBLEMS", Prentice-HalL, 1974. Revised FEB 1995 to accompany reprinting of the book by SIAM.
Merzbild.UnsafeVectorView
— TypeViews in Julia still allocate some memory (since they need to keep a reference to the original array). This type allocates no memory and does no bounds checking. Use it with caution.
Merzbild.orthogonal_rotmat
— FunctionCOMPUTE ORTHOGONAL ROTATION MATRIX.. The original version of this code was developed by Charles L. Lawson and Richard J. Hanson at Jet Propulsion Laboratory 1973 JUN 12, and published in the book "SOLVING LEAST SQUARES PROBLEMS", Prentice-HalL, 1974. Revised FEB 1995 to accompany reprinting of the book by SIAM.
COMPUTE.. MATRIX (C, S) SO THAT (C, S)(A) = (SQRT(A2+B2)) (-S,C) (-S,C)(B) ( 0 ) COMPUTE SIG = SQRT(A2+B2) SIG IS COMPUTED LAST TO ALLOW FOR THE POSSIBILITY THAT SIG MAY BE IN THE SAME LOCATION AS A OR B .
Merzbild.apply_householder!
— FunctionCONSTRUCTION AND/OR APPLICATION OF A SINGLE HOUSEHOLDER TRANSFORMATION.. Q = I + U*(U**T)/B
The original version of this code was developed by Charles L. Lawson and Richard J. Hanson at Jet Propulsion Laboratory 1973 JUN 12, and published in the book "SOLVING LEAST SQUARES PROBLEMS", Prentice-HalL, 1974. Revised FEB 1995 to accompany reprinting of the book by SIAM.