![]() |
SMILE
v2.5
Schwarzschild Modelling Interactive expLoratory Environment
|
| ►Nsmile | Common namespace for all core SMILE classes, functions and variables |
| CCAngMomOrbitFilteringFnc | Orbit filtering function that evaluates the z-component of angular momentum of an orbit |
| CCBasicICGenerator | Base class for creating initial conditions for orbit library |
| CCBasicInformation | Parent class for data container objects used to store various data and exchange it between objects |
| CCBasicIOSnapshot | The abstract class implementing reading and writing snapshots; derived classes take the filename as the argument of the constructor |
| CCBasicOdeIntegrator | Basic class for numerical integrators of ODE system |
| CCBasicOrbitFilteringFnc | Parent class for orbit filtering functions which evaluate whether an orbit should be used (in some calculation) |
| CCBasicOrbitRuntimeFnc | Defines a routine which may be called after each integration timestep to perform user-specific data collection |
| CCBasicOrbitRuntimeFncCreator | Defines a basic class that creates some sort of runtime function for any orbit in the orbit library |
| CCBasicQuadraticOptimizationSolver | The interface class for various third-party quadratic optimization solvers |
| CCBasicSchwData | Base class for Schwarzschild Data objects |
| CCBasicSchwModel | Base class for Schwarzschild Modelling driver objects |
| CCBasicShellSchwData | Base class for storing kinematic information on a radial grid |
| CCBasicSpectrumAnalyzer | Basic class for various methods of spectral analysis |
| CCBinnedMassRefinementFnc | A mass refinement function is used to create an Nbody snapshot with unequal mass particles |
| CCCentrophilicOrbitFilteringFnc | Orbit filtering function that selects centrophilic orbits |
| CCChaosOrbitFilteringFnc | Orbit filtering function that evaluates chaotic properties of an orbit, based on threshold in frequency diffusion rate and in Lyapunov exponent value, multiplied by some predefined factor |
| CCConfigCore | Common configuration parameters for various tasks in CSmileCore |
| CCConfigFile | Utility class for handling an INI file |
| CCConfigOrbit | General parameters for orbit integration and classification |
| CCConfigPotential | Structure that contains parameters for all possible potentials |
| CCDensity | Base class defining density model (without corresponding potential) |
| CCDensityEllipsoidal | Ellipsoidal model |
| CCDensityExpDisk | Exponential disk with several variants of vertical profile and spiral structure |
| CCDensityIsochrone | Isochrone density profile, triaxial |
| ►CCDensityMGE | Multi-Gaussian expansion of a triaxial density profile |
| CCGaussian | Defines one component of the multi-gaussian expansion |
| CCDensityNFW | Modified Navarro-Frenk-White density profile, triaxial |
| CCDensityPerfectEllipsoid | Triaxial Perfect Ellipsoid density profile |
| CCDensityPlummer | Plummer density profile, triaxial |
| CCDensitySersic | Sersic profile, triaxial |
| CCEnergyOrbitFilteringFnc | Example of evaluation function for multimass Nbody models, which sorts orbits in total energy |
| CCFileInputText | Class for reading data from a text file, possibly accompanied by binary files for the orbit library |
| CCFileOutputText | Class for writing data to a text file, possibly accompanied by binary files for the orbit library |
| CCICGeneratorDensityEllipsoidal | Sample point coordinates using ellipsoidal equidensity surface approximation; this method is generally inferior to CICGeneratorDensitySampler |
| CCICGeneratorDensitySampler | Sample points coordinates proportionally to local density, no velocities assigned |
| CCICGeneratorDensitySpherical | Sample points from a spherical mass model |
| CCICGeneratorPrincipalPlane | Initial conditions from principal-plane start space |
| CCICGeneratorRandomE | Initial conditions from random start space at given energy |
| CCICGeneratorSchw | Class that combines two samplers – for positions and velocities |
| CCICGeneratorStationary | Initial conditions from stationary start space |
| CCICGeneratorVelocityEddington | Sample velocities from the Eddington distribution function for equivalent spherical system |
| CCICGeneratorVelocityJeansAxi | Sample velocities from Jeans equation for an axisymmetric system |
| CCICGeneratorVelocityJeansSph | Sample velocities from the spherical Jeans equation |
| CCICGeneratorYalpha | Initial conditions from Y-alpha start space |
| CCIOSnapshotGadget | GADGET snapshot format; needs UNSIO library |
| CCIOSnapshotNemo | NEMO snapshot format |
| CCIOSnapshotText | Text file with three coordinates, possibly three velocities and mass, space or tab-separated |
| CCMassModel | Class defining a spherical mass model |
| CCMassModelAxisymmetric | Class for representing an axisymmetric density model |
| CCMassModelAxisymmetricJeans | An extension of axisymmetric model which uses anisotropic Jeans equations to compute velocity dispersions in cylindrical coordinates |
| CCMatrix | Interface for matrix storage |
| CCMatrixBasicSchwModel | Matrix interface class that passes the linear matrix elements from Schwarzschild model object to the solver |
| CCMatrixDense | Matrix interface class that actually holds the entire matrix and returns its elements |
| CCMatrixDiagonal | Matrix interface class that provides a diagonal matrix |
| CCNbodyExportStatWorker | Worker object that calculates statistics after Nbody export (currently, computes virial ratio) |
| CCNemoSnapshotWriter | Helper class that writes NEMO-compatible snapshot file |
| CCOdeIntegratorDOP853 | 8th order Runge-Kutta integrator from Hairer,Norsett&Wanner |
| CCOdeIntegratorHermite | Hermite integrator that uses information about force derivatives (jerk) in a 4th-order predictor-corrector scheme with only two force evaluations per timestep |
| CCOdeIntegratorIAS15 | 15-th order implicit Runge-Kutta scheme from Rein & Spiegel, 2014, MNRAS (adapted from Rebound) |
| CCOdeIntegratorLeapfrog | Low-order leapfrog method provided for treecode, which has discontinuous potential/forces and is poorly handled by Runge-Kutta integrator |
| CCOdeIntegratorOdeint | A template class for integrators based on the boost::numeric::odeint library |
| CCOdeSystem | Basic class of ODE system used in the orbit integrator |
| CCOptimizationSolverBPMPD | Interface to the standalone program BPMPD |
| CCOptimizationSolverCVXOPT | Interface to the LP/QP solver CVXOPT written in Python |
| CCOptimizationSolverGLPK | Interface to the linear optimization solver GLPK |
| CCOrbit | Class for performing a single orbit integration |
| CCOrbitDesc | Container for orbit initial conditions and information objects |
| CCOrbitInformation | Information object containing orbit analysis results |
| CCOrbitIntWorker | Worker object that runs single orbit integration in a separate thread |
| CCOrbitLauncher | An utility class that keeps all necessary data to start orbit integration |
| CCOrbitLibrary | The collection of orbits |
| CCOrbitLibWorker | Worker object that runs orbit library integration (for use in multiple parallel threads) |
| CCOrbitRuntimePericenter | Class for recording pericenter passages and analyzing their distribution to figure out if the orbit is centrophilic or not |
| CCOrbitRuntimePericenterCreator | Corresponding creator class for the pericenter analysis runtime function |
| CCOrbitRuntimePoincare | Compute the Poincare surface of section for an orbit |
| CCOrbitRuntimePoincareCreator | Corresponding creator class for Poincare timestep fnc |
| CCOrbitRuntimeSchwAngMomDist | Runtime function recording binned angular momentum distribution |
| CCOrbitRuntimeSchwAngMomDistCreator | Corresponding creator class for angular momentum Schw runtime function |
| CCOrbitRuntimeSchwDensGrid | Runtime function corresponding to classic 3d-grid Schwarzschild density data object |
| CCOrbitRuntimeSchwDensGridCreator | Corresponding creator class for classic Schw runtime function |
| CCOrbitRuntimeSchwDensSH | Runtime function corresponding to Schwatzschild density data object based on spherical-harmonic expansion of potential coefficients at radial grid points or for some radial basis functions (serves both variants) |
| CCOrbitRuntimeSchwDensSHCreator | Corresponding creator class for SH Schw runtime function |
| CCOrbitRuntimeSchwKinemShell | Runtime function recording shell-based kinematic data (time spent in each shell and radial/tangential velocity dispersion in a shell) |
| CCOrbitRuntimeSchwKinemShellCreator | Corresponding creator class for shell-kinematic Schw runtime function |
| CCOrbitRuntimeTrajectory | Class for recording orbit trajectory and doing various analysis (frequency, Lyapunov exponent, etc) |
| CCOrbitRuntimeTrajectoryCreator | Corresponding creator class for Trajectory analysis timestep fnc |
| CCOrbitRuntimeTrajSample | Trajectory sampler (record a given number of unsorted points from the trajectory, to be used in creating an Nbody model from the Schwarzschild model) |
| CCOrbitRuntimeTrajSampleCreator | Corresponding creator class for trajectory sampler |
| CCOrbitRuntimeVelPerturber | Class for applying random perturbations on velocity during orbit integration, mimicking the effect of two-body relaxation |
| CCOrbitRuntimeVelPerturberCreator | Corresponding creator class for the velocity perturber runtime function |
| CCOutputHookQProcess | Helper class to capture diagnostic and progress messages from running BPMPD process, and redirect them to the main SMILE program via my_message() |
| CCPericenterInformation | Information object for pericenter data (distribution of angular momentum at pericenter passages) |
| CCPoincareInformation | Information object to store points from the Poincare surface of section |
| CCPointMassSet | An array of particles with positions, velocities and masses |
| CCPointMassSetHandler | A helper object for computing the virial ratio for a set of point masses |
| CCPosPoint | Data-only class containing 3 coordinates |
| CCPosVelPoint | Data-only class containing 3 coordinates and 3 velocities |
| CCPotential | Base class for potential-density model including potential derivatives (=forces) |
| CCPotentialAxisymmetrized | A helper class for representing axisymmetrized versions of the given potential and/or density model |
| CCPotentialBSE | Basis-set expansion on the Zhao(1996) basis set (alpha models) |
| CCPotentialBSECompact | Basis-set expansion using spherical Bessel functions (e.g.Allen et al.1990) |
| CCPotentialComposite | A composite potential which consists of several other potential types, plus a possible black hole and a rotating reference frame |
| CCPotentialCylSpline | Angular expansion of potential in azimuthal angle with coefficients being 2d spline functions of R,z |
| CCPotentialDehnen | Dehnen(1993) double power-law model |
| CCPotentialDirect | Direct computation of potential for any density profile, using double integration over space |
| CCPotentialFerrers | Ferrers density profile (with finite size R and density (1-(r/R)^2)^2) |
| CCPotentialHarmonic | Potential of a constant-density (harmonic) core with different frequencies of oscillations in three directions |
| CCPotentialLog | Logarithmic potential, with possible core |
| CCPotentialMiyamotoNagai | Miyamoto-Nagai axisymmetric potential; equivalent to Plummer if A=0 |
| ►CCPotentialNB | Frozen N-body potential calculated by tree-code algorithm (based on hackcode1.c) |
| Ccell | CELL: structure used to represent internal nodes of tree |
| Cnode | NODE: data common to BODY and CELL structures |
| CCPotentialScaleFree | Simple power-law potential/density pair: rho ~ r^-gamma |
| CCPotentialScaleFreeSH | Angular expansion of scale-free potential in spherical harmonics |
| CCPotentialSH | Parent class for all potential expansions based on spherical harmonics for angular variables |
| CCPotentialSpherical | Spherically-symmetric arbitrary density profile potential provided by CMassModel |
| CCPotentialSpline | Spherical-harmonic expansion of potential with coefficients being spline functions of radius |
| CCRadiusMassRefinementFnc | Another mass refinement function that aims to reduce the average mass of particles inside a given radius |
| CCSchwarzschildWorker | Worker object that runs Schwarzschild model optimization solver |
| CCSchwDataAngMomDist | Schwarzschild data object to manage kinematic data in the form of binned angular momentum distribution as a function of energy |
| CCSchwDataBasicDens | Base class for density data objects |
| CCSchwDataDensGrid | Base class for Schwarzschild data objects with grid-based density model |
| CCSchwDataDensGridClassic | Schwarzschild data object for the classic grid-based density model |
| CCSchwDataDensGridCylindrical | Schwarzschild data object for the grid-based density model in cylindrical geometry |
| CCSchwDataDensSH | Base class for variants of Schwarzschild density data objects based on spherical-harmonic expansion of density of both target model and orbits |
| CCSchwDataDensSHBSE | Variant of Schwarzschild density data object based on basis-set expansion in terms of Zhao(1995) basis set for density of both required profile and of orbits |
| CCSchwDataDensSHMesh | Variant of Schwarzschild density data object based on spherical-harmonic expansion of potential coefficients at radial mesh points |
| CCSchwDataKinemShell | Schwarzschild data object to handle (rudimentary) kinematic data, in the form of radial and tangential velocity dispersions in a number of radial shells |
| CCSchwInformation | Information object that keeps density data for all variants of Schwarzschild data objects |
| CCSchwModelQuadOpt | The class for performing Schwarzschild modelling of density and kinematic data from the theoretical point of view (without "observational errors") |
| CCShellOrbitFilteringFnc | Orbit filtering function based on whether an orbit belongs to a given energy shell |
| CCSmileConsole | The console version of application is implemented in this class |
| CCSmileCore | Class that provides all core computational functionality |
| CCSmileGUI | The main GUI window class |
| CCSpectralLine | Definition of one spectral line in one-dimensional time series (nothing to do with spectroscopy!:) |
| CCSpectrumAnalyzerHunter | Spectrum analysis based on Hunter's DFT method |
| CCSplineApprox | Penalized linear least-square fitting problem |
| CCTrajSampleInformation | Information object keeping a trajectory sample (to generate an N-body model from a Schwarzschild model) |
| CCTriangle | Defines a triangle with indexed vertices referring to points from the trajectory |
| CCTriangThread | Helper thread that performs Delaunay triangulation with the help of external program 'qdelaunay' |
| CCVelPerturberInformation | Information object for velocity perturber class (keep track of accumulated energy change due to relaxation) |
| CQwtPlotPicker2 | Helper class for displaying coordinates on a 2d plot picker with scientific numeric format string |
| CQwtPlotZoomer2 | Helper class for displaying coordinates on a 2d plot zoomer with scientific numeric format string |
| CStringVariant | Simple string-based variant implementation that allows the user to easily convert between simple numeric/string types |
| Csmilepot | Defines a wrapper class that is used in constructing NEMO potential and acceleration objects from a SMILE potential that is specified by parameters in an ini file, or by a potential coefficients file |
1.8.8
