SKIRT v9.0 (git 4fdaaf1-dirty built on 02/11/2025 at 09:46:57)
Introduction
This page lists the properties for each concrete SKIRT class that may occur as an object in a ski file.
The sections are listed alphabetically on class name. To quickly locate the section for a given class, use your browser's find function and precede the class name with a - (dash).
-AbsorptionOnlyMaterialMixDecorator
[docs] : a decorator that removes scattering from any material mix
| Compound Property | | Type | Base Class | | Description |
| materialMix | docs | Item | MaterialMix | subclasses | the material mix to be decorated |
-AdaptiveMeshGeometry
[docs] : a geometry imported from data represented on an adaptive mesh (AMR grid)
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file to be imported |
| minX | docs | Double | the start point of the domain in the X direction |
| maxX | docs | Double | the end point of the domain in the X direction |
| minY | docs | Double | the start point of the domain in the Y direction |
| maxY | docs | Double | the end point of the domain in the Y direction |
| minZ | docs | Double | the start point of the domain in the Z direction |
| maxZ | docs | Double | the end point of the domain in the Z direction |
| massType | docs | Enum | the type of mass quantity to be imported |
| | --> MassDensity | mass density |
| | --> Mass | mass (volume-integrated mass density) |
| | --> NumberDensity | number density |
| | --> Number | number (volume-integrated number density) |
| importMetallicity | docs | Bool | import a metallicity column |
| importTemperature | docs | Bool | import a temperature column |
| maxTemperature | docs | Double | the maximum temperature for included mass (or zero to include all) |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
-AdaptiveMeshMedium
[docs] : a transfer medium imported from data represented on an adaptive mesh (AMR grid)
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file to be imported |
| minX | docs | Double | the start point of the domain in the X direction |
| maxX | docs | Double | the end point of the domain in the X direction |
| minY | docs | Double | the start point of the domain in the Y direction |
| maxY | docs | Double | the end point of the domain in the Y direction |
| minZ | docs | Double | the start point of the domain in the Z direction |
| maxZ | docs | Double | the end point of the domain in the Z direction |
| massType | docs | Enum | the type of mass quantity to be imported |
| | --> MassDensity | mass density |
| | --> Mass | mass (volume-integrated) |
| | --> MassDensityAndMass | both mass density and volume-integrated mass |
| | --> NumberDensity | number density |
| | --> Number | number (volume-integrated) |
| | --> NumberDensityAndNumber | both number density and volume-integrated number |
| massFraction | docs | Double | the fraction of the mass to be included (or one to include all) |
| importMetallicity | docs | Bool | import a metallicity column |
| importTemperature | docs | Bool | import a temperature column |
| maxTemperature | docs | Double | the maximum temperature for included mass (or zero to include all) |
| importVelocity | docs | Bool | import velocity components (3 columns) |
| importMagneticField | docs | Bool | import magnetic field components (3 columns) |
| importVariableMixParams | docs | Bool | import parameter(s) to select a spatially varying material mix |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
| Compound Property | | Type | Base Class | | Description |
| materialMix | docs | Item | MaterialMix | subclasses | the material type and properties throughout the medium |
| materialMixFamily | docs | Item | MaterialMixFamily | subclasses | the material mix family addressed by the imported parameter(s) |
-AdaptiveMeshSource
[docs] : a primary source imported from data represented on an adaptive mesh (AMR grid)
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file to be imported |
| minX | docs | Double | the start point of the domain in the X direction |
| maxX | docs | Double | the end point of the domain in the X direction |
| minY | docs | Double | the start point of the domain in the Y direction |
| maxY | docs | Double | the end point of the domain in the Y direction |
| minZ | docs | Double | the start point of the domain in the Z direction |
| maxZ | docs | Double | the end point of the domain in the Z direction |
| importVelocity | docs | Bool | import velocity components (3 columns) |
| importVelocityDispersion | docs | Bool | import velocity dispersion (spherically symmetric) |
| importCurrentMass | docs | Bool | import current mass |
| importBias | docs | Bool | import a per-particle/cell source bias weight |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
| sourceWeight | docs | Double | the weight of this source for the number of photon packets launched |
| wavelengthBias | docs | Double | the fraction of photon packet wavelengths sampled from a bias distribution |
| Compound Property | | Type | Base Class | | Description |
| sedFamily | docs | Item | SEDFamily | subclasses | the SED family for assigning spectra to the imported sources |
| wavelengthBiasDistribution | docs | Item | WavelengthDistribution | subclasses | the bias distribution for sampling photon packet wavelengths |
-AdaptiveMeshSpatialGrid
[docs] : a spatial grid taken from an imported adaptive mesh snapshot
-AllCellsLibrary
[docs] : a library scheme that has a separate entry for every spatial cell
-AllSkyInstrument
[docs] : an all-sky instrument (for observing inside a model)
| Scalar Property | | Type | Description |
| instrumentName | docs | String | the name for this instrument |
| numPixelsY | docs | Int | the number of image pixels in the vertical (shortest) direction |
| radius | docs | Double | the radius of the observer's all-sky sphere |
| observerX | docs | Double | the position of the observer, x component |
| observerY | docs | Double | the position of the observer, y component |
| observerZ | docs | Double | the position of the observer, z component |
| crossX | docs | Double | the position of the crosshair, x component |
| crossY | docs | Double | the position of the crosshair, y component |
| crossZ | docs | Double | the position of the crosshair, z component |
| upX | docs | Double | the upwards direction, x component |
| upY | docs | Double | the upwards direction, y component |
| upZ | docs | Double | the upwards direction, z component |
| recordComponents | docs | Bool | record flux components separately |
| numScatteringLevels | docs | Int | the number of individually recorded scattering levels |
| recordPolarization | docs | Bool | record polarization (Stokes vector elements) |
| recordStatistics | docs | Bool | record information for calculating statistical properties |
| Compound Property | | Type | Base Class | | Description |
| wavelengthGrid | docs | Item | WavelengthGrid | subclasses | the wavelength grid for this instrument |
| projection | docs | Item | AllSkyProjection | subclasses | the projection used for mapping the sky to a rectangle |
-AllSkyProjectionForm
[docs] : all-sky projection at a position inside the model
| Scalar Property | | Type | Description |
| numPixelsY | docs | Int | the number of image pixels in the vertical (shortest) direction |
| observerX | docs | Double | the position of the observer, x component |
| observerY | docs | Double | the position of the observer, y component |
| observerZ | docs | Double | the position of the observer, z component |
| crossX | docs | Double | the position of the crosshair, x component |
| crossY | docs | Double | the position of the crosshair, y component |
| crossZ | docs | Double | the position of the crosshair, z component |
| upX | docs | Double | the upwards direction, x component |
| upY | docs | Double | the upwards direction, y component |
| upZ | docs | Double | the upwards direction, z component |
| Compound Property | | Type | Base Class | | Description |
| projection | docs | Item | AllSkyProjection | subclasses | the projection used for mapping the sky to a rectangle |
-AnnulusGeometry
[docs] : an annulus geometry
| Scalar Property | | Type | Description |
| minRadius | docs | Double | the inner radius of the annulus |
| maxRadius | docs | Double | the outer radius of the annulus |
| height | docs | Double | the annulus height |
-AtPositionsForm
[docs] : a text column file with values for each imported position
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file listing the positions |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
-AxPowerLawRedistributeGeometryDecorator
[docs] : a decorator that redistributes another geometry with an axial power law
| Scalar Property | | Type | Description |
| RExponent | docs | Double | the negative power of the radial part of the weight function |
| zExponent | docs | Double | the negative power of the vertical part of the weight function |
| minR | docs | Double | the radius of the clipping cylinder around the z-axis |
| minZ | docs | Double | half the height of the clipping region around the xy-plane |
| Compound Property | | Type | Base Class | | Description |
| geometry | docs | Item | Geometry | subclasses | the geometry for which the density will be redistributed |
-BandLuminosityNormalization
[docs] : source normalization through the specific luminosity for a given wavelength band
| Scalar Property | | Type | Description |
| unitStyle | docs | Enum | the luminosity unit style |
| | --> neutralmonluminosity | neutral: λ L_λ = ν L_ν |
| | --> wavelengthmonluminosity | per unit of wavelength: L_λ |
| | --> frequencymonluminosity | per unit of frequency: L_ν |
| | --> energymonluminosity | counts per unit of energy: L_E |
| specificLuminosity | docs | Double | the specific luminosity for the given band |
| Compound Property | | Type | Base Class | | Description |
| band | docs | Item | Band | subclasses | the wavelength band for which to provide the specific luminosity |
-BegemannPorousAluminaGrainComposition
[docs] : a Begemann porous alumina dust grain composition
-BlackBodySED
[docs] : a black-body spectral energy distribution
| Scalar Property | | Type | Description |
| temperature | docs | Double | the black body temperature |
-BlackBodySEDFamily
[docs] : a black body SED family
-BoxClipGeometryDecorator
[docs] : a decorator that clips another geometry using a cubodial box
| Scalar Property | | Type | Description |
| remove | docs | Enum | the region to be removed |
| | --> Inside | the inner region (creating a cavity) |
| | --> Outside | the outer region (cropping) |
| minX | docs | Double | the start point of the box in the X direction |
| maxX | docs | Double | the end point of the box in the X direction |
| minY | docs | Double | the start point of the box in the Y direction |
| maxY | docs | Double | the end point of the box in the Y direction |
| minZ | docs | Double | the start point of the box in the Z direction |
| maxZ | docs | Double | the end point of the box in the Z direction |
| Compound Property | | Type | Base Class | | Description |
| geometry | docs | Item | Geometry | subclasses | the geometry to be clipped |
-BpassSED
[docs] : a BPASS single stellar population SED
| Scalar Property | | Type | Description |
| metallicity | docs | Double | the metallicity of the SSP |
| age | docs | Double | the age of the SSP |
-BpassSEDFamily
[docs] : a BPASS SED family for single stellar populations
| Scalar Property | | Type | Description |
| imf | docs | Enum | IMF |
| | --> Chabrier100 | Chabrier IMF (0.1-100 Msun) |
| | --> Chabrier300 | Chabrier IMF (0.1-300 Msun) |
| resolution | docs | Enum | the wavelength resolution |
| | --> Original | Original wavelength resolution and range |
| | --> Downsampled | Downsampled wavelength resolution and extended wavelength range |
-BroadBand
[docs] : a standard built-in broadband (transmission curve)
| Scalar Property | | Type | Description |
| bandName | docs | String | the name of the standard broadband (e.g. 'Johnson V' or 'PACS 100') |
-BrokenExpDiskGeometry
[docs] : a broken exponential disk geometry
| Scalar Property | | Type | Description |
| scaleLengthInner | docs | Double | the scale length of the inner disk |
| scaleLengthOuter | docs | Double | the scale length of the outer disk |
| scaleHeight | docs | Double | the scale height |
| breakRadius | docs | Double | the break radius |
| sharpness | docs | Double | the sharpness of the break |
-BruzualCharlotSED
[docs] : a Bruzual-Charlot simple stellar population SED
| Scalar Property | | Type | Description |
| imf | docs | Enum | the assumed initial mass function |
| | --> Chabrier | Chabrier IMF |
| | --> Salpeter | Salpeter IMF |
| metallicity | docs | Double | the metallicity of the SSP |
| age | docs | Double | the age of the SSP |
-BruzualCharlotSEDFamily
[docs] : a Bruzual-Charlot SED family for single stellar populations
| Scalar Property | | Type | Description |
| imf | docs | Enum | the assumed initial mass function |
| | --> Chabrier | Chabrier IMF |
| | --> Salpeter | Salpeter IMF |
| resolution | docs | Enum | the wavelength resolution |
| | --> Low | Low wavelength resolution (1221 points) |
| | --> High | High wavelength resolution (6900 points) |
-CartesianSpatialGrid
[docs] : a Cartesian spatial grid
| Scalar Property | | Type | Description |
| minX | docs | Double | the start point of the box in the X direction |
| maxX | docs | Double | the end point of the box in the X direction |
| minY | docs | Double | the start point of the box in the Y direction |
| maxY | docs | Double | the end point of the box in the Y direction |
| minZ | docs | Double | the start point of the box in the Z direction |
| maxZ | docs | Double | the end point of the box in the Z direction |
| Compound Property | | Type | Base Class | | Description |
| meshX | docs | Item | Mesh | subclasses | the bin distribution in the X direction |
| meshY | docs | Item | Mesh | subclasses | the bin distribution in the Y direction |
| meshZ | docs | Item | Mesh | subclasses | the bin distribution in the Z direction |
-CastelliKuruczSED
[docs] : a Castelli-Kurucz stellar atmosphere SED
| Scalar Property | | Type | Description |
| metallicity | docs | Double | the stellar metallicity |
| temperature | docs | Double | the effective surface temperature |
| gravity | docs | Double | the surface gravity |
-CastelliKuruczSEDFamily
[docs] : a Castelli-Kurucz SED family for stellar atmospheres
-CellGeometry
[docs] : a geometry imported from cuboidal cell data
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file to be imported |
| massType | docs | Enum | the type of mass quantity to be imported |
| | --> MassDensity | mass density |
| | --> Mass | mass (volume-integrated mass density) |
| | --> NumberDensity | number density |
| | --> Number | number (volume-integrated number density) |
| importMetallicity | docs | Bool | import a metallicity column |
| importTemperature | docs | Bool | import a temperature column |
| maxTemperature | docs | Double | the maximum temperature for included mass (or zero to include all) |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
-CellMedium
[docs] : a transfer medium imported from cuboidal cell data
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file to be imported |
| massType | docs | Enum | the type of mass quantity to be imported |
| | --> MassDensity | mass density |
| | --> Mass | mass (volume-integrated) |
| | --> NumberDensity | number density |
| | --> Number | number (volume-integrated) |
| massFraction | docs | Double | the fraction of the mass to be included (or one to include all) |
| importMetallicity | docs | Bool | import a metallicity column |
| importTemperature | docs | Bool | import a temperature column |
| maxTemperature | docs | Double | the maximum temperature for included mass (or zero to include all) |
| importVelocity | docs | Bool | import velocity components (3 columns) |
| importMagneticField | docs | Bool | import magnetic field components (3 columns) |
| importVariableMixParams | docs | Bool | import parameter(s) to select a spatially varying material mix |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
| Compound Property | | Type | Base Class | | Description |
| materialMix | docs | Item | MaterialMix | subclasses | the material type and properties throughout the medium |
| materialMixFamily | docs | Item | MaterialMixFamily | subclasses | the material mix family addressed by the imported parameter(s) |
-CellSource
[docs] : a primary source imported from cuboidal cell data
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file to be imported |
| importVelocity | docs | Bool | import velocity components (3 columns) |
| importVelocityDispersion | docs | Bool | import velocity dispersion (spherically symmetric) |
| importCurrentMass | docs | Bool | import current mass |
| importBias | docs | Bool | import a per-particle/cell source bias weight |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
| sourceWeight | docs | Double | the weight of this source for the number of photon packets launched |
| wavelengthBias | docs | Double | the fraction of photon packet wavelengths sampled from a bias distribution |
| Compound Property | | Type | Base Class | | Description |
| sedFamily | docs | Item | SEDFamily | subclasses | the SED family for assigning spectra to the imported sources |
| wavelengthBiasDistribution | docs | Item | WavelengthDistribution | subclasses | the bias distribution for sampling photon packet wavelengths |
-ClearDensityRecipe
[docs] : a recipe that clears material in cells above a given radiation field strength
| Scalar Property | | Type | Description |
| maxNotConvergedCells | docs | Int | the number of spatial cells allowed to not converge |
| fieldStrengthThreshold | docs | Double | the field strength above which material is cleared from a cell |
-ClumpyGeometryDecorator
[docs] : a decorator that adds clumpiness to any geometry
| Scalar Property | | Type | Description |
| clumpFraction | docs | Double | the fraction of the mass locked up in clumps |
| numClumps | docs | Int | the total number of clumps |
| clumpRadius | docs | Double | the scale radius of a single clump |
| cutoffClumps | docs | Bool | cut off clumps at the boundary of the underlying geometry |
| seed | docs | Int | the seed for the random clump position generator, or zero to use the default generator |
| Compound Property | | Type | Base Class | | Description |
| geometry | docs | Item | Geometry | subclasses | the geometry to be made clumpy |
| smoothingKernel | docs | Item | SmoothingKernel | subclasses | the smoothing kernel that describes the density of a single clump |
-CombineGeometryDecorator
[docs] : a decorator that combines two different geometries
| Scalar Property | | Type | Description |
| firstWeight | docs | Double | the weight of the first geometry |
| secondWeight | docs | Double | the weight of the second geometry |
| Compound Property | | Type | Base Class | | Description |
| firstGeometry | docs | Item | Geometry | subclasses | the first geometry |
| secondGeometry | docs | Item | Geometry | subclasses | the second geometry |
-CompositeWavelengthGrid
[docs] : a wavelength grid composited from a list of wavelength grids
| Scalar Property | | Type | Description |
| log | docs | Bool | use logarithmic scale |
| Compound Property | | Type | Base Class | | Description |
| wavelengthGrids | docs | ItemList | DisjointWavelengthGrid | subclasses | the wavelength grids to be composited |
-ConfigurableBandWavelengthGrid
[docs] : a wavelength grid including a configurable list of (broad)bands
| Compound Property | | Type | Base Class | | Description |
| bands | docs | ItemList | Band | subclasses | the (broad)bands defining this wavelength grid |
-ConfigurableDustMix
[docs] : a configurable dust mix with one or more grain populations
| Scalar Property | | Type | Description |
| scatteringType | docs | Enum | the type of scattering to be implemented |
| | --> HenyeyGreenstein | use the Henyey-Greenstein phase function (unpolarized) |
| | --> MaterialPhaseFunction | use the phase function derived from actual material properties (unpolarized) |
| | --> SphericalPolarization | support polarization through scattering by spherical grains |
| | --> SpheroidalPolarization | support polarization through scattering, absorption and emission by spheroidal grains |
| Compound Property | | Type | Base Class | | Description |
| populations | docs | ItemList | GrainPopulation | subclasses | the grain populations |
-ConicalAngularDistribution
[docs] : an anisotropic conical emission profile
| Scalar Property | | Type | Description |
| symmetryX | docs | Double | the direction of the positive symmetry axis, x component |
| symmetryY | docs | Double | the direction of the positive symmetry axis, y component |
| symmetryZ | docs | Double | the direction of the positive symmetry axis, z component |
| openingAngle | docs | Double | the (half) opening angle of the cone |
-ConicalShellGeometry
[docs] : a conical shell geometry
| Scalar Property | | Type | Description |
| exponent | docs | Double | the radial powerlaw exponent p of the conical shell |
| index | docs | Double | the polar index q of the conical shell |
| minAngle | docs | Double | the inner angle of the conical shell |
| maxAngle | docs | Double | the outer angle of the conical shell |
| minRadius | docs | Double | the minimum radius of the conical shell |
| maxRadius | docs | Double | the maximum radius of the conical shell |
| reshapeInnerRadius | docs | Bool | reshape the inner radius according to the Netzer luminosity profile |
| cutoffRadius | docs | Double | the inner cutoff radius of the conical shell |
-ConvergenceCutsProbe
[docs] : convergence: cuts of the medium density along the coordinate planes
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| probeAfter | docs | Enum | perform the probe after |
| | --> Setup | after setup |
| | --> Run | after the complete simulation run |
-ConvergenceInfoProbe
[docs] : convergence: information on the spatial grid
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| wavelength | docs | Double | the wavelength at which to determine the optical depth |
| probeAfter | docs | Enum | perform the probe after |
| | --> Setup | after setup |
| | --> Run | after the complete simulation run |
-CrystalEnstatiteGrainComposition
[docs] : a crystalline Enstatite dust grain composition
-CrystalForsteriteGrainComposition
[docs] : a crystalline Forsterite dust grain composition
-CubicSplineSmoothingKernel
[docs] : a cubic spline smoothing kernel
-CubicalBackgroundSource
[docs] : a cubical background source with an anisotropic inward radiation field
| Scalar Property | | Type | Description |
| centerX | docs | Double | the center of the source, x component |
| centerY | docs | Double | the center of the source, y component |
| centerZ | docs | Double | the center of the source, z component |
| edgeLength | docs | Double | the edge length of the background cube |
| velocityX | docs | Double | the bulk velocity of the source, x component |
| velocityY | docs | Double | the bulk velocity of the source, y component |
| velocityZ | docs | Double | the bulk velocity of the source, z component |
| sourceWeight | docs | Double | the weight of this source for the number of photon packets launched |
| wavelengthBias | docs | Double | the fraction of photon packet wavelengths sampled from a bias distribution |
| Compound Property | | Type | Base Class | | Description |
| sed | docs | Item | SED | subclasses | the spectral energy distribution for the source |
| normalization | docs | Item | LuminosityNormalization | subclasses | the type of luminosity normalization for the source |
| wavelengthBiasDistribution | docs | Item | WavelengthDistribution | subclasses | the bias distribution for sampling photon packet wavelengths |
-CustomStateProbe
[docs] : internal spatial grid: custom medium state quantities
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| indices | docs | String | zero-based indices or index ranges of quantities to probe, or empty for all |
| probeAfter | docs | Enum | perform the probe after |
| | --> Setup | after setup |
| | --> Run | after the complete simulation run |
| | --> Primary | after each iteration over primary emission |
| | --> Secondary | after each iteration over secondary emission |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | Form | subclasses | the form describing how this quantity should be probed |
-Cylinder2DSpatialGrid
[docs] : a 2D axisymmetric spatial grid in cylindrical coordinates
| Scalar Property | | Type | Description |
| minRadius | docs | Double | the inner cylindrical radius of the grid |
| maxRadius | docs | Double | the outer cylindrical radius of the grid |
| minZ | docs | Double | the start point of the cylinder in the Z direction |
| maxZ | docs | Double | the end point of the cylinder in the Z direction |
| Compound Property | | Type | Base Class | | Description |
| meshRadial | docs | Item | Mesh | subclasses | the bin distribution in the radial direction |
| meshZ | docs | Item | Mesh | subclasses | the bin distribution in the Z direction |
-Cylinder3DSpatialGrid
[docs] : a 3D spatial grid in cylindrical coordinates
| Scalar Property | | Type | Description |
| minRadius | docs | Double | the inner cylindrical radius of the grid |
| maxRadius | docs | Double | the outer cylindrical radius of the grid |
| minZ | docs | Double | the start point of the cylinder in the Z direction |
| maxZ | docs | Double | the end point of the cylinder in the Z direction |
| Compound Property | | Type | Base Class | | Description |
| meshRadial | docs | Item | Mesh | subclasses | the bin distribution in the radial direction |
| meshAzimuthal | docs | Item | Mesh | subclasses | the bin distribution in the azimuthal direction |
| meshZ | docs | Item | Mesh | subclasses | the bin distribution in the vertical direction |
-CylindricalCellGeometry
[docs] : a geometry imported from cylindrical cell data
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file to be imported |
| autoRevolve | docs | Bool | automatically revolve 2D data to a 3D model |
| numAutoRevolveBins | docs | Int | the number of azimuth bins for auto-revolving 2D data |
| massType | docs | Enum | the type of mass quantity to be imported |
| | --> MassDensity | mass density |
| | --> Mass | mass (volume-integrated mass density) |
| | --> NumberDensity | number density |
| | --> Number | number (volume-integrated number density) |
| importMetallicity | docs | Bool | import a metallicity column |
| importTemperature | docs | Bool | import a temperature column |
| maxTemperature | docs | Double | the maximum temperature for included mass (or zero to include all) |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
-CylindricalCellMedium
[docs] : a transfer medium imported from cylindrical cell data
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file to be imported |
| autoRevolve | docs | Bool | automatically revolve 2D data to a 3D model |
| numAutoRevolveBins | docs | Int | the number of azimuth bins for auto-revolving 2D data |
| massType | docs | Enum | the type of mass quantity to be imported |
| | --> MassDensity | mass density |
| | --> Mass | mass (volume-integrated) |
| | --> NumberDensity | number density |
| | --> Number | number (volume-integrated) |
| massFraction | docs | Double | the fraction of the mass to be included (or one to include all) |
| importMetallicity | docs | Bool | import a metallicity column |
| importTemperature | docs | Bool | import a temperature column |
| maxTemperature | docs | Double | the maximum temperature for included mass (or zero to include all) |
| importVelocity | docs | Bool | import velocity components (3 columns) |
| importMagneticField | docs | Bool | import magnetic field components (3 columns) |
| importVariableMixParams | docs | Bool | import parameter(s) to select a spatially varying material mix |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
| Compound Property | | Type | Base Class | | Description |
| materialMix | docs | Item | MaterialMix | subclasses | the material type and properties throughout the medium |
| materialMixFamily | docs | Item | MaterialMixFamily | subclasses | the material mix family addressed by the imported parameter(s) |
-CylindricalCellSource
[docs] : a primary source imported from cylindrical cell data
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file to be imported |
| autoRevolve | docs | Bool | automatically revolve 2D data to a 3D model |
| numAutoRevolveBins | docs | Int | the number of azimuth bins for auto-revolving 2D data |
| importVelocity | docs | Bool | import velocity components (3 columns) |
| importVelocityDispersion | docs | Bool | import velocity dispersion (spherically symmetric) |
| importCurrentMass | docs | Bool | import current mass |
| importBias | docs | Bool | import a per-particle/cell source bias weight |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
| sourceWeight | docs | Double | the weight of this source for the number of photon packets launched |
| wavelengthBias | docs | Double | the fraction of photon packet wavelengths sampled from a bias distribution |
| Compound Property | | Type | Base Class | | Description |
| sedFamily | docs | Item | SEDFamily | subclasses | the SED family for assigning spectra to the imported sources |
| wavelengthBiasDistribution | docs | Item | WavelengthDistribution | subclasses | the bias distribution for sampling photon packet wavelengths |
-CylindricalClipGeometryDecorator
[docs] : a decorator that clips another geometry using a cylinder
| Scalar Property | | Type | Description |
| remove | docs | Enum | the region to be removed |
| | --> Inside | the inner region (creating a cavity) |
| | --> Outside | the outer region (cropping) |
| clipRadius | docs | Double | the radius of the clipping cylinder |
| Compound Property | | Type | Base Class | | Description |
| geometry | docs | Item | Geometry | subclasses | the geometry to be clipped |
-CylindricalVectorField
[docs] : a vector field rotating clockwise around the z-axis
| Scalar Property | | Type | Description |
| unityRadius | docs | Double | the radius where the magnitude of the vectors is unity |
| exponent | docs | Double | the power-law exponent governing the radial dependence of the magnitude |
-DefaultCutsForm
[docs] : default planar cuts along the coordinate planes
-DefaultWavelengthDistribution
[docs] : the default (logarithmic) wavelength probability distribution
-DensityProbe
[docs] : internal spatial grid: density of the medium
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| aggregation | docs | Enum | how to aggregate the density |
| | --> Fragment | per fragment (dust grain material type and/or size bin) |
| | --> Component | per medium component |
| | --> Type | per medium type (dust, electrons, gas) |
| probeAfter | docs | Enum | perform the probe after |
| | --> Setup | after setup |
| | --> Run | after the complete simulation run |
| | --> Primary | after each iteration over primary emission |
| | --> Secondary | after each iteration over secondary emission |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | Form | subclasses | the form describing how this quantity should be probed |
-DensityTreePolicy
[docs] : a tree grid construction policy using the medium density distribution
| Scalar Property | | Type | Description |
| minLevel | docs | Int | the minimum level of grid refinement |
| maxLevel | docs | Int | the maximum level of grid refinement |
| maxDustFraction | docs | Double | the maximum fraction of dust contained in each cell |
| maxDustOpticalDepth | docs | Double | the maximum diagonal dust optical depth for each cell |
| wavelength | docs | Double | the wavelength at which to evaluate the optical depth |
| maxDustDensityDispersion | docs | Double | the maximum dust density dispersion in each cell |
| maxElectronFraction | docs | Double | the maximum fraction of electrons contained in each cell |
| maxGasFraction | docs | Double | the maximum fraction of gas contained in each cell |
-DiscreteWavelengthDistribution
[docs] : a discrete wavelength probability distribution derived from a wavelength grid
| Compound Property | | Type | Base Class | | Description |
| wavelengthGrid | docs | Item | DisjointWavelengthGrid | subclasses | the wavelength grid defining the discrete distribution |
-DonutGeometry
[docs] : a donut torus geometry
| Scalar Property | | Type | Description |
| largeRadius | docs | Double | the radius of the torus circle in the equatorial plane |
| smallRadius | docs | Double | the radius of the torus circle in the azimuthal plane |
-DorschnerOlivineGrainComposition
[docs] : a Dorschner olivine dust grain composition
-DraineGraphiteGrainComposition
[docs] : a Draine graphite dust grain composition
-DraineIonizedPAHGrainComposition
[docs] : a Draine ionized PAH dust grain composition
-DraineLiDustMix
[docs] : a Draine and Li (2007) dust mix
| Scalar Property | | Type | Description |
| numSilicateSizes | docs | Int | the number of silicate grain size bins |
| numGraphiteSizes | docs | Int | the number of graphite grain size bins (for each of two populations) |
| numPAHSizes | docs | Int | the number of neutral and ionized PAH size bins (each) |
-DraineNeutralPAHGrainComposition
[docs] : a Draine neutral PAH dust grain composition
-DraineSilicateGrainComposition
[docs] : a Draine silicate dust grain composition
-DustAbsorptionPerCellProbe
[docs] : specialty: spectral luminosity absorbed by dust for each spatial cell
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| writeWavelengthGrid | docs | Bool | output a text file with the radiation field wavelength grid |
-DustEmGrainComposition
[docs] : a dust grain composition based on DustEM data
| Scalar Property | | Type | Description |
| grainType | docs | Enum | the DustEM grain type |
| | --> aSil | astronomical silicate grains (Draine & Li 2007) |
| | --> Gra | graphite grains (Draine & Li 2001; Li & Draine 2001) |
| | --> PAH0DL07 | neutral PAHs (Draine & Li 2007) |
| | --> PAH1DL07 | ionized PAHs (Draine & Li 2007) |
| | --> PAH0MC10 | neutral PAHs (Compiègne et al. 2011) |
| | --> PAH1MC10 | ionized PAHs (Compiègne et al. 2011) |
| | --> CM20 | amorphous hydro-carbon grains (Jones et al. 2013) |
| | --> aOlM5 | amorphous olivine/forsterite grains (Koehler et al. 2014) |
| | --> aPyM5 | amorphous pyroxene/enstatite grains (Koehler et al. 2014) |
| bulkMassDensity | docs | Double | the bulk mass density for this grain material |
-DustEmissionOptions
[docs] : a set of options related to thermal emission from dust
| Scalar Property | | Type | Description |
| dustEmissionType | docs | Enum | the method used for dust emission calculations |
| | --> Equilibrium | assume local thermal equilibrium (LTE) |
| | --> Stochastic | handle stochastically heated grains (non-LTE) |
| includeHeatingByCMB | docs | Bool | add the cosmic microwave background (CMB) as a dust heating source term |
| maxFractionOfPrimary | docs | Double | convergence is reached when the total absorbed dust luminosity is less than this fraction of the total absorbed primary luminosity |
| maxFractionOfPrevious | docs | Double | convergence is reached when the total absorbed dust luminosity has changed by less than this fraction compared to the previous iteration |
| sourceWeight | docs | Double | the weight of dust emission for the number of photon packets launched |
| wavelengthBias | docs | Double | the fraction of secondary photon packet wavelengths sampled from a bias distribution |
| Compound Property | | Type | Base Class | | Description |
| cellLibrary | docs | Item | SpatialCellLibrary | subclasses | the spatial cell grouping scheme for calculating dust emission |
| dustEmissionWLG | docs | Item | DisjointWavelengthGrid | subclasses | the wavelength grid for calculating the dust emission spectrum |
| wavelengthBiasDistribution | docs | Item | WavelengthDistribution | subclasses | the bias distribution for sampling secondary photon packet wavelengths |
-DustEmissionWavelengthGridProbe
[docs] : wavelength grid: dust emission
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
-DustEmissivityProbe
[docs] : properties: emissivity spectrum for each dust mix in a range of standard fields
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| writeWavelengthGrid | docs | Bool | output a text file with the emission spectrum wavelength grid |
-DustGrainPopulationsProbe
[docs] : properties: dust grain population mass and size information
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
-DustGrainSizeDistributionProbe
[docs] : properties: dust grain size distribution
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| numSamples | docs | Int | the number of samples in the size distribution table |
-DynamicStateOptions
[docs] : a set of options for dynamically adjusting the medium state
| Compound Property | | Type | Base Class | | Description |
| recipes | docs | ItemList | DynamicStateRecipe | subclasses | the dynamic medium state recipes |
-EinastoGeometry
[docs] : an Einasto geometry
| Scalar Property | | Type | Description |
| halfMassRadius | docs | Double | the half-mass radius |
| index | docs | Double | the Einasto index n |
-ElectronMix
[docs] : a population of electrons
| Scalar Property | | Type | Description |
| includePolarization | docs | Bool | include support for polarization |
| includeThermalDispersion | docs | Bool | include thermal velocity dispersion |
| defaultTemperature | docs | Double | the default temperature of the electron population |
-ExpDiskGeometry
[docs] : an exponential disk geometry
| Scalar Property | | Type | Description |
| scaleLength | docs | Double | the scale length |
| scaleHeight | docs | Double | the scale height |
| minRadius | docs | Double | the radius of the central cavity |
| maxRadius | docs | Double | the truncation radius (zero means no truncation) |
| maxZ | docs | Double | the truncation height (zero means no truncation) |
-ExtragalacticUnits
[docs] : extragalactic units (length in pc, distance in Mpc)
| Scalar Property | | Type | Description |
| wavelengthOutputStyle | docs | Enum | the output style for wavelengths |
| | --> Wavelength | as photon wavelength: λ |
| | --> Frequency | as photon frequency: ν |
| | --> Energy | as photon energy: E |
| fluxOutputStyle | docs | Enum | the output style for flux density and surface brightness |
| | --> Neutral | neutral: λ F_λ = ν F_ν |
| | --> Wavelength | per unit of wavelength: F_λ |
| | --> Frequency | per unit of frequency: F_ν |
| | --> Energy | counts per unit of energy: F_E |
-FSPSSED
[docs] : an FSPS simple stellar population SED
| Scalar Property | | Type | Description |
| imf | docs | Enum | the assumed initial mass function |
| | --> Chabrier | Chabrier IMF |
| | --> Kroupa | Kroupa IMF |
| | --> Salpeter | Salpeter IMF |
| metallicity | docs | Double | the metallicity of the SSP |
| age | docs | Double | the age of the SSP |
-FSPSSEDFamily
[docs] : an FSPS SED family for single stellar populations
| Scalar Property | | Type | Description |
| imf | docs | Enum | the assumed initial mass function |
| | --> Chabrier | Chabrier IMF |
| | --> Kroupa | Kroupa IMF |
| | --> Salpeter | Salpeter IMF |
-FieldStrengthCellLibrary
[docs] : a library scheme for grouping spatial cells based on radiation field strength
| Scalar Property | | Type | Description |
| numFieldStrengths | docs | Int | the number of field strength bins |
-FileBand
[docs] : a wavelength band (transmission curve) loaded from a text file
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file defining the transmission curve |
-FileBorderWavelengthGrid
[docs] : a wavelength grid loaded from a text file listing bin borders
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file with the wavelength bin borders |
| characteristic | docs | Enum | determine the characteristic wavelength for each bin |
| | --> Linear | using linear interpolation |
| | --> Logarithmic | using logarithmic interpolation |
| | --> Specified | specified in the imported wavelength list |
-FileGrainSizeDistribution
[docs] : a dust grain size distribution loaded from a text file
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file with the dust grain size distribution |
-FileIndexedSEDFamily
[docs] : a user-provided, indexed SED family
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the stored table file listing the SEDs |
-FileLineSED
[docs] : a discrete line SED loaded from a text file
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file with the line definitions |
-FileMesh
[docs] : a mesh read from a file
| Scalar Property | | Type | Description |
| numBins | docs | Int | the number of bins in the mesh |
| filename | docs | String | the name of the file with the mesh border points |
-FilePolarizedPointSource
[docs] : a primary point source with a polarized spectrum read from file
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the stored table file listing the Stokes vector components |
| positionX | docs | Double | the position of the point source, x component |
| positionY | docs | Double | the position of the point source, y component |
| positionZ | docs | Double | the position of the point source, z component |
| symmetryX | docs | Double | the direction of the positive symmetry axis, x component |
| symmetryY | docs | Double | the direction of the positive symmetry axis, y component |
| symmetryZ | docs | Double | the direction of the positive symmetry axis, z component |
| velocityX | docs | Double | the bulk velocity of the point source, x component |
| velocityY | docs | Double | the bulk velocity of the point source, y component |
| velocityZ | docs | Double | the bulk velocity of the point source, z component |
| sourceWeight | docs | Double | the weight of this source for the number of photon packets launched |
| wavelengthBias | docs | Double | the fraction of photon packet wavelengths sampled from a bias distribution |
| Compound Property | | Type | Base Class | | Description |
| normalization | docs | Item | LuminosityNormalization | subclasses | the type of luminosity normalization for the source |
| wavelengthBiasDistribution | docs | Item | WavelengthDistribution | subclasses | the bias distribution for sampling photon packet wavelengths |
-FileSED
[docs] : a spectral energy distribution loaded from a text file
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file with the spectral energy distribution |
-FileSSPSEDFamily
[docs] : a user-provided SED family for single stellar populations
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the stored table file defining the SED templates |
| hasIonizationParameter | docs | Bool | include ionization U as an extra parameter for the SED family |
-FileTreeSpatialGrid
[docs] : a tree-based spatial grid loaded from a topology data file
| Scalar Property | | Type | Description |
| minX | docs | Double | the start point of the box in the X direction |
| maxX | docs | Double | the end point of the box in the X direction |
| minY | docs | Double | the start point of the box in the Y direction |
| maxY | docs | Double | the end point of the box in the Y direction |
| minZ | docs | Double | the start point of the box in the Z direction |
| maxZ | docs | Double | the end point of the box in the Z direction |
| filename | docs | String | the name of the file with the tree topology data |
-FileWavelengthDistribution
[docs] : a wavelength probability distribution loaded from a text file
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file with the wavelength probability distribution |
-FileWavelengthGrid
[docs] : a wavelength grid loaded from a text file
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file with the characteristic wavelengths |
| relativeHalfWidth | docs | Double | the relative half width for discrete bins, or zero for a consecutive range |
| log | docs | Bool | use logarithmic scale |
-FlatUniverseCosmology
[docs] : the model is at a given redshift in a flat universe
| Scalar Property | | Type | Description |
| redshift | docs | Double | the redshift z of the model coordinate frame |
| reducedHubbleConstant | docs | Double | the reduced Hubble constant h |
| matterDensityFraction | docs | Double | the cosmological matter density fraction Ω_m |
-FragmentDustMixDecorator
[docs] : a dust mix decorator that manages separate densities for fragments of another dust mix
| Scalar Property | | Type | Description |
| fragmentSizeBins | docs | Bool | fragment each dust population into its grain size bins |
| hasDynamicDensities | docs | Bool | allow the fragment densities to be adjusted dynamically |
| initialDensityFraction | docs | Double | the initial value of the dynamic density fraction |
| Compound Property | | Type | Base Class | | Description |
| dustMix | docs | Item | MultiGrainDustMix | subclasses | the dust mix to be fragmented |
-FrameInstrument
[docs] : a distant instrument that outputs the surface brightness in every pixel as a data cube
| Scalar Property | | Type | Description |
| instrumentName | docs | String | the name for this instrument |
| distance | docs | Double | the distance to the system |
| inclination | docs | Double | the inclination angle θ of the detector |
| azimuth | docs | Double | the azimuth angle φ of the detector |
| roll | docs | Double | the roll angle ω of the detector |
| fieldOfViewX | docs | Double | the total field of view in the horizontal direction |
| numPixelsX | docs | Int | the number of pixels in the horizontal direction |
| centerX | docs | Double | the center of the frame in the horizontal direction |
| fieldOfViewY | docs | Double | the total field of view in the vertical direction |
| numPixelsY | docs | Int | the number of pixels in the vertical direction |
| centerY | docs | Double | the center of the frame in the vertical direction |
| recordComponents | docs | Bool | record flux components separately |
| numScatteringLevels | docs | Int | the number of individually recorded scattering levels |
| recordPolarization | docs | Bool | record polarization (Stokes vector elements) |
| recordStatistics | docs | Bool | record information for calculating statistical properties |
| Compound Property | | Type | Base Class | | Description |
| wavelengthGrid | docs | Item | WavelengthGrid | subclasses | the wavelength grid for this instrument |
-FullInstrument
[docs] : a distant instrument that outputs both the flux density (SED) and surface brightness (data cube)
| Scalar Property | | Type | Description |
| instrumentName | docs | String | the name for this instrument |
| distance | docs | Double | the distance to the system |
| inclination | docs | Double | the inclination angle θ of the detector |
| azimuth | docs | Double | the azimuth angle φ of the detector |
| roll | docs | Double | the roll angle ω of the detector |
| fieldOfViewX | docs | Double | the total field of view in the horizontal direction |
| numPixelsX | docs | Int | the number of pixels in the horizontal direction |
| centerX | docs | Double | the center of the frame in the horizontal direction |
| fieldOfViewY | docs | Double | the total field of view in the vertical direction |
| numPixelsY | docs | Int | the number of pixels in the vertical direction |
| centerY | docs | Double | the center of the frame in the vertical direction |
| recordComponents | docs | Bool | record flux components separately |
| numScatteringLevels | docs | Int | the number of individually recorded scattering levels |
| recordPolarization | docs | Bool | record polarization (Stokes vector elements) |
| recordStatistics | docs | Bool | record information for calculating statistical properties |
| Compound Property | | Type | Base Class | | Description |
| wavelengthGrid | docs | Item | WavelengthGrid | subclasses | the wavelength grid for this instrument |
-GammaGeometry
[docs] : a gamma geometry
| Scalar Property | | Type | Description |
| scaleLength | docs | Double | the scale length |
| gamma | docs | Double | the central density slope γ |
-GaussianGeometry
[docs] : a Gaussian geometry
| Scalar Property | | Type | Description |
| dispersion | docs | Double | the scale length (dispersion) σ |
-GeometricMedium
[docs] : a transfer medium with a built-in geometry
| Scalar Property | | Type | Description |
| velocityMagnitude | docs | Double | the magnitude of the velocity (multiplier) |
| magneticFieldStrength | docs | Double | the strength of the magnetic field (multiplier) |
| Compound Property | | Type | Base Class | | Description |
| geometry | docs | Item | Geometry | subclasses | the geometry of the spatial density distribution for the medium |
| materialMix | docs | Item | MaterialMix | subclasses | the material type and properties throughout the medium |
| normalization | docs | Item | MaterialNormalization | subclasses | the type of normalization for the amount of material |
| velocityDistribution | docs | Item | VectorField | subclasses | the spatial distribution of the velocity, if any |
| magneticFieldDistribution | docs | Item | VectorField | subclasses | the spatial distribution of the magnetic field, if any |
-GeometricSource
[docs] : a primary source with a built-in geometry
| Scalar Property | | Type | Description |
| velocityMagnitude | docs | Double | the magnitude of the velocity (multiplier) |
| sourceWeight | docs | Double | the weight of this source for the number of photon packets launched |
| wavelengthBias | docs | Double | the fraction of photon packet wavelengths sampled from a bias distribution |
| Compound Property | | Type | Base Class | | Description |
| geometry | docs | Item | Geometry | subclasses | the geometry of the spatial luminosity distribution for the source |
| velocityDistribution | docs | Item | VectorField | subclasses | the spatial distribution of the velocity, if any |
| sed | docs | Item | SED | subclasses | the spectral energy distribution for the source |
| normalization | docs | Item | LuminosityNormalization | subclasses | the type of luminosity normalization for the source |
| wavelengthBiasDistribution | docs | Item | WavelengthDistribution | subclasses | the bias distribution for sampling photon packet wavelengths |
-GrainPopulation
[docs] : a dust grain population
| Scalar Property | | Type | Description |
| numSizes | docs | Int | the number of grain size bins |
| normalizationType | docs | Enum | the mechanism for specifying the amount of dust in the population |
| | --> DustMassPerHydrogenAtom | an absolute dust mass per hydrogen atom |
| | --> DustMassPerHydrogenMass | a ratio of dust mass per hydrogen mass |
| | --> FactorOnSizeDistribution | a proportionality factor on the size distribution |
| dustMassPerHydrogenAtom | docs | Double | the dust mass per hydrogen atom |
| dustMassPerHydrogenMass | docs | Double | the dust mass per hydrogen mass |
| factorOnSizeDistribution | docs | Double | the proportionality factor on the size distribution |
| Compound Property | | Type | Base Class | | Description |
| composition | docs | Item | GrainComposition | subclasses | the dust grain composition |
| sizeDistribution | docs | Item | GrainSizeDistribution | subclasses | the dust grain size distribution |
-HEALPixSkyInstrument
[docs] : a HEALPix all-sky instrument (for Planck-like observations inside a model)
| Scalar Property | | Type | Description |
| instrumentName | docs | String | the name for this instrument |
| order | docs | Int | HEALPix order |
| radius | docs | Double | the radius of the observer's all-sky sphere |
| observerX | docs | Double | the position of the observer, x component |
| observerY | docs | Double | the position of the observer, y component |
| observerZ | docs | Double | the position of the observer, z component |
| crossX | docs | Double | the position of the crosshair, x component |
| crossY | docs | Double | the position of the crosshair, y component |
| crossZ | docs | Double | the position of the crosshair, z component |
| upX | docs | Double | the upwards direction, x component |
| upY | docs | Double | the upwards direction, y component |
| upZ | docs | Double | the upwards direction, z component |
| recordComponents | docs | Bool | record flux components separately |
| numScatteringLevels | docs | Int | the number of individually recorded scattering levels |
| recordPolarization | docs | Bool | record polarization (Stokes vector elements) |
| recordStatistics | docs | Bool | record information for calculating statistical properties |
| Compound Property | | Type | Base Class | | Description |
| wavelengthGrid | docs | Item | WavelengthGrid | subclasses | the wavelength grid for this instrument |
-HammerAitoffProjection
[docs] : the Hammer-Aitoff all-sky projection
-HirashitaLogNormalGrainSizeDistribution
[docs] : a Hirashita (2015) log-normal dust grain size distribution
| Scalar Property | | Type | Description |
| minSize | docs | Double | the minimum grain size for this distribution |
| maxSize | docs | Double | the maximum grain size for this distribution |
| centroid | docs | Double | the centroid a0 of the log-normal law |
| width | docs | Double | the width σ of the log-normal law |
-HofmeisterPericlaseGrainComposition
[docs] : a Hofmeister periclase dust grain composition
-HollowRadialVectorField
[docs] : a vector field pointing away from the origin with a central cavity
| Scalar Property | | Type | Description |
| zeroRadius | docs | Double | the radius within which the magnitude of the vectors is zero |
| exponent | docs | Double | the power-law exponent governing the radial dependence of the magnitude |
-HubbleRadialVectorField
[docs] : a Hubble flow pointing away from the origin with a constant acceleration and decelaration
| Scalar Property | | Type | Description |
| turnoverRadius | docs | Double | the turnover radius marking the transition from acceleration to decelaration |
| maxRadius | docs | Double | the maximum radius beyond which the outflow velocity is zero |
-HyperboloidGeometry
[docs] : a hyperboloid geometry
| Scalar Property | | Type | Description |
| radialExtent | docs | Double | the radial extent of the hyperboloid |
| openingAngle | docs | Double | the half opening angle of the hyperboloid |
| realAxis | docs | Double | the real axis of the hyperboloid |
| minRadius | docs | Double | the radius of the central cavity |
| reshapeInnerRadius | docs | Bool | reshape the inner radius according to the Netzer luminosity profile |
| cutoffRadius | docs | Double | the inner cutoff radius of the hyperboloid |
-HyperboloidShellGeometry
[docs] : a hyperboloid shell geometry
| Scalar Property | | Type | Description |
| outerRadialExtent | docs | Double | the radial extent of the hyperboloid outer wall |
| outerOpeningAngle | docs | Double | the half opening angle of the hyperboloid outer wall |
| outerRealAxis | docs | Double | the real axis of the hyperboloid outer wall |
| innerOpeningAngle | docs | Double | the half opening angle of the hyperboloid inner wall |
| innerRealAxis | docs | Double | the real axis of the hyperboloid inner wall |
-ImportedMediumDensityProbe
[docs] : imported medium: mass or number density
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | GenericForm | subclasses | the form describing how this quantity should be probed |
-ImportedMediumMetallicityProbe
[docs] : imported medium: metallicity
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | GenericForm | subclasses | the form describing how this quantity should be probed |
-ImportedMediumTemperatureProbe
[docs] : imported medium: temperature
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | GenericForm | subclasses | the form describing how this quantity should be probed |
-ImportedMediumVelocityProbe
[docs] : imported medium: bulk velocity
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | GenericForm | subclasses | the form describing how this quantity should be probed |
-ImportedSourceAgeProbe
[docs] : imported source: age
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| weight | docs | Enum | weight for averaging the probed quantity |
| | --> Luminosity | luminosity |
| | --> InitialMass | initial mass |
| | --> CurrentMass | current mass |
| wavelength | docs | Double | the wavelength at which to determine the luminosity |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | GenericForm | subclasses | the form describing how this quantity should be probed |
-ImportedSourceDensityProbe
[docs] : imported source: mass density
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| massType | docs | Enum | type of mass being probed |
| | --> InitialMass | initial mass |
| | --> CurrentMass | current mass |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | GenericForm | subclasses | the form describing how this quantity should be probed |
-ImportedSourceLuminosityProbe
[docs] : imported source: specific luminosity density
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| convolve | docs | Bool | average or convolve the specific luminosity over the wavelength bin |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | GenericForm | subclasses | the form describing how this quantity should be probed |
| wavelengthGrid | docs | Item | WavelengthGrid | subclasses | the wavelength grid for this probe |
-ImportedSourceMetallicityProbe
[docs] : imported source: metallicity
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| weight | docs | Enum | weight for averaging the probed quantity |
| | --> Luminosity | luminosity |
| | --> InitialMass | initial mass |
| | --> CurrentMass | current mass |
| wavelength | docs | Double | the wavelength at which to determine the luminosity |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | GenericForm | subclasses | the form describing how this quantity should be probed |
-ImportedSourceVelocityProbe
[docs] : imported source: bulk velocity
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| weight | docs | Enum | weight for averaging the probed quantity |
| | --> Luminosity | luminosity |
| | --> InitialMass | initial mass |
| | --> CurrentMass | current mass |
| wavelength | docs | Double | the wavelength at which to determine the luminosity |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | GenericForm | subclasses | the form describing how this quantity should be probed |
-InstrumentSystem
[docs] : an instrument system
| Compound Property | | Type | Base Class | | Description |
| defaultWavelengthGrid | docs | Item | WavelengthGrid | subclasses | the default instrument wavelength grid |
| instruments | docs | ItemList | Instrument | subclasses | the instruments |
-InstrumentWavelengthGridProbe
[docs] : wavelength grid: instruments
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
-IntegratedLuminosityNormalization
[docs] : source normalization through the integrated luminosity for a given wavelength range
| Scalar Property | | Type | Description |
| wavelengthRange | docs | Enum | the wavelength range for which to provide the integrated luminosity |
| | --> Source | the wavelength range of the primary sources |
| | --> All | all wavelengths (i.e. over the full SED) |
| | --> Custom | a custom wavelength range specified here |
| minWavelength | docs | Double | the shortest wavelength of the integration range |
| maxWavelength | docs | Double | the longest wavelength of the integration range |
| integratedLuminosity | docs | Double | the integrated luminosity for the given wavelength range |
-IsotropicAngularDistribution
[docs] : an isotropic emission profile
-IterationOptions
[docs] : a set of options for configuring iterations during primary and/or secondary emission
| Scalar Property | | Type | Description |
| minPrimaryIterations | docs | Int | the minimum number of iterations during primary emission |
| maxPrimaryIterations | docs | Int | the maximum number of iterations during primary emission |
| minSecondaryIterations | docs | Int | the minimum number of iterations during secondary emission |
| maxSecondaryIterations | docs | Int | the maximum number of iterations during secondary emission |
| includePrimaryEmission | docs | Bool | include primary emission in the secondary emission iterations |
| primaryIterationPacketsMultiplier | docs | Double | the multiplier on the number of photon packets launched for each primary emission iteration |
| secondaryIterationPacketsMultiplier | docs | Double | the multiplier on the number of photon packets launched for each secondary emission iteration |
-LaserAngularDistribution
[docs] : a laser emission profile
| Scalar Property | | Type | Description |
| symmetryX | docs | Double | the direction of the positive symmetry axis, x component |
| symmetryY | docs | Double | the direction of the positive symmetry axis, y component |
| symmetryZ | docs | Double | the direction of the positive symmetry axis, z component |
-LaunchedPacketsProbe
[docs] : source: number of photon packets launched from primary and secondary sources
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| Compound Property | | Type | Base Class | | Description |
| wavelengthGrid | docs | Item | WavelengthGrid | subclasses | the wavelength grid for this probe |
-LinBorderWavelengthGrid
[docs] : a linear wavelength grid with given outer borders
| Scalar Property | | Type | Description |
| minWavelength | docs | Double | the shortest wavelength |
| maxWavelength | docs | Double | the longest wavelength |
| numWavelengthBins | docs | Int | the number of wavelength bins |
-LinMesh
[docs] : a linear mesh
| Scalar Property | | Type | Description |
| numBins | docs | Int | the number of bins in the mesh |
-LinWavelengthDistribution
[docs] : a linear wavelength probability distribution
| Scalar Property | | Type | Description |
| minWavelength | docs | Double | the shortest wavelength of the wavelength probability distribution |
| maxWavelength | docs | Double | the longest wavelength of the wavelength probability distribution |
-LinWavelengthGrid
[docs] : a linear wavelength grid
| Scalar Property | | Type | Description |
| minWavelength | docs | Double | the shortest wavelength |
| maxWavelength | docs | Double | the longest wavelength |
| numWavelengths | docs | Int | the number of wavelength grid points |
-LineLuminosityNormalization
[docs] : source normalization through the luminosity for a given emission line
| Scalar Property | | Type | Description |
| wavelength | docs | Double | the central wavelength of the emission line |
| luminosity | docs | Double | the luminosity for the emission line |
-LinearCutForm
[docs] : a text column file with values along a given line segment
| Scalar Property | | Type | Description |
| numSamples | docs | Int | the number of samples along the line segment |
| startX | docs | Double | the position of the starting point, x component |
| startY | docs | Double | the position of the starting point, y component |
| startZ | docs | Double | the position of the starting point, z component |
| endX | docs | Double | the position of the ending point, x component |
| endY | docs | Double | the position of the ending point, y component |
| endZ | docs | Double | the position of the ending point, z component |
-LinearDustDestructionRecipe
[docs] : a dust destruction recipe using a linear temperature dependence
| Scalar Property | | Type | Description |
| maxNotConvergedCells | docs | Int | the number of spatial cells allowed to not converge |
| densityFractionTolerance | docs | Double | the convergence tolerance on the dynamic density fraction |
| minSilicateTemperature | docs | Double | the temperature below which silicate grains are not destroyed |
| maxSilicateTemperature | docs | Double | the temperature above which all silicate grains are destroyed |
| minGraphiteTemperature | docs | Double | the temperature below which graphite grains are not destroyed |
| maxGraphiteTemperature | docs | Double | the temperature above which all graphite grains are destroyed |
-ListBand
[docs] : a wavelength band (transmission curve) specified inside the configuration file
| Scalar Property | | Type | Description |
| wavelengths | docs | DoubleList | the wavelengths at which to specify the transmission |
| transmissionValues | docs | DoubleList | the transmission at each of the given wavelengths |
-ListBorderWavelengthGrid
[docs] : a wavelength grid configured as a list of bin borders
| Scalar Property | | Type | Description |
| wavelengths | docs | DoubleList | the wavelength bin borders |
| characteristic | docs | Enum | determine the characteristic wavelength for each bin |
| | --> Linear | using linear interpolation |
| | --> Logarithmic | using logarithmic interpolation |
| | --> Specified | specified in the configured wavelength list |
-ListGrainSizeDistribution
[docs] : a dust grain size distribution specified inside the configuration file
| Scalar Property | | Type | Description |
| sizes | docs | DoubleList | the grain sizes at which to specify the size distribution |
| sizeDistributionValues | docs | DoubleList | the size distribution values at each of the given grain sizes |
-ListLineSED
[docs] : a discrete line SED specified inside the configuration file
| Scalar Property | | Type | Description |
| wavelengths | docs | DoubleList | the line wavelengths |
| luminosities | docs | DoubleList | the line luminosities |
-ListMesh
[docs] : a mesh specified inside the configuration file
| Scalar Property | | Type | Description |
| numBins | docs | Int | the number of bins in the mesh |
| points | docs | DoubleList | the mesh border points |
-ListSED
[docs] : a spectral energy distribution specified inside the configuration file
| Scalar Property | | Type | Description |
| wavelengths | docs | DoubleList | the wavelengths at which to specify the specific luminosity |
| unitStyle | docs | Enum | the luminosity unit style |
| | --> neutralmonluminosity | neutral: λ L_λ = ν L_ν |
| | --> wavelengthmonluminosity | per unit of wavelength: L_λ |
| | --> frequencymonluminosity | per unit of frequency: L_ν |
| | --> energymonluminosity | counts per unit of energy: L_E |
| specificLuminosities | docs | DoubleList | the specific luminosities at each of the given wavelengths |
-ListWavelengthDistribution
[docs] : a wavelength probability distribution specified inside the configuration file
| Scalar Property | | Type | Description |
| wavelengths | docs | DoubleList | the wavelengths at which to specify the probability |
| unitStyle | docs | Enum | the probability unit style |
| | --> neutralmonluminosity | neutral: λ L_λ = ν L_ν |
| | --> wavelengthmonluminosity | per unit of wavelength: L_λ |
| | --> frequencymonluminosity | per unit of frequency: L_ν |
| | --> energymonluminosity | counts per unit of energy: L_E |
| probabilities | docs | DoubleList | the probabilities at each of the given wavelengths |
-ListWavelengthGrid
[docs] : a wavelength grid configured as a list
| Scalar Property | | Type | Description |
| wavelengths | docs | DoubleList | the characteristic wavelength for each bin |
| relativeHalfWidth | docs | Double | the relative half width for discrete bins, or zero for a consecutive range |
| log | docs | Bool | use logarithmic scale |
-LocalUniverseCosmology
[docs] : the model is at redshift zero in the Local Universe
-LogBorderWavelengthGrid
[docs] : a logarithmic wavelength grid with given outer borders
| Scalar Property | | Type | Description |
| minWavelength | docs | Double | the shortest wavelength |
| maxWavelength | docs | Double | the longest wavelength |
| numWavelengthBins | docs | Int | the number of wavelength bins |
-LogMesh
[docs] : a logarithmic mesh
| Scalar Property | | Type | Description |
| numBins | docs | Int | the number of bins in the mesh |
| centralBinFraction | docs | Double | the central bin width fraction |
-LogNormalGrainSizeDistribution
[docs] : a log-normal dust grain size distribution
| Scalar Property | | Type | Description |
| minSize | docs | Double | the minimum grain size for this distribution |
| maxSize | docs | Double | the maximum grain size for this distribution |
| centroid | docs | Double | the centroid a0 of the log-normal law |
| width | docs | Double | the width σ of the log-normal law |
-LogWavelengthDistribution
[docs] : a logarithmic wavelength probability distribution
| Scalar Property | | Type | Description |
| minWavelength | docs | Double | the shortest wavelength of the wavelength probability distribution |
| maxWavelength | docs | Double | the longest wavelength of the wavelength probability distribution |
-LogWavelengthGrid
[docs] : a logarithmic wavelength grid
| Scalar Property | | Type | Description |
| minWavelength | docs | Double | the shortest wavelength |
| maxWavelength | docs | Double | the longest wavelength |
| numWavelengths | docs | Int | the number of wavelength grid points |
-LuminosityProbe
[docs] : source: luminosities of primary sources
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| Compound Property | | Type | Base Class | | Description |
| wavelengthGrid | docs | Item | WavelengthGrid | subclasses | the wavelength grid for this probe |
-LyaDoublePeakedSED
[docs] : a double-peaked spectrum around the central Lyman-alpha wavelength
| Scalar Property | | Type | Description |
| scale | docs | Double | the velocity scale |
-LyaDoublePeakedSEDFamily
[docs] : a family of double-peaked spectra around the central Lyman-alpha wavelength
-LyaGaussianSED
[docs] : a Gaussian spectrum around the central Lyman-alpha wavelength
| Scalar Property | | Type | Description |
| dispersion | docs | Double | the Gaussian velocity dispersion |
-LyaGaussianSEDFamily
[docs] : a family of Gaussian spectra around the central Lyman-alpha wavelength
-LyaNeutralHydrogenGasMix
[docs] : neutral hydrogen for Lyman-alpha line transfer
| Scalar Property | | Type | Description |
| defaultTemperature | docs | Double | the default temperature of the neutral hydrogen gas |
| includePolarization | docs | Bool | include support for polarization |
-LyaOptions
[docs] : a set of options related to Lyman-alpha line transfer
| Scalar Property | | Type | Description |
| lyaAccelerationScheme | docs | Enum | the Lyman-alpha line transfer acceleration scheme |
| | --> None | no acceleration |
| | --> Constant | acceleration scheme with a constant critical value |
| | --> Variable | acceleration scheme depending on local gas temperature and density |
| lyaAccelerationStrength | docs | Double | the acceleration strength; higher is faster but less accurate |
| includeHubbleFlow | docs | Bool | include the Doppler shift caused by the expansion of the universe |
-LyaSEDDecorator
[docs] : an SED decorator replacing ionizing radiation with Lyman-alpha line emission
| Scalar Property | | Type | Description |
| conversionFraction | docs | Double | the fraction of ionizing radiation replaced by Lyman-alpha emission |
| Compound Property | | Type | Base Class | | Description |
| sedOriginal | docs | Item | ContSED | subclasses | the original SED being adjusted |
| sedLymanAlpha | docs | Item | ContSED | subclasses | the SED representing the Lyman-alpha line emission |
-LyaSEDFamilyDecorator
[docs] : an SED family decorator replacing ionizing radiation with Lyman-alpha line emission
| Scalar Property | | Type | Description |
| conversionFraction | docs | Double | the fraction of ionizing radiation replaced by Lyman-alpha emission |
| Compound Property | | Type | Base Class | | Description |
| sedFamilyOriginal | docs | Item | SEDFamily | subclasses | the original SED family being adjusted |
| sedLymanAlpha | docs | Item | ContSED | subclasses | the SED representing the Lyman-alpha line emission |
-MRNDustMix
[docs] : an MRN (1997) dust mix
| Scalar Property | | Type | Description |
| numSilicateSizes | docs | Int | the number of silicate grain size bins |
| numGraphiteSizes | docs | Int | the number of graphite grain size bins |
-MagneticFieldProbe
[docs] : internal spatial grid: magnetic field associated with the medium
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | Form | subclasses | the form describing how this quantity should be probed |
-MappingsSED
[docs] : a star-forming region SED from the MAPPINGS III model
| Scalar Property | | Type | Description |
| metallicity | docs | Double | the metallicity |
| compactness | docs | Double | the logarithm of the compactness parameter |
| pressure | docs | Double | the ISM pressure |
| coveringFactor | docs | Double | the PDR covering factor |
-MappingsSEDFamily
[docs] : a MAPPINGS III SED family for star-forming regions
-MarastonSED
[docs] : a Maraston simple stellar population SED
| Scalar Property | | Type | Description |
| imf | docs | Enum | the assumed initial mass function |
| | --> Kroupa | Kroupa IMF |
| | --> Salpeter | Salpeter IMF |
| metallicity | docs | Double | the metallicity of the SSP |
| age | docs | Double | the age of the SSP |
-MarastonSEDFamily
[docs] : a Maraston SED family for single stellar populations
| Scalar Property | | Type | Description |
| imf | docs | Enum | the assumed initial mass function |
| | --> Kroupa | Kroupa IMF |
| | --> Salpeter | Salpeter IMF |
-MassColumnMaterialNormalization
[docs] : normalization by defining the mass column density along a coordinate axis
| Scalar Property | | Type | Description |
| axis | docs | Enum | the axis along which to specify the normalization |
| | --> X | the X axis of the model coordinate sytem |
| | --> Y | the Y axis of the model coordinate sytem |
| | --> Z | the Z axis of the model coordinate sytem |
| massColumnDensity | docs | Double | the mass column density along this axis |
-MassMaterialNormalization
[docs] : normalization by defining the total mass
| Scalar Property | | Type | Description |
| mass | docs | Double | the total mass of the material |
-MeanFileDustMix
[docs] : a dust mix with mean properties loaded from a text file
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file with the optical properties for the dust mix |
-MeanInterstellarDustMix
[docs] : a typical interstellar dust mix (mean properties)
-MeanIvezicBenchmarkDustMix
[docs] : an Ivezic 1D benchmark dust mix (mean properties)
-MeanListDustMix
[docs] : a dust mix with mean properties specified inside the configuration file
| Scalar Property | | Type | Description |
| wavelengths | docs | DoubleList | the wavelengths at which to specify the optical properties |
| extinctionCoefficients | docs | DoubleList | the extinction mass coefficients at each of the given wavelengths |
| albedos | docs | DoubleList | the scattering albedos at each of the given wavelengths |
| asymmetryParameters | docs | DoubleList | the scattering asymmetry parameters at each of the given wavelengths |
-MeanPascucciBenchmarkDustMix
[docs] : a Pascucci 2D benchmark dust mix (mean properties)
-MeanPinteBenchmarkDustMix
[docs] : a Pinte 2D benchmark dust mix (mean properties, optionally with polarization at 1 micron)
| Scalar Property | | Type | Description |
| scatteringType | docs | Enum | the type of scattering to be implemented |
| | --> HenyeyGreenstein | use the Henyey-Greenstein phase function (unpolarized) |
| | --> MaterialPhaseFunction | use the phase function derived from actual material properties (unpolarized) |
| | --> SphericalPolarization | support polarization through scattering by spherical grains |
-MeanTrustBenchmarkDustMix
[docs] : a TRUST benchmark dust mix (mean properties, optionally with polarization)
| Scalar Property | | Type | Description |
| scatteringType | docs | Enum | the type of scattering to be implemented |
| | --> HenyeyGreenstein | use the Henyey-Greenstein phase function (unpolarized) |
| | --> MaterialPhaseFunction | use the phase function derived from actual material properties (unpolarized) |
| | --> SphericalPolarization | support polarization through scattering by spherical grains |
-MediumSystem
[docs] : a medium system
| Compound Property | | Type | Base Class | | Description |
| photonPacketOptions | docs | Item | PhotonPacketOptions | subclasses | the photon packet options |
| lyaOptions | docs | Item | LyaOptions | subclasses | the Lyman-alpha line transfer options |
| dynamicStateOptions | docs | Item | DynamicStateOptions | subclasses | the dynamic medium state options |
| radiationFieldOptions | docs | Item | RadiationFieldOptions | subclasses | the radiation field options |
| secondaryEmissionOptions | docs | Item | SecondaryEmissionOptions | subclasses | the secondary emission options |
| iterationOptions | docs | Item | IterationOptions | subclasses | the primary and/or secondary emission iteration options |
| dustEmissionOptions | docs | Item | DustEmissionOptions | subclasses | the dust emission options |
| media | docs | ItemList | Medium | subclasses | the transfer media |
| samplingOptions | docs | Item | SamplingOptions | subclasses | the spatial grid sampling options |
| grid | docs | Item | SpatialGrid | subclasses | the spatial grid |
-MeridionalCutForm
[docs] : a text column file with values along a meridian
| Scalar Property | | Type | Description |
| numSamples | docs | Int | the number of samples along the meridian |
| radius | docs | Double | the radius of the circle containing the meridian |
| azimuth | docs | Double | the azimuth angle φ of the meridian |
-MetallicityProbe
[docs] : internal spatial grid: metallicity of the gas medium
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| probeAfter | docs | Enum | perform the probe after |
| | --> Setup | after setup |
| | --> Run | after the complete simulation run |
| | --> Primary | after each iteration over primary emission |
| | --> Secondary | after each iteration over secondary emission |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | Form | subclasses | the form describing how this quantity should be probed |
-MieSilicateGrainComposition
[docs] : a MieX-based Draine silicate dust grain composition
-MinSilicateGrainComposition
[docs] : a Min 2007 amorphous silicate dust grain composition
-ModifiedLogNormalGrainSizeDistribution
[docs] : a modified log-normal dust grain size distribution
| Scalar Property | | Type | Description |
| minSize | docs | Double | the minimum grain size for this distribution |
| maxSize | docs | Double | the maximum grain size for this distribution |
| centroid | docs | Double | the centroid a0 of the log-normal law |
| width | docs | Double | the width σ of the log-normal law |
| firstMixingParameter | docs | Double | the first mixing parameter y0 |
| secondMixingParameter | docs | Double | the second mixing parameter y1 |
-ModifiedPowerLawGrainSizeDistribution
[docs] : a modified power-law dust grain size distribution
| Scalar Property | | Type | Description |
| minSize | docs | Double | the minimum grain size for this distribution |
| maxSize | docs | Double | the maximum grain size for this distribution |
| powerLawIndex | docs | Double | the index α of the power law |
| turnOffPoint | docs | Double | the turn-off point a_t in the exponential decay term |
| scaleExponentialDecay | docs | Double | the scale a_c in the exponential decay term |
| exponentExponentialDecay | docs | Double | the exponent γ in the exponential decay term |
| scaleCurvature | docs | Double | the scale a_u in the curvature term |
| strengthCurvature | docs | Double | the strength ζ in the curvature term |
| exponentCurvature | docs | Double | the exponent η in the curvature term |
-MollweideProjection
[docs] : the Mollweide all-sky projection
-MonteCarloSimulation
[docs] : a Monte Carlo simulation
| Scalar Property | | Type | Description |
| userLevel | docs | Enum | the user experience level |
| | --> Basic | Basic: for beginning users (hides many options) |
| | --> Regular | Regular: for regular users (hides esoteric options) |
| | --> Expert | Expert: for expert users (hides no options) |
| simulationMode | docs | Enum | the overall simulation mode |
| | --> OligoNoMedium | No medium - oligochromatic regime (a few discrete wavelengths) |
| | --> OligoExtinctionOnly | Extinction only - oligochromatic regime (a few discrete wavelengths) |
| | --> NoMedium | No medium (primary sources only) |
| | --> ExtinctionOnly | Extinction only (no secondary emission) |
| | --> LyaExtinctionOnly | Extinction only with Lyman-alpha line transfer |
| | --> DustEmission | With secondary emission from dust |
| | --> GasEmission | With secondary emission from gas |
| | --> DustAndGasEmission | With secondary emission from dust and gas |
| iteratePrimaryEmission | docs | Bool | iterate over primary emission for self-consistent calculation |
| iterateSecondaryEmission | docs | Bool | iterate over secondary emission for self-consistent calculation |
| numPackets | docs | Double | the default number of photon packets launched per simulation segment |
| Compound Property | | Type | Base Class | | Description |
| random | docs | Item | Random | subclasses | the random number generator |
| units | docs | Item | Units | subclasses | the units system |
| cosmology | docs | Item | Cosmology | subclasses | the cosmology parameters |
| sourceSystem | docs | Item | SourceSystem | subclasses | the source system |
| mediumSystem | docs | Item | MediumSystem | subclasses | the medium system |
| instrumentSystem | docs | Item | InstrumentSystem | subclasses | the instrument system |
| probeSystem | docs | Item | ProbeSystem | subclasses | the probe system |
-MultiGaussianExpansionGeometry
[docs] : a multi-gaussian expansion geometry
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file with the multi-gaussian expansion parameters |
| pixelscale | docs | Double | the scale of the multi-gaussian-expanded image (length per pixel) |
| inclination | docs | Double | the inclination of the system |
-NestedDensityTreePolicy
[docs] : a tree grid construction policy using a nested density tree policy
| Scalar Property | | Type | Description |
| minLevel | docs | Int | the minimum level of grid refinement |
| maxLevel | docs | Int | the maximum level of grid refinement |
| maxDustFraction | docs | Double | the maximum fraction of dust contained in each cell |
| maxDustOpticalDepth | docs | Double | the maximum diagonal dust optical depth for each cell |
| wavelength | docs | Double | the wavelength at which to evaluate the optical depth |
| maxDustDensityDispersion | docs | Double | the maximum dust density dispersion in each cell |
| maxElectronFraction | docs | Double | the maximum fraction of electrons contained in each cell |
| maxGasFraction | docs | Double | the maximum fraction of gas contained in each cell |
| innerMinX | docs | Double | the start point of the inner box in the X direction |
| innerMaxX | docs | Double | the end point of the inner box in the X direction |
| innerMinY | docs | Double | the start point of the inner box in the Y direction |
| innerMaxY | docs | Double | the end point of the inner box in the Y direction |
| innerMinZ | docs | Double | the start point of the inner box in the Z direction |
| innerMaxZ | docs | Double | the end point of the inner box in the Z direction |
| Compound Property | | Type | Base Class | | Description |
| innerPolicy | docs | Item | DensityTreePolicy | subclasses | the density tree policy for the inner region |
-NestedLogWavelengthGrid
[docs] : a nested logarithmic wavelength grid
| Scalar Property | | Type | Description |
| minWavelengthBaseGrid | docs | Double | the shortest wavelength of the low-resolution grid |
| maxWavelengthBaseGrid | docs | Double | the longest wavelength of the low-resolution grid |
| numWavelengthsBaseGrid | docs | Int | the number of wavelength grid points in the low-resolution grid |
| minWavelengthSubGrid | docs | Double | the shortest wavelength of the high-resolution subgrid |
| maxWavelengthSubGrid | docs | Double | the longest wavelength of the high-resolution subgrid |
| numWavelengthsSubGrid | docs | Int | the number of wavelength grid points in the high-resolution subgrid |
-NetzerAngularDistribution
[docs] : a Netzer AGN accretion disk emission profile
| Scalar Property | | Type | Description |
| symmetryX | docs | Double | the direction of the positive symmetry axis, x component |
| symmetryY | docs | Double | the direction of the positive symmetry axis, y component |
| symmetryZ | docs | Double | the direction of the positive symmetry axis, z component |
-NoPolarizationProfile
[docs] : an unpolarized emission profile
-NonLTELineGasMix
[docs] : A gas mix supporting rotational transitions in specific molecules and atoms
| Scalar Property | | Type | Description |
| sourceWeight | docs | Double | the weight of this secondary source for the number of photon packets launched |
| wavelengthBias | docs | Double | the fraction of secondary photon packet wavelengths sampled from a bias distribution |
| species | docs | Enum | the molecular or atomic species being represented |
| | --> Test | Fictive two-level test molecule (TT) |
| | --> Hydroxyl | Hydroxyl radical (OH) |
| | --> HydroxylHFS | Hydroxyl radical (OH) with hyperfine structure |
| | --> Formyl | Formyl cation (HCO+) |
| | --> CarbonMonoxide | Carbon monoxide (CO) |
| | --> AtomicCarbon | Atomic carbon (C) |
| | --> IonizedCarbon | Ionized carbon (C+) |
| | --> MolecularHydrogen | Molecular hydrogen (H2) |
| numEnergyLevels | docs | Int | the number of energy levels used (or 999 for all supported) |
| defaultTemperature | docs | Double | the default temperature of the gas |
| defaultCollisionPartnerRatios | docs | DoubleList | the default relative abundances of the collisional partners |
| defaultTurbulenceVelocity | docs | Double | the default (non-thermal) turbulence velocity |
| maxChangeInLevelPopulations | docs | Double | the maximum relative change for the level populations in a cell to be considered converged |
| maxFractionNotConvergedCells | docs | Double | the maximum fraction of not-converged cells for all cells to be considered converged |
| maxChangeInGlobalLevelPopulations | docs | Double | the maximum relative change for the global level populations to be considered converged |
| lowestOpticalDepth | docs | Double | Lower limit of (negative) optical depth along a cell diagonal |
| storeMeanIntensities | docs | Bool | store the mean radiation field intensity at each transition line |
| initialLevelPopsFilename | docs | String | the name of the file with initial level populations |
| Compound Property | | Type | Base Class | | Description |
| wavelengthBiasDistribution | docs | Item | WavelengthDistribution | subclasses | the bias distribution for sampling secondary photon packet wavelengths |
-NumberColumnMaterialNormalization
[docs] : normalization by defining the number column density along a coordinate axis
| Scalar Property | | Type | Description |
| axis | docs | Enum | the axis along which to specify the normalization |
| | --> X | the X axis of the model coordinate sytem |
| | --> Y | the Y axis of the model coordinate sytem |
| | --> Z | the Z axis of the model coordinate sytem |
| numberColumnDensity | docs | Double | the number column density along this axis |
-NumberMaterialNormalization
[docs] : normalization by defining the total number of entities
| Scalar Property | | Type | Description |
| number | docs | Double | the total number of entities in the material |
-OffsetGeometryDecorator
[docs] : a decorator that adds an offset to any geometry
| Scalar Property | | Type | Description |
| offsetX | docs | Double | the offset in the x direction |
| offsetY | docs | Double | the offset in the y direction |
| offsetZ | docs | Double | the offset in the z direction |
| Compound Property | | Type | Base Class | | Description |
| geometry | docs | Item | Geometry | subclasses | the geometry to be offset |
-OffsetVectorFieldDecorator
[docs] : a decorator that adds an offset to any vector field
| Scalar Property | | Type | Description |
| offsetX | docs | Double | the offset in the x direction |
| offsetY | docs | Double | the offset in the y direction |
| offsetZ | docs | Double | the offset in the z direction |
| Compound Property | | Type | Base Class | | Description |
| vectorField | docs | Item | VectorField | subclasses | the vector field to be offset |
-OpacityProbe
[docs] : internal spatial grid: opacity of the medium
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| aggregation | docs | Enum | how to aggregate the opacity |
| | --> Fragment | per fragment (dust grain material type and/or size bin) |
| | --> Component | per medium component |
| | --> Type | per medium type (dust, electrons, gas) |
| | --> System | for the complete medium system |
| probeAfter | docs | Enum | perform the probe after |
| | --> Setup | after setup |
| | --> Run | after the complete simulation run |
| | --> Primary | after each iteration over primary emission |
| | --> Secondary | after each iteration over secondary emission |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | Form | subclasses | the form describing how this quantity should be probed |
| wavelengthGrid | docs | Item | WavelengthGrid | subclasses | the wavelength grid for this probe |
-OpticalDepthMaterialNormalization
[docs] : normalization by defining the optical depth along a coordinate axis
| Scalar Property | | Type | Description |
| axis | docs | Enum | the axis along which to specify the normalization |
| | --> X | the X axis of the model coordinate sytem |
| | --> Y | the Y axis of the model coordinate sytem |
| | --> Z | the Z axis of the model coordinate sytem |
| wavelength | docs | Double | the wavelength at which to specify the optical depth |
| opticalDepth | docs | Double | the optical depth along this axis at this wavelength |
-OpticalMaterialPropertiesProbe
[docs] : properties: aggregate optical material properties for each medium
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| Compound Property | | Type | Base Class | | Description |
| wavelengthGrid | docs | Item | WavelengthGrid | subclasses | the wavelength grid for this probe |
-ParaboloidGeometry
[docs] : a paraboloid geometry
| Scalar Property | | Type | Description |
| radialExtent | docs | Double | the radial extent of the paraboloid |
| openingAngle | docs | Double | the half opening angle of the paraboloid |
| offsetZ | docs | Double | the offset of the paraboloid vertices in the z direction |
-ParaboloidShellGeometry
[docs] : a paraboloid shell geometry
| Scalar Property | | Type | Description |
| innerRadialExtent | docs | Double | the radial extent of the inner paraboloid wall |
| innerOpeningAngle | docs | Double | the half opening angle of the inner paraboloid wall |
| outerOpeningAngle | docs | Double | the half opening angle of the outer paraboloid wall |
| innerOffsetZ | docs | Double | the offset of the inner paraboloid vertices in the z direction |
| outerOffsetZ | docs | Double | the offset of the outer paraboloid vertices in the z direction |
-ParallelProjectionForm
[docs] : parallel projection on a distant plane
| Scalar Property | | Type | Description |
| inclination | docs | Double | the inclination angle θ of the projection |
| azimuth | docs | Double | the azimuth angle φ of the projection |
| roll | docs | Double | the roll angle ω of the projection |
| fieldOfViewX | docs | Double | the total field of view in the horizontal direction |
| numPixelsX | docs | Int | the number of pixels in the horizontal direction |
| centerX | docs | Double | the center of the frame in the horizontal direction |
| fieldOfViewY | docs | Double | the total field of view in the vertical direction |
| numPixelsY | docs | Int | the number of pixels in the vertical direction |
| centerY | docs | Double | the center of the frame in the vertical direction |
| numSampling | docs | Int | the oversampling rate in each direction |
-ParticleGeometry
[docs] : a geometry imported from smoothed particle data
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file to be imported |
| importMetallicity | docs | Bool | import a metallicity column |
| importTemperature | docs | Bool | import a temperature column |
| maxTemperature | docs | Double | the maximum temperature for included mass (or zero to include all) |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
| Compound Property | | Type | Base Class | | Description |
| smoothingKernel | docs | Item | SmoothingKernel | subclasses | the kernel for interpolating the smoothed particles |
-ParticleMedium
[docs] : a transfer medium imported from smoothed particle data
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file to be imported |
| massType | docs | Enum | the type of mass quantity to be imported |
| | --> Mass | mass (volume-integrated) |
| | --> Number | number (volume-integrated) |
| massFraction | docs | Double | the fraction of the mass to be included (or one to include all) |
| importMetallicity | docs | Bool | import a metallicity column |
| importTemperature | docs | Bool | import a temperature column |
| maxTemperature | docs | Double | the maximum temperature for included mass (or zero to include all) |
| importVelocity | docs | Bool | import velocity components (3 columns) |
| importMagneticField | docs | Bool | import magnetic field components (3 columns) |
| importVariableMixParams | docs | Bool | import parameter(s) to select a spatially varying material mix |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
| Compound Property | | Type | Base Class | | Description |
| smoothingKernel | docs | Item | SmoothingKernel | subclasses | the kernel for interpolating the smoothed particles |
| materialMix | docs | Item | MaterialMix | subclasses | the material type and properties throughout the medium |
| materialMixFamily | docs | Item | MaterialMixFamily | subclasses | the material mix family addressed by the imported parameter(s) |
-ParticleSource
[docs] : a primary source imported from smoothed particle data
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file to be imported |
| importVelocity | docs | Bool | import velocity components (3 columns) |
| importVelocityDispersion | docs | Bool | import velocity dispersion (spherically symmetric) |
| importCurrentMass | docs | Bool | import current mass |
| importBias | docs | Bool | import a per-particle/cell source bias weight |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
| sourceWeight | docs | Double | the weight of this source for the number of photon packets launched |
| wavelengthBias | docs | Double | the fraction of photon packet wavelengths sampled from a bias distribution |
| Compound Property | | Type | Base Class | | Description |
| smoothingKernel | docs | Item | SmoothingKernel | subclasses | the kernel for interpolating the smoothed particles |
| sedFamily | docs | Item | SEDFamily | subclasses | the SED family for assigning spectra to the imported sources |
| wavelengthBiasDistribution | docs | Item | WavelengthDistribution | subclasses | the bias distribution for sampling photon packet wavelengths |
-PerCellForm
[docs] : a text column file with values for each spatial cell
-PerspectiveInstrument
[docs] : a perspective instrument (mostly for making movies)
| Scalar Property | | Type | Description |
| instrumentName | docs | String | the name for this instrument |
| numPixelsX | docs | Int | the number of viewport pixels in the horizontal direction |
| numPixelsY | docs | Int | the number of viewport pixels in the vertical direction |
| width | docs | Double | the width of the viewport |
| viewX | docs | Double | the position of the viewport origin, x component |
| viewY | docs | Double | the position of the viewport origin, y component |
| viewZ | docs | Double | the position of the viewport origin, z component |
| crossX | docs | Double | the position of the crosshair, x component |
| crossY | docs | Double | the position of the crosshair, y component |
| crossZ | docs | Double | the position of the crosshair, z component |
| upX | docs | Double | the upwards direction, x component |
| upY | docs | Double | the upwards direction, y component |
| upZ | docs | Double | the upwards direction, z component |
| focal | docs | Double | the distance from the eye to the viewport origin |
| recordComponents | docs | Bool | record flux components separately |
| numScatteringLevels | docs | Int | the number of individually recorded scattering levels |
| recordPolarization | docs | Bool | record polarization (Stokes vector elements) |
| recordStatistics | docs | Bool | record information for calculating statistical properties |
| Compound Property | | Type | Base Class | | Description |
| wavelengthGrid | docs | Item | WavelengthGrid | subclasses | the wavelength grid for this instrument |
-PhotonPacketOptions
[docs] : a set of options related to the photon packet lifecycle
| Scalar Property | | Type | Description |
| explicitAbsorption | docs | Bool | use explicit absorption to allow negative absorption (stimulated emission) |
| forceScattering | docs | Bool | use forced scattering to reduce noise |
| minWeightReduction | docs | Double | the minimum weight reduction factor before a photon packet is terminated |
| minScattEvents | docs | Int | the minimum number of forced scattering events before a photon packet is terminated |
| pathLengthBias | docs | Double | the fraction of path lengths sampled from a stretched distribution |
-PlanarCutsForm
[docs] : configurable planar cuts parallel to the coordinate planes
| Scalar Property | | Type | Description |
| minX | docs | Double | the start point of the box in the X direction |
| maxX | docs | Double | the end point of the box in the X direction |
| minY | docs | Double | the start point of the box in the Y direction |
| maxY | docs | Double | the end point of the box in the Y direction |
| minZ | docs | Double | the start point of the box in the Z direction |
| maxZ | docs | Double | the end point of the box in the Z direction |
| positionX | docs | Double | the x position of the cut parallel to the yz plane |
| positionY | docs | Double | the y position of the cut parallel to the xz plane |
| positionZ | docs | Double | the z position of the cut parallel to the xy plane |
| numPixelsX | docs | Int | the number of pixels in the x direction |
| numPixelsY | docs | Int | the number of pixels in the y direction |
| numPixelsZ | docs | Int | the number of pixels in the z direction |
-PlummerGeometry
[docs] : a Plummer geometry
| Scalar Property | | Type | Description |
| scaleLength | docs | Double | the scale length |
-PointSource
[docs] : a primary point source
| Scalar Property | | Type | Description |
| positionX | docs | Double | the position of the point source, x component |
| positionY | docs | Double | the position of the point source, y component |
| positionZ | docs | Double | the position of the point source, z component |
| velocityX | docs | Double | the bulk velocity of the source, x component |
| velocityY | docs | Double | the bulk velocity of the source, y component |
| velocityZ | docs | Double | the bulk velocity of the source, z component |
| sourceWeight | docs | Double | the weight of this source for the number of photon packets launched |
| wavelengthBias | docs | Double | the fraction of photon packet wavelengths sampled from a bias distribution |
| Compound Property | | Type | Base Class | | Description |
| angularDistribution | docs | Item | AngularDistribution | subclasses | the angular luminosity distribution of the emission |
| polarizationProfile | docs | Item | PolarizationProfile | subclasses | the polarization profile of the emission |
| sed | docs | Item | SED | subclasses | the spectral energy distribution for the source |
| normalization | docs | Item | LuminosityNormalization | subclasses | the type of luminosity normalization for the source |
| wavelengthBiasDistribution | docs | Item | WavelengthDistribution | subclasses | the bias distribution for sampling photon packet wavelengths |
-PolarizedGraphiteGrainComposition
[docs] : a graphite dust grain composition with support for polarization
-PolarizedSilicateGrainComposition
[docs] : a silicate dust grain composition with support for polarization
-PolicyTreeSpatialGrid
[docs] : a tree-based spatial grid
| Scalar Property | | Type | Description |
| minX | docs | Double | the start point of the box in the X direction |
| maxX | docs | Double | the end point of the box in the X direction |
| minY | docs | Double | the start point of the box in the Y direction |
| maxY | docs | Double | the end point of the box in the Y direction |
| minZ | docs | Double | the start point of the box in the Z direction |
| maxZ | docs | Double | the end point of the box in the Z direction |
| treeType | docs | Enum | the type of tree |
| | --> OctTree | an octtree (8 children per node) |
| | --> BinTree | a binary tree (2 children per node) |
| Compound Property | | Type | Base Class | | Description |
| policy | docs | Item | TreePolicy | subclasses | the tree construction policy (configuration options) |
-PowMesh
[docs] : a power-law mesh
| Scalar Property | | Type | Description |
| numBins | docs | Int | the number of bins in the mesh |
| ratio | docs | Double | the bin width ratio between the last and the first bin |
-PowerLawGrainSizeDistribution
[docs] : a power-law dust grain size distribution
| Scalar Property | | Type | Description |
| minSize | docs | Double | the minimum grain size for this distribution |
| maxSize | docs | Double | the maximum grain size for this distribution |
| exponent | docs | Double | the (absolute value of the) exponent in the power-law distribution function |
-PredefinedBandWavelengthGrid
[docs] : a wavelength grid including a predefined list of (broad)bands
| Scalar Property | | Type | Description |
| includeGALEX | docs | Bool | include GALEX FUV and NUV bands |
| includeSDSS | docs | Bool | include SDSS ugriz bands |
| include2MASS | docs | Bool | include 2MASS J, H and Ks bands |
| includeWISE | docs | Bool | include WISE W1, W2, W3 and W4 bands |
| includeHERSCHEL | docs | Bool | include HERSCHEL PACS 70,100,160 and SPIRE 250,350,500 bands |
-ProbeSystem
[docs] : a probe system
| Compound Property | | Type | Base Class | | Description |
| probes | docs | ItemList | Probe | subclasses | the probes |
-PseudoSersicGeometry
[docs] : a pseudo-Sérsic geometry
| Scalar Property | | Type | Description |
| effectiveRadius | docs | Double | the effective radius |
| index | docs | Double | the Sérsic index n |
-QuarticSplineSmoothingKernel
[docs] : a quartic spline smoothing kernel
-QuasarSED
[docs] : the spectral energy distribution of a typical quasar
-RadialVectorField
[docs] : a vector field pointing away from the origin
| Scalar Property | | Type | Description |
| unityRadius | docs | Double | the radius where the magnitude of the vectors is unity |
| exponent | docs | Double | the power-law exponent governing the radial dependence of the magnitude |
-RadiationFieldOptions
[docs] : a set of options related to the radiation field
| Scalar Property | | Type | Description |
| storeRadiationField | docs | Bool | store the radiation field so that it can be probed for output |
| Compound Property | | Type | Base Class | | Description |
| radiationFieldWLG | docs | Item | DisjointWavelengthGrid | subclasses | the wavelength grid for storing the radiation field |
-RadiationFieldProbe
[docs] : internal spatial grid: the mean radiation field intensity
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| writeWavelengthGrid | docs | Bool | output a text file with the radiation field wavelength grid |
| probeAfter | docs | Enum | perform the probe after |
| | --> Run | after the complete simulation run |
| | --> Primary | after each iteration over primary emission |
| | --> Secondary | after each iteration over secondary emission |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | Form | subclasses | the form describing how this quantity should be probed |
-RadiationFieldWavelengthGridProbe
[docs] : wavelength grid: radiation field
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
-Random
[docs] : the default random generator
| Scalar Property | | Type | Description |
| seed | docs | Int | the seed for the random generator |
-ReadFits3DGeometry
[docs] : a geometry read from a 3D FITS file
| Scalar Property | | Type | Description |
| filename | docs | String | the filename of the datacube |
| pixelScale | docs | Double | the pixel scale for the datacube (i.e. the physical length per pixel) |
-ReadFitsGeometry
[docs] : a geometry read from a 2D FITS file
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the input image file |
| pixelScale | docs | Double | the physical scale of the image (length per pixel) |
| positionAngle | docs | Double | the position angle ω of the system |
| inclination | docs | Double | the inclination angle θ of the system |
| numPixelsX | docs | Int | number of pixels in the x direction |
| centerX | docs | Double | x coordinate of the center (in pixels) |
| numPixelsY | docs | Int | number of pixels in the y direction |
| centerY | docs | Double | y coordinate of the center (in pixels) |
| scaleHeight | docs | Double | the scale height |
-ResolutionBorderWavelengthGrid
[docs] : a logarithmic wavelength grid with given spectral resolution and outer borders
| Scalar Property | | Type | Description |
| minWavelength | docs | Double | the shortest wavelength |
| maxWavelength | docs | Double | the longest wavelength |
| resolution | docs | Double | the spectral resolution R of the grid |
-ResolutionWavelengthGrid
[docs] : a logarithmic wavelength grid with given spectral resolution
| Scalar Property | | Type | Description |
| minWavelength | docs | Double | the shortest wavelength |
| maxWavelength | docs | Double | the longest wavelength |
| resolution | docs | Double | the spectral resolution R of the grid |
-RingGeometry
[docs] : a ring geometry
| Scalar Property | | Type | Description |
| ringRadius | docs | Double | the radius of the ring |
| width | docs | Double | the radial width of the ring |
| height | docs | Double | the scale height of the ring |
-RotateGeometryDecorator
[docs] : a decorator that adds a rotation to any geometry
| Scalar Property | | Type | Description |
| eulerAlpha | docs | Double | the first Euler angle α |
| eulerBeta | docs | Double | the second Euler angle β |
| eulerGamma | docs | Double | the third Euler angle γ |
| Compound Property | | Type | Base Class | | Description |
| geometry | docs | Item | Geometry | subclasses | the geometry to be rotated |
-RotateVectorFieldDecorator
[docs] : a decorator that adds a rotation to any vector field
| Scalar Property | | Type | Description |
| eulerAlpha | docs | Double | the first Euler angle α |
| eulerBeta | docs | Double | the second Euler angle β |
| eulerGamma | docs | Double | the third Euler angle γ |
| Compound Property | | Type | Base Class | | Description |
| vectorField | docs | Item | VectorField | subclasses | the vector field to be rotated |
-SEDInstrument
[docs] : a distant instrument that outputs the spatially integrated flux density as an SED
| Scalar Property | | Type | Description |
| instrumentName | docs | String | the name for this instrument |
| distance | docs | Double | the distance to the system |
| inclination | docs | Double | the inclination angle θ of the detector |
| azimuth | docs | Double | the azimuth angle φ of the detector |
| roll | docs | Double | the roll angle ω of the detector |
| radius | docs | Double | the radius of the circular aperture, or zero for no aperture |
| recordComponents | docs | Bool | record flux components separately |
| numScatteringLevels | docs | Int | the number of individually recorded scattering levels |
| recordPolarization | docs | Bool | record polarization (Stokes vector elements) |
| recordStatistics | docs | Bool | record information for calculating statistical properties |
| Compound Property | | Type | Base Class | | Description |
| wavelengthGrid | docs | Item | WavelengthGrid | subclasses | the wavelength grid for this instrument |
-SIUnits
[docs] : SI units
| Scalar Property | | Type | Description |
| wavelengthOutputStyle | docs | Enum | the output style for wavelengths |
| | --> Wavelength | as photon wavelength: λ |
| | --> Frequency | as photon frequency: ν |
| | --> Energy | as photon energy: E |
| fluxOutputStyle | docs | Enum | the output style for flux density and surface brightness |
| | --> Neutral | neutral: λ F_λ = ν F_ν |
| | --> Wavelength | per unit of wavelength: F_λ |
| | --> Frequency | per unit of frequency: F_ν |
| | --> Energy | counts per unit of energy: F_E |
-SamplingOptions
[docs] : a set of options related to media sampling for the spatial grid
| Scalar Property | | Type | Description |
| numDensitySamples | docs | Int | the number of random density samples for determining spatial cell mass |
| numPropertySamples | docs | Int | the number of random samples for determining other medium properties |
| aggregateVelocity | docs | Enum | aggregating the bulk velocity from multiple medium components |
| | --> Average | Use the density-weighted average; missing values are taken to be zero |
| | --> Maximum | Use the vector with largest magnitude; missing values are taken to be zero |
| | --> First | Use the vector of the first medium component for which one is available |
-ScaledGaussianSmoothingKernel
[docs] : a scaled Gaussian smoothing kernel
-SecondaryDustLuminosityProbe
[docs] : internal spatial grid: secondary dust luminosity
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| probeAfter | docs | Enum | perform the probe after |
| | --> Run | after the complete simulation run |
| | --> Secondary | after each iteration over secondary emission |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | Form | subclasses | the form describing how this quantity should be probed |
-SecondaryEmissionOptions
[docs] : a set of options related to secondary emission
| Scalar Property | | Type | Description |
| storeEmissionRadiationField | docs | Bool | store the radiation field during emission so that it can be probed for output |
| secondaryPacketsMultiplier | docs | Double | the multiplier on the number of photon packets launched for secondary emission |
| spatialBias | docs | Double | the fraction of secondary photon packets distributed uniformly across spatial cells |
| sourceBias | docs | Double | the fraction of photon packets distributed uniformly across secondary sources |
-SecondaryLineLuminosityProbe
[docs] : internal spatial grid: secondary line luminosity
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| probeAfter | docs | Enum | perform the probe after |
| | --> Run | after the complete simulation run |
| | --> Secondary | after each iteration over secondary emission |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | Form | subclasses | the form describing how this quantity should be probed |
-SelectDustMixFamily
[docs] : a family of dust mixes specified in the configuration
| Compound Property | | Type | Base Class | | Description |
| dustMixes | docs | ItemList | DustMix | subclasses | the family of dust mixes |
-SersicGeometry
[docs] : a Sérsic geometry
| Scalar Property | | Type | Description |
| effectiveRadius | docs | Double | the effective radius |
| index | docs | Double | the Sérsic index n |
-ShellGeometry
[docs] : a shell geometry
| Scalar Property | | Type | Description |
| minRadius | docs | Double | the inner radius of the shell |
| maxRadius | docs | Double | the outer radius of the shell |
| exponent | docs | Double | the power law exponent |
-SineSquarePolarizationProfile
[docs] : an axysimmetric sine-square polarization emission profile
| Scalar Property | | Type | Description |
| symmetryX | docs | Double | the direction of the positive symmetry axis, x component |
| symmetryY | docs | Double | the direction of the positive symmetry axis, y component |
| symmetryZ | docs | Double | the direction of the positive symmetry axis, z component |
| maxPolarizationDegree | docs | Double | the maximum linear polarization degree |
| polarizationAngle | docs | Double | the linear polarization angle |
-SingleGrainSizeDistribution
[docs] : a single-size dust grain size distribution
| Scalar Property | | Type | Description |
| size | docs | Double | the single grain size for this distribution |
-SingleWavelengthSED
[docs] : a single-wavelength SED in the form of a Dirac-delta function
| Scalar Property | | Type | Description |
| wavelength | docs | Double | the single emission wavelength |
-SiteListTreePolicy
[docs] : a tree grid construction policy using positions defined by an imported medium
| Scalar Property | | Type | Description |
| minLevel | docs | Int | the minimum level of grid refinement |
| maxLevel | docs | Int | the maximum level of grid refinement |
| numExtraLevels | docs | Int | the number of additional subdivision levels |
-SourceSystem
[docs] : a primary source system
| Scalar Property | | Type | Description |
| minWavelength | docs | Double | the shortest wavelength of photon packets launched from primary sources |
| maxWavelength | docs | Double | the longest wavelength of photon packets launched from primary sources |
| wavelengths | docs | DoubleList | the discrete wavelengths of photon packets launched from primary sources |
| sourceBias | docs | Double | the fraction of photon packets distributed uniformly across primary sources |
| Compound Property | | Type | Base Class | | Description |
| sources | docs | ItemList | Source | subclasses | the primary sources |
-SpatialCellPropertiesProbe
[docs] : properties: basic info for each spatial cell
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| wavelength | docs | Double | the wavelength at which to determine the optical depth |
| probeAfter | docs | Enum | perform the probe after |
| | --> Setup | after setup |
| | --> Run | after the complete simulation run |
-SpatialGridPlotProbe
[docs] : properties: data files for plotting the structure of the grid
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
-SpatialGridSourceDensityProbe
[docs] : specialty: primary source density discretized on spatial grid
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
-SpecificLuminosityNormalization
[docs] : source normalization through the specific luminosity at a given wavelength
| Scalar Property | | Type | Description |
| wavelength | docs | Double | the wavelength at which to provide the specific luminosity |
| unitStyle | docs | Enum | the luminosity unit style |
| | --> neutralmonluminosity | neutral: λ L_λ = ν L_ν |
| | --> wavelengthmonluminosity | per unit of wavelength: L_λ |
| | --> frequencymonluminosity | per unit of frequency: L_ν |
| | --> energymonluminosity | counts per unit of energy: L_E |
| specificLuminosity | docs | Double | the specific luminosity at the given wavelength |
-SphePowerLawRedistributeGeometryDecorator
[docs] : a decorator that redistributes another geometry with a spherical power law
| Scalar Property | | Type | Description |
| exponent | docs | Double | the negative power of the weight function |
| minRadius | docs | Double | the radius of the clipping sphere |
| Compound Property | | Type | Base Class | | Description |
| geometry | docs | Item | Geometry | subclasses | the geometry for which the density will be redistributed |
-Sphere1DSpatialGrid
[docs] : a 1D spherically symmetric spatial grid
| Scalar Property | | Type | Description |
| minRadius | docs | Double | the inner radius of the grid |
| maxRadius | docs | Double | the outer radius of the grid |
| Compound Property | | Type | Base Class | | Description |
| meshRadial | docs | Item | Mesh | subclasses | the bin distribution in the radial direction |
-Sphere2DSpatialGrid
[docs] : a 2D axisymmetric spatial grid in spherical coordinates
| Scalar Property | | Type | Description |
| minRadius | docs | Double | the inner radius of the grid |
| maxRadius | docs | Double | the outer radius of the grid |
| Compound Property | | Type | Base Class | | Description |
| meshRadial | docs | Item | Mesh | subclasses | the bin distribution in the radial direction |
| meshPolar | docs | Item | Mesh | subclasses | the bin distribution in the polar direction |
-Sphere3DSpatialGrid
[docs] : a 3D spatial grid in spherical coordinates
| Scalar Property | | Type | Description |
| minRadius | docs | Double | the inner radius of the grid |
| maxRadius | docs | Double | the outer radius of the grid |
| Compound Property | | Type | Base Class | | Description |
| meshRadial | docs | Item | Mesh | subclasses | the bin distribution in the radial direction |
| meshPolar | docs | Item | Mesh | subclasses | the bin distribution in the polar direction |
| meshAzimuthal | docs | Item | Mesh | subclasses | the bin distribution in the azimuthal direction |
-SphericalBackgroundSource
[docs] : a spherical background source with an anisotropic inward radiation field
| Scalar Property | | Type | Description |
| centerX | docs | Double | the center of the source, x component |
| centerY | docs | Double | the center of the source, y component |
| centerZ | docs | Double | the center of the source, z component |
| backgroundRadius | docs | Double | the radius of the background sphere |
| velocityX | docs | Double | the bulk velocity of the source, x component |
| velocityY | docs | Double | the bulk velocity of the source, y component |
| velocityZ | docs | Double | the bulk velocity of the source, z component |
| sourceWeight | docs | Double | the weight of this source for the number of photon packets launched |
| wavelengthBias | docs | Double | the fraction of photon packet wavelengths sampled from a bias distribution |
| Compound Property | | Type | Base Class | | Description |
| sed | docs | Item | SED | subclasses | the spectral energy distribution for the source |
| normalization | docs | Item | LuminosityNormalization | subclasses | the type of luminosity normalization for the source |
| wavelengthBiasDistribution | docs | Item | WavelengthDistribution | subclasses | the bias distribution for sampling photon packet wavelengths |
-SphericalCellGeometry
[docs] : a geometry imported from spherical cell data
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file to be imported |
| autoRevolve | docs | Enum | automatically revolve 1D or 2D data to a 3D model |
| | --> None | no auto-revolve |
| | --> Inclination | auto-revolve inclination |
| | --> Azimuth | auto-revolve azimuth |
| | --> InclinationAndAzimuth | auto-revolve both inclination and azimuth |
| numInclinationRevolveBins | docs | Int | the number of inclination bins for auto-revolving 1D or 2D data |
| numAzimuthRevolveBins | docs | Int | the number of azimuth bins for auto-revolving 1D or 2D data |
| massType | docs | Enum | the type of mass quantity to be imported |
| | --> MassDensity | mass density |
| | --> Mass | mass (volume-integrated mass density) |
| | --> NumberDensity | number density |
| | --> Number | number (volume-integrated number density) |
| importMetallicity | docs | Bool | import a metallicity column |
| importTemperature | docs | Bool | import a temperature column |
| maxTemperature | docs | Double | the maximum temperature for included mass (or zero to include all) |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
-SphericalCellMedium
[docs] : a transfer medium imported from spherical cell data
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file to be imported |
| autoRevolve | docs | Enum | automatically revolve 1D or 2D data to a 3D model |
| | --> None | no auto-revolve |
| | --> Inclination | auto-revolve inclination |
| | --> Azimuth | auto-revolve azimuth |
| | --> InclinationAndAzimuth | auto-revolve both inclination and azimuth |
| numInclinationRevolveBins | docs | Int | the number of inclination bins for auto-revolving 1D or 2D data |
| numAzimuthRevolveBins | docs | Int | the number of azimuth bins for auto-revolving 1D or 2D data |
| massType | docs | Enum | the type of mass quantity to be imported |
| | --> MassDensity | mass density |
| | --> Mass | mass (volume-integrated) |
| | --> NumberDensity | number density |
| | --> Number | number (volume-integrated) |
| massFraction | docs | Double | the fraction of the mass to be included (or one to include all) |
| importMetallicity | docs | Bool | import a metallicity column |
| importTemperature | docs | Bool | import a temperature column |
| maxTemperature | docs | Double | the maximum temperature for included mass (or zero to include all) |
| importVelocity | docs | Bool | import velocity components (3 columns) |
| importMagneticField | docs | Bool | import magnetic field components (3 columns) |
| importVariableMixParams | docs | Bool | import parameter(s) to select a spatially varying material mix |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
| Compound Property | | Type | Base Class | | Description |
| materialMix | docs | Item | MaterialMix | subclasses | the material type and properties throughout the medium |
| materialMixFamily | docs | Item | MaterialMixFamily | subclasses | the material mix family addressed by the imported parameter(s) |
-SphericalCellSource
[docs] : a primary source imported from spherical cell data
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file to be imported |
| autoRevolve | docs | Enum | automatically revolve 1D or 2D data to a 3D model |
| | --> None | no auto-revolve |
| | --> Inclination | auto-revolve inclination |
| | --> Azimuth | auto-revolve azimuth |
| | --> InclinationAndAzimuth | auto-revolve both inclination and azimuth |
| numInclinationRevolveBins | docs | Int | the number of inclination bins for auto-revolving 1D or 2D data |
| numAzimuthRevolveBins | docs | Int | the number of azimuth bins for auto-revolving 1D or 2D data |
| importVelocity | docs | Bool | import velocity components (3 columns) |
| importVelocityDispersion | docs | Bool | import velocity dispersion (spherically symmetric) |
| importCurrentMass | docs | Bool | import current mass |
| importBias | docs | Bool | import a per-particle/cell source bias weight |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
| sourceWeight | docs | Double | the weight of this source for the number of photon packets launched |
| wavelengthBias | docs | Double | the fraction of photon packet wavelengths sampled from a bias distribution |
| Compound Property | | Type | Base Class | | Description |
| sedFamily | docs | Item | SEDFamily | subclasses | the SED family for assigning spectra to the imported sources |
| wavelengthBiasDistribution | docs | Item | WavelengthDistribution | subclasses | the bias distribution for sampling photon packet wavelengths |
-SphericalClipGeometryDecorator
[docs] : a decorator that clips another geometry using a sphere
| Scalar Property | | Type | Description |
| remove | docs | Enum | the region to be removed |
| | --> Inside | the inner region (creating a cavity) |
| | --> Outside | the outer region (cropping) |
| clipRadius | docs | Double | the radius of the clipping sphere |
| centerX | docs | Double | the x coordinate of the sphere's center |
| centerY | docs | Double | the y coordinate of the sphere's center |
| centerZ | docs | Double | the z coordinate of the sphere's center |
| Compound Property | | Type | Base Class | | Description |
| geometry | docs | Item | Geometry | subclasses | the geometry to be clipped |
-SpheroidalGeometryDecorator
[docs] : a decorator that constructs a spheroidal variant of any spherical geometry
| Scalar Property | | Type | Description |
| flattening | docs | Double | the flattening parameter q |
| Compound Property | | Type | Base Class | | Description |
| geometry | docs | Item | SpheGeometry | subclasses | the spherical geometry to be made spheroidal |
-SpheroidalGraphiteGrainComposition
[docs] : a spheroidal graphite dust grain composition with support for polarization
| Scalar Property | | Type | Description |
| tableType | docs | Enum | the type of emission tables to use |
| | --> Builtin | builtin resources |
| | --> OneTable | single custom table |
| | --> TwoTables | two custom tables with interpolation |
| emissionTable | docs | String | the name of the file tabulating properties for polarized emission by arbitrarily aligned spheroidal grains |
| alignedEmissionTable | docs | String | the name of the file tabulating properties for polarized emission by perfectly aligned spheroidal grains |
| nonAlignedEmissionTable | docs | String | the name of the file tabulating properties for polarized emission by non-aligned spheroidal grains |
| alignmentFraction | docs | Double | the alignment fraction of the spheroidal grains with the local magnetic field |
-SpheroidalSilicateGrainComposition
[docs] : a spheroidal silicate dust grain composition with support for polarization
| Scalar Property | | Type | Description |
| tableType | docs | Enum | the type of emission tables to use |
| | --> Builtin | builtin resources |
| | --> OneTable | single custom table |
| | --> TwoTables | two custom tables with interpolation |
| emissionTable | docs | String | the name of the file tabulating properties for polarized emission by arbitrarily aligned spheroidal grains |
| alignedEmissionTable | docs | String | the name of the file tabulating properties for polarized emission by perfectly aligned spheroidal grains |
| nonAlignedEmissionTable | docs | String | the name of the file tabulating properties for polarized emission by non-aligned spheroidal grains |
| alignmentFraction | docs | Double | the alignment fraction of the spheroidal grains with the local magnetic field |
-SpinFlipAbsorptionMix
[docs] : A gas mix supporting the spin-flip 21 cm hydrogen absorption
| Scalar Property | | Type | Description |
| defaultTemperature | docs | Double | the default temperature of the gas |
-SpinFlipHydrogenGasMix
[docs] : A gas mix supporting the spin-flip 21 cm hydrogen transition
| Scalar Property | | Type | Description |
| sourceWeight | docs | Double | the weight of this secondary source for the number of photon packets launched |
| wavelengthBias | docs | Double | the fraction of secondary photon packet wavelengths sampled from a bias distribution |
| defaultMetallicity | docs | Double | the default metallicity of the gas |
| defaultTemperature | docs | Double | the default temperature of the gas |
| defaultNeutralSurfaceDensity | docs | Double | the default neutral hydrogen surface density |
| Compound Property | | Type | Base Class | | Description |
| wavelengthBiasDistribution | docs | Item | WavelengthDistribution | subclasses | the bias distribution for sampling secondary photon packet wavelengths |
-SpinFlipSEDFamily
[docs] : a family of Gaussian spectra around the central spin-flip wavelength
-SpiralStructureGeometryDecorator
[docs] : a decorator that adds spiral structure to any axisymmetric geometry
| Scalar Property | | Type | Description |
| numArms | docs | Int | the number of spiral arms |
| pitchAngle | docs | Double | the pitch angle |
| radiusZeroPoint | docs | Double | the radius zero-point |
| phaseZeroPoint | docs | Double | the phase zero-point |
| perturbationWeight | docs | Double | the weight of the spiral perturbation |
| index | docs | Int | the arm-interarm size ratio index |
| Compound Property | | Type | Base Class | | Description |
| geometry | docs | Item | AxGeometry | subclasses | the axisymmetric geometry to be decorated with spiral structure |
-Starburst99SED
[docs] : a Starburst99 simple stellar population SED
| Scalar Property | | Type | Description |
| metallicity | docs | Double | the metallicity of the SSP |
| age | docs | Double | the age of the SSP |
-Starburst99SEDFamily
[docs] : a Starburst99 SED family for single stellar populations
-StellarSurfaceSource
[docs] : a stellar surface source with an anisotropic outward radiation field
| Scalar Property | | Type | Description |
| centerX | docs | Double | the center of the source, x component |
| centerY | docs | Double | the center of the source, y component |
| centerZ | docs | Double | the center of the source, z component |
| stellarRadius | docs | Double | the stellar radius |
| velocityX | docs | Double | the bulk velocity of the source, x component |
| velocityY | docs | Double | the bulk velocity of the source, y component |
| velocityZ | docs | Double | the bulk velocity of the source, z component |
| sourceWeight | docs | Double | the weight of this source for the number of photon packets launched |
| wavelengthBias | docs | Double | the fraction of photon packet wavelengths sampled from a bias distribution |
| Compound Property | | Type | Base Class | | Description |
| sed | docs | Item | SED | subclasses | the spectral energy distribution for the source |
| normalization | docs | Item | LuminosityNormalization | subclasses | the type of luminosity normalization for the source |
| wavelengthBiasDistribution | docs | Item | WavelengthDistribution | subclasses | the bias distribution for sampling photon packet wavelengths |
-StellarUnits
[docs] : stellar units (length in AU, distance in pc)
| Scalar Property | | Type | Description |
| wavelengthOutputStyle | docs | Enum | the output style for wavelengths |
| | --> Wavelength | as photon wavelength: λ |
| | --> Frequency | as photon frequency: ν |
| | --> Energy | as photon energy: E |
| fluxOutputStyle | docs | Enum | the output style for flux density and surface brightness |
| | --> Neutral | neutral: λ F_λ = ν F_ν |
| | --> Wavelength | per unit of wavelength: F_λ |
| | --> Frequency | per unit of frequency: F_ν |
| | --> Energy | counts per unit of energy: F_E |
-SunSED
[docs] : the spectral energy distribution of the Sun
-SymCosMesh
[docs] : a symmetric cosine mesh
| Scalar Property | | Type | Description |
| numBins | docs | Int | the number of bins in the mesh |
-SymLogMesh
[docs] : a symmetric logarithmic mesh
| Scalar Property | | Type | Description |
| numBins | docs | Int | the number of bins in the mesh |
| centralBinFraction | docs | Double | the central bin width fraction |
-SymPowMesh
[docs] : a symmetric power-law mesh
| Scalar Property | | Type | Description |
| numBins | docs | Int | the number of bins in the mesh |
| ratio | docs | Double | the bin width ratio between the outermost and the innermost bins |
-TTauriDiskGeometry
[docs] : a T Tauri disk geometry
| Scalar Property | | Type | Description |
| scaleLength | docs | Double | the scale length |
| scaleHeight | docs | Double | the scale height |
| minRadius | docs | Double | the inner radius of the disk |
| maxRadius | docs | Double | the outer radius of the disk |
| radialIndex | docs | Double | the radial exponent index α |
| verticalIndex | docs | Double | the vertical exponent index b |
-TemperatureProbe
[docs] : internal spatial grid: indicative temperature of the medium
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| aggregation | docs | Enum | how to aggregate the indicative temperature |
| | --> Fragment | per fragment (dust grain material type and/or size bin) |
| | --> Component | per medium component |
| | --> Type | per medium type (dust, electrons, gas) |
| probeAfter | docs | Enum | perform the probe after |
| | --> Setup | after setup |
| | --> Run | after the complete simulation run |
| | --> Primary | after each iteration over primary emission |
| | --> Secondary | after each iteration over secondary emission |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | Form | subclasses | the form describing how this quantity should be probed |
-TemperatureWavelengthCellLibrary
[docs] : a library scheme for grouping spatial cells based on indicative temperature and wavelength
| Scalar Property | | Type | Description |
| numTemperatures | docs | Int | the number of temperature bins |
| numWavelengths | docs | Int | the number of wavelength bins |
-TetraMeshSpatialGrid
[docs] : a tetrahedral spatial grid
| Scalar Property | | Type | Description |
| minX | docs | Double | the start point of the box in the X direction |
| maxX | docs | Double | the end point of the box in the X direction |
| minY | docs | Double | the start point of the box in the Y direction |
| maxY | docs | Double | the end point of the box in the Y direction |
| minZ | docs | Double | the start point of the box in the Z direction |
| maxZ | docs | Double | the end point of the box in the Z direction |
| policy | docs | Enum | the policy for determining the positions of the vertices |
| | --> Uniform | random from uniform distribution |
| | --> CentralPeak | random from distribution with a steep central peak |
| | --> DustDensity | random from dust density distribution |
| | --> ElectronDensity | random from electron density distribution |
| | --> GasDensity | random from gas density distribution |
| | --> File | loaded from text column data file |
| numSamples | docs | Int | the number of random positions to be used as vertices |
| filename | docs | String | the name of the file containing the vertex positions |
| refine | docs | Bool | refine the grid by performing local mesh operations |
-ThemisDustMix
[docs] : a THEMIS (Jones et al. 2017) dust mix
| Scalar Property | | Type | Description |
| numSilicateSizes | docs | Int | the number of grain size bins for each of the silicate populations |
| numHydrocarbonSizes | docs | Int | the number of grain size bins for each of the hydrocarbon populations |
-ToddlersSED
[docs] : a Toddlers SED for emission from star-forming regions
| Scalar Property | | Type | Description |
| metallicity | docs | Double | metallicity |
| SFE | docs | Double | star formation efficiency |
| cloudNumDensity | docs | Double | initial cloud number density |
-ToddlersSEDFamily
[docs] : a TODDLERS SED family for emission from star-forming regions
| Scalar Property | | Type | Description |
| sedMode | docs | Enum | SED calculation mode |
| | --> SFRNormalized | SEDs normalized by star formation rate |
| | --> Cloud | Individual cloud SEDs with time evolution |
| stellarTemplate | docs | Enum | the stellar template, IMF, and evolution model to use |
| | --> SB99Kroupa100Sin | Starburst99 with Kroupa IMF (0.1-100 Msun) and single star evolution |
| | --> BPASSChab100Bin | BPASS with Chabrier IMF (0.1-100 Msun) and binary star evolution |
| | --> BPASSChab300Bin | BPASS with Chabrier IMF (0.1-300 Msun) and binary star evolution |
| includeDust | docs | Bool | include dust processing in the SED models |
| resolution | docs | Enum | the wavelength resolution |
| | --> Low | Low wavelength resolution (continuum and lines at R=300) |
| | --> High | High wavelength resolution (continuum at R=300 and lines at R=5e4) |
| sfrPeriod | docs | Enum | the SFR integration time period |
| | --> Period10Myr | SFR integrated over 10 Myr |
| | --> Period30Myr | SFR integrated over 30 Myr |
-TorusGeometry
[docs] : a torus geometry
| Scalar Property | | Type | Description |
| exponent | docs | Double | the radial powerlaw exponent p of the torus |
| index | docs | Double | the polar index q of the torus |
| openingAngle | docs | Double | the half opening angle of the torus |
| minRadius | docs | Double | the minimum radius of the torus |
| maxRadius | docs | Double | the maximum radius of the torus |
| reshapeInnerRadius | docs | Bool | reshape the inner radius according to the Netzer luminosity profile |
| cutoffRadius | docs | Double | the inner cutoff radius of the torus |
-TreeSpatialGridTopologyProbe
[docs] : specialty: data file representing the topology of the tree spatial grid
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
-TriaxialGeometryDecorator
[docs] : a decorator that constructs a triaxial variant of any spherical geometry
| Scalar Property | | Type | Description |
| flatteningY | docs | Double | the flattening parameter p (along the y-axis) |
| flatteningZ | docs | Double | the flattening parameter q (along the z-axis) |
| Compound Property | | Type | Base Class | | Description |
| geometry | docs | Item | SpheGeometry | subclasses | the spherical geometry to be made triaxial |
-TrivialGasMix
[docs] : A trivial gas mix for testing purposes
| Scalar Property | | Type | Description |
| absorptionCrossSection | docs | Double | the absorption cross section per hydrogen atom |
| scatteringCrossSection | docs | Double | the scattering cross section per hydrogen atom |
| asymmetryParameter | docs | Double | the scattering asymmetry parameter |
-TrustBenchmarkDustMix
[docs] : a TRUST benchmark dust mix
| Scalar Property | | Type | Description |
| numSilicateSizes | docs | Int | the number of silicate grain size bins |
| numGraphiteSizes | docs | Int | the number of graphite grain size bins |
| numPAHSizes | docs | Int | the number of PAH size bins |
-TrustGraphiteGrainComposition
[docs] : a TRUST benchmark graphite dust grain composition
-TrustNeutralPAHGrainComposition
[docs] : a TRUST benchmark neutral PAH dust grain composition
-TrustSilicateGrainComposition
[docs] : a TRUST benchmark silicate dust grain composition
-UnidirectionalVectorField
[docs] : a vector field uniformly pointing in a given direction
| Scalar Property | | Type | Description |
| fieldX | docs | Double | the field direction, x component |
| fieldY | docs | Double | the field direction, y component |
| fieldZ | docs | Double | the field direction, z component |
-UniformBoxGeometry
[docs] : a geometry with uniform density inside a box
| Scalar Property | | Type | Description |
| minX | docs | Double | the start point of the box in the X direction |
| maxX | docs | Double | the end point of the box in the X direction |
| minY | docs | Double | the start point of the box in the Y direction |
| maxY | docs | Double | the end point of the box in the Y direction |
| minZ | docs | Double | the start point of the box in the Z direction |
| maxZ | docs | Double | the end point of the box in the Z direction |
-UniformSmoothingKernel
[docs] : a uniform smoothing kernel
-VelocityProbe
[docs] : internal spatial grid: bulk velocity of the medium
| Scalar Property | | Type | Description |
| probeName | docs | String | the name for this probe |
| Compound Property | | Type | Base Class | | Description |
| form | docs | Item | Form | subclasses | the form describing how this quantity should be probed |
-VoronoiMeshGeometry
[docs] : a geometry imported from data represented on a Voronoi mesh
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file to be imported |
| minX | docs | Double | the start point of the domain in the X direction |
| maxX | docs | Double | the end point of the domain in the X direction |
| minY | docs | Double | the start point of the domain in the Y direction |
| maxY | docs | Double | the end point of the domain in the Y direction |
| minZ | docs | Double | the start point of the domain in the Z direction |
| maxZ | docs | Double | the end point of the domain in the Z direction |
| massType | docs | Enum | the type of mass quantity to be imported |
| | --> MassDensity | mass density |
| | --> Mass | mass (volume-integrated mass density) |
| | --> NumberDensity | number density |
| | --> Number | number (volume-integrated number density) |
| importMetallicity | docs | Bool | import a metallicity column |
| importTemperature | docs | Bool | import a temperature column |
| maxTemperature | docs | Double | the maximum temperature for included mass (or zero to include all) |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
-VoronoiMeshMedium
[docs] : a transfer medium imported from data represented on a Voronoi mesh
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file to be imported |
| minX | docs | Double | the start point of the domain in the X direction |
| maxX | docs | Double | the end point of the domain in the X direction |
| minY | docs | Double | the start point of the domain in the Y direction |
| maxY | docs | Double | the end point of the domain in the Y direction |
| minZ | docs | Double | the start point of the domain in the Z direction |
| maxZ | docs | Double | the end point of the domain in the Z direction |
| massType | docs | Enum | the type of mass quantity to be imported |
| | --> MassDensity | mass density |
| | --> Mass | mass (volume-integrated) |
| | --> MassDensityAndMass | both mass density and volume-integrated mass |
| | --> NumberDensity | number density |
| | --> Number | number (volume-integrated) |
| | --> NumberDensityAndNumber | both number density and volume-integrated number |
| massFraction | docs | Double | the fraction of the mass to be included (or one to include all) |
| importMetallicity | docs | Bool | import a metallicity column |
| importTemperature | docs | Bool | import a temperature column |
| maxTemperature | docs | Double | the maximum temperature for included mass (or zero to include all) |
| importVelocity | docs | Bool | import velocity components (3 columns) |
| importMagneticField | docs | Bool | import magnetic field components (3 columns) |
| importVariableMixParams | docs | Bool | import parameter(s) to select a spatially varying material mix |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
| Compound Property | | Type | Base Class | | Description |
| materialMix | docs | Item | MaterialMix | subclasses | the material type and properties throughout the medium |
| materialMixFamily | docs | Item | MaterialMixFamily | subclasses | the material mix family addressed by the imported parameter(s) |
-VoronoiMeshSource
[docs] : a primary source imported from data represented on a Voronoi mesh
| Scalar Property | | Type | Description |
| filename | docs | String | the name of the file to be imported |
| minX | docs | Double | the start point of the domain in the X direction |
| maxX | docs | Double | the end point of the domain in the X direction |
| minY | docs | Double | the start point of the domain in the Y direction |
| maxY | docs | Double | the end point of the domain in the Y direction |
| minZ | docs | Double | the start point of the domain in the Z direction |
| maxZ | docs | Double | the end point of the domain in the Z direction |
| importVelocity | docs | Bool | import velocity components (3 columns) |
| importVelocityDispersion | docs | Bool | import velocity dispersion (spherically symmetric) |
| importCurrentMass | docs | Bool | import current mass |
| importBias | docs | Bool | import a per-particle/cell source bias weight |
| useColumns | docs | String | a list of names corresponding to columns in the file to be imported |
| sourceWeight | docs | Double | the weight of this source for the number of photon packets launched |
| wavelengthBias | docs | Double | the fraction of photon packet wavelengths sampled from a bias distribution |
| Compound Property | | Type | Base Class | | Description |
| sedFamily | docs | Item | SEDFamily | subclasses | the SED family for assigning spectra to the imported sources |
| wavelengthBiasDistribution | docs | Item | WavelengthDistribution | subclasses | the bias distribution for sampling photon packet wavelengths |
-VoronoiMeshSpatialGrid
[docs] : a Voronoi tessellation-based spatial grid
| Scalar Property | | Type | Description |
| minX | docs | Double | the start point of the box in the X direction |
| maxX | docs | Double | the end point of the box in the X direction |
| minY | docs | Double | the start point of the box in the Y direction |
| maxY | docs | Double | the end point of the box in the Y direction |
| minZ | docs | Double | the start point of the box in the Z direction |
| maxZ | docs | Double | the end point of the box in the Z direction |
| policy | docs | Enum | the policy for determining the positions of the sites |
| | --> Uniform | random from uniform distribution |
| | --> CentralPeak | random from distribution with a steep central peak |
| | --> DustDensity | random from dust density distribution |
| | --> ElectronDensity | random from electron density distribution |
| | --> GasDensity | random from gas density distribution |
| | --> File | loaded from text column data file |
| | --> ImportedSites | positions of particles, sites or cells in imported distribution |
| | --> ImportedMesh | employ imported Voronoi mesh in medium system |
| numSites | docs | Int | the number of random sites (or cells in the grid) |
| filename | docs | String | the name of the file containing the site positions |
| relaxSites | docs | Bool | perform site relaxation to avoid overly elongated cells |
-WeingartnerDraineDustMix
[docs] : a Weingartner and Draine (2001) dust mix
| Scalar Property | | Type | Description |
| environment | docs | Enum | the environment determining the dust model |
| | --> MilkyWay | the Milky Way |
| | --> LMC | the Large Magellanic Cloud |
| | --> SMC | the Small Magellanic Cloud |
| numSilicateSizes | docs | Int | the number of silicate grain size bins |
| numGraphiteSizes | docs | Int | the number of graphite grain size bins |
| numPAHSizes | docs | Int | the number of neutral and ionized PAH size bins (each) |
-XRayAtomicGasMix
[docs] : A gas mix supporting photo-absorption and fluorescence for X-ray wavelengths
| Scalar Property | | Type | Description |
| abundancies | docs | DoubleList | the abundancies for the elements with atomic number Z = 1,...,30 |
| temperature | docs | Double | the temperature of the gas or zero to disable thermal dispersion |
| scatterBoundElectrons | docs | Enum | implementation of scattering by bound electrons |
| | --> None | ignore bound electrons |
| | --> Free | use free-electron Compton scattering |
| | --> FreeWithPolarization | use free-electron Compton scattering with support for polarization |
| | --> Good | use smooth Rayleigh scattering and exact bound-Compton scattering |
| | --> Exact | use anomalous Rayleigh scattering and exact bound-Compton scattering |
-ZubkoDustMix
[docs] : a Zubko et al. (2004) dust mix
| Scalar Property | | Type | Description |
| numSilicateSizes | docs | Int | the number of silicate grain size bins |
| numGraphiteSizes | docs | Int | the number of graphite grain size bins |
| numPAHSizes | docs | Int | the number of neutral and ionized PAH size bins (each) |
-ZubkoGraphiteGrainSizeDistribution
[docs] : a Zubko, Dwek & Arendt size distribution for graphite dust grains
-ZubkoPAHGrainSizeDistribution
[docs] : a Zubko, Dwek & Arendt size distribution for PAH molecules
-ZubkoSilicateGrainSizeDistribution
[docs] : a Zubko, Dwek & Arendt size distribution for silicate dust grains