Welcome to the GSFC Exoplanet Modeling and Analysis Center (EMAC)
EMAC serves as a catalog, repository and integration platform for modeling and analysis resources focused on the study of exoplanet characteristics and environments. EMAC is a key project of the GSFC Sellers Exoplanet Environments Collaboration (SEEC).
If you've used EMAC in any part of your research, please cite our RNAAS paper either in your methods section or in the "Software used" portion of any manuscripts; see the FAQ for more information.
More Information on EMAC for first-time visitors...
If you make use of tools linked or hosted on EMAC: please use the following statement in your publication acknowledgements: “This research made use of the NASA Exoplanet Modeling and Analysis Center (EMAC), which is funded by the NASA Planetary Science Division's Internal Scientist Funding Model.”
Stay up to date with EMAC!
- Subscribe to our monthly RSS messages on new updates and tools.
- Check out the Bluesky account @exoplanetmodels.bsky.social (not an official NASA account), where new tools and features are highlighted.
Help us improve EMAC!
-
Email us with general feedback at
and tell us what you'd change or improve.
- Click the icon in a resource box to provide suggestions for an individual tool or tools.
Other EMAC info!
- EMAC is intended as a clearinghouse for the whole research community interested in exoplanets, where any software or model developer can submit their tool/model or their model output as a contribution for others to use.
- EMAC provides a searchable and sortable database for available source code and data output files - both resources hosted locally by EMAC as well as existing external tools and repositories hosted elsewhere.
- The EMAC team also helps develop new web interfaces for tools that can be run “on-demand” or model grids that can be interpolated for more individualized results.
- If you would like to submit a new tool/model to EMAC, please visit our Submit a Resource page.
- For help with tutorials for select resources/tools use the “Demo” buttons below and subscribe to our YouTube channel.
- Watch this video for a walk-through of the whole EMAC site, including how to submit a new tool and how to access information for each resource.
The P.I. is Avi Mandell, and the Deputy P.I. is Eric Lopez; more information on EMAC staffing and organization can be found on Our Team page.
EMAC has launched a new community-supported curator program, and we need your help! Check out our
curator page to learn how exoplanet experts like yourself can support EMAC's mission, and help us spread the word about this new initiative!
ODUSSEAS is an automatic computational tool able to quickly and reliably derive the Teff and [Fe/H] of M dwarfs using optical spectra obtained by different spectrographs with different resolutions.
It is based on the measurement of the pseudo equivalent widths for more than 4000 stellar absorption lines and on the use of the machine learning Python package “scikit-learn” for predicting the stellar parameters.
It is able to derive parameters accurately and with high precision, having precision errors of ~30 K for Teff and ~0.04 dex for [Fe/H]. The results are consistent for spectra with resolutions of between 48000 and 115000 and a signal-to-noise ratio above 20.
Code Language(s): Python3
Last updated: Sep. 24, 2024
The Time Series Helper & Integration Reduction Tool tshirt is a general-purpose tool for time series science. Its main application is to process raw data on exoplanet systems. tshirt can:
- Reduce raw data: flat field, bias subtract, gain correct, etc. This has been demonstrated to work with merged CCD images from Mont4K imager on the Kuiper-61 inch on Mt Bigelow, AZ.
- Extract Photometry
- Extract Spectroscopy
Code Language(s): Python3
Last updated: Sep. 18, 2024
This is a grid of one-dimensional, hydrostatic, plane-parallel and spherical LTE model atmospheres. These may be used together with atomic and molecular spectral line data and software for radiative transfer to generate synthetic stellar spectra.
The MARCS site contains about 52,000 stellar atmospheric models of spectral types F, G, K, and M in 3 different formats and also flux sample files indicating rough surface fluxes.
Code Language(s): N/A
Last updated: Sep. 18, 2024
IGRINS_transit is a pipeline to take high-resolution observations of transiting exoplanets with Gemini-S/IGRINS and produce cross-correlation detections of molecules in the exoplanet's atmosphere.
Code Language(s): Python3
Last updated: Sep. 6, 2024
Version: v1.0
NEMESISPY is a Python package developed for atmospheric retrievals, which is the inference of atmospheric properties such as chemical composition using spectroscopic data. The package contains code for radiative transfer calculation using the correlated-k approximation and for parametric atmospheric modelling. NEMESISPY is a recent and active development of the well-established Fortran NEMESIS library (Irwin et al., 2008), which has been applied to the atmospheric retrievals of both solar system planets and exoplanets employing numerous different observing geometries.
Code Language(s): Python
Last updated: Sep. 5, 2024
A One-Class Support Vector Machine (SVM) model designed to detect exoplanet transit events. One-Class SVMs can be fitted to data up to 84 times faster than simple CNNs and make predictions over 3 times faster on the same datasets using the same hardware. In addition, One-Class SVMs can be run smoothly on unspecialized hardware, removing the need for Graphics Processing Unit (GPU) usage. In cases where time and processing power are valuable resources, One-Class SVMs are able to minimize time spent on transit detection tasks while maximizing performance and efficiency.
Code Language(s): Python3
Last updated: Aug. 16, 2024
ExoTR (Exoplanetary Transmission Retrieval) is a Bayesian inverse retrieval algorithm to interpret exoplanetary transmission spectra.
The code can be used in two ways:
- leveraging the physics forward model only to generate synthetic planetary atmospheric transmission spectra (including the addition of errorbars);
- using a retrieval routine based on nested sampling (i.e. MultiNest) to extract physical and chemical information from the input transmission spectra.
Code Language(s): Python3
Last updated: Aug. 16, 2024
A new method for fitting exoplanet orbits to direct astrometric measurements, using nonlinear batch estimation and nonsingular orbital elements. The estimation technique is based on the unscented transform, which approximates probability distributions using finite, deterministic sets of weighted sample points. Furthermore, NEXO uses Gaussian mixtures to account for the strong nonlinearities in the measurement model. As a fitting basis, it uses a set of orbital elements developed specifically for directly observed exoplanets, combining features of the Thiele–Innes constants and the Cohen–Hubbard nonsingular elements.
Code Language(s): Python3, Fortran
Last updated: Aug. 7, 2024
plaNETic is a neural network-based Bayesian internal structure modelling framework for small exoplanets with masses between 0.5 and 15 Mearth, introduced in Egger et al. 2024. The code efficiently computes posteriors of a planet's internal structure based on its observed planetary and stellar parameters. It uses a full grid accept-reject sampling algorithm with neural networks trained on the interior model of the BICEPS code (Haldemann et al. 2024) as a forward model. Furthermore, it allows for different choices in priors concerning the expected abundance of water (formation inside vs. outside of iceline) and the planetary Si/Mg/Fe ratios (stellar vs. iron-enriched vs. free).
Code Language(s): Python3
Last updated: Aug. 7, 2024
AstroNet is a Neural Network for identifying exoplanets in light curve data, implemented in TensorFlow.
It uses the Adam optimization algorithm to minimize the cross-entropy error function over the training set, and augments the training data by applying random horizontal reflections to the light curves during training. It also applies dropout regularization to the fully connected layers, which helps prevent overfitting by randomly “dropping” some of the output neurons from each layer during training to prevent the model from becoming overly reliant on any of its features.
AstroNet uses the Google-Vizier system for black-box optimization to automatically tune its hyper-parameters.
Code Language(s): Python
Last updated: Jul. 22, 2024
The JKTEBOP code calculates model light and radial velocity curves of eclipsing binary star and transiting planetary systems, and adjusts the parameters of the model to fit observed light curve, radial velocity curves, and times of mid-eclipse. It is a development of the original EBOP model by Paul B. Etzel. The fitting is performed using Levenberg-Marquart minimisation, and uncertainties can be obtained from the covariance matrix, bootstrapping simulations, a Monte Carlo algorithm, and residual-permutation simulations. The stars are treated as spheres for the calculation of eclipses, but the ellipsoidal and reflection effects are included. Limb darkening is implemented using the linear, sqr
Code Language(s): FORTRAN
Last updated: Jul. 22, 2024
flatstar is an open-source Python tool for drawing stellar disks as numpy.ndarray objects with scientifically-rigorous limb darkening. Each pixel has an accurate fractional intensity in relation to the total stellar intensity of 1.0. It is ideal for ray-tracing simulations of stars and planetary transits.
Code Language(s): Python3
Last updated: Jul. 22, 2024
A python code to simulate the formation of rocky planets in chemical equilibrium (based on a Gibbs free energy minimisation) and tools for the analysis of the simulated planet. The code includes a database of thermochemical data and a database of stellar abundance patterns.
Code Language(s): Python3
Last updated: Jul. 22, 2024
Radio BErkeley Atmospheric Radiative-transfer (RadioBEAR) is a planetary atmosphere code to calculate the brightness temperature of planetary atmospheres in the meter-to-millimeter wavelength range.
Code Language(s): Python3
Last updated: Jul. 22, 2024
A python package to fit the photometric spectral energy distribution of stars. It uses a Markov chain Monte Carlo approach to determine the errors on the derived parameters.
Speedyfit is a command line tool writen in Python 3 that allows you to search the most common online databases for photometric observations of your target, and fit theoretical atmosphere models to the obtained photometry. Speedyfit can deal with both single and binary stars, and allows for the inclusion of constraints from other sources, as for example atmosphere parameters derived from spectroscopy, distances from GAIA or reddening.
Code Language(s): Python3
Last updated: Jul. 22, 2024
Version: v0.2.4
PyExoCross is designed for postprocessing the huge molecular line lists generated by the ExoMol project and other similar initiatives such as the HITRAN and HITEMP. It generates LTE and non-LTE absorption and emission stick spectra, cross sections, and other properties (partition functions, specific heats, cooling functions, lifetimes, and oscillator strengths) based on molecular line lists. PyExoCross calculates cross sections with four line profiles: Doppler, Gaussian, Lorentzian, and Voigt; a number of options are available for computing Voigt profiles. PyExoCross can convert data format between ExoMol and HITRAN. PyExoCross supports line lists in the ExoMol and HITRAN/HITEMP formats.
Code Language(s): Python3
Last updated: Jul. 22, 2024
ExoMol is a database of molecular line lists that can be used for spectral characterization and simulation, and as input to atmospheric models of exoplanets, brown dwarfs and cool stars, and other models including those for combustion and sunspots.
Code Language(s): N/A
Last updated: Jul. 2, 2024
The data reduction pipeline for the Keck Planet Imager and Characterizer. It is used for processing high resolution spectroscopy data taken with KPIC to study exoplanet atmospheres. Designed to process and calibrate KPIC data to enable spectroscopic model fitting.
Code Language(s): Python
Last updated: Jul. 2, 2024
RTModel is a package for modeling and interpretation of microlensing events. It uses photometric time series collected from ground and/or space telescopes.
The modeling strategy is based on a grid search in the parameter space for single-lens models, whereas a template library for binary-lens models is used including all possible geometries of the source trajectory with respect to the caustics. In addition to this global search, planets are searched where maximal deviations from a Paczynski model occurs.
Code Language(s): C++, Python
Last updated: Jun. 26, 2024
Photochem is a photochemical and climate model of planet's atmospheres. Given inputs, like the stellar UV flux, the atmospheric temperature structure, etc., this code will find the steady-state chemical composition of an atmosphere, or evolve atmospheres through time. The code also contains 1-D climate models.
Code Language(s): Fortran, C, Python
Last updated: Jun. 20, 2024
Version: v0.5.5
breads, or the Broad Repository for Exoplanet Analysis, Detection, and Spectroscopy, is a flexible framework that allows forward modeling of data from moderate to high resolution spectrographs. The philosophy of breads is to have the users choose a data class, a forward model function, and a fitting strategy. Data classes normalize the data format, simplifying reduction across different spectrographs while allowing for specific behaviors of each instrument to also be coded into their own specific class. The forward model (FM) aims to reproduce the data (d) as d = FM + n, where n is the noise.
Code Language(s): Python3
Last updated: Jun. 6, 2024
MOLPOP-CEP is a universal line transfer code that allows the exact calculation of multi-level line emission from a slab with variable physical conditions for any arbitrary atom or molecule for which atomic data exist.
Code Language(s): Fortran 90
Last updated: May. 22, 2024
sunbather performs simulations of escaping planet atmospheres and their transit signatures. The main use of the code is to construct 1D Parker wind profiles using the Python p-winds package, to simulate these with photoionization code Cloudy, and to postprocess the output with a custom radiative transfer module to predict the transmission spectra of exoplanets, for a nearly arbitrary chemical composition.
Code Language(s): Python3
Last updated: May. 22, 2024
This package computes the equilibrium structure of rapidly rotating planets and stars modeled as "polytropes."
Code Language(s): Python3
Last updated: May. 22, 2024
The Sonora Elf Owl Models is a successor to the Sonora Bobcat and Sonora Cholla models. The Sonora Elf Owl model grid includes cloud-free radiative-convective equilibrium model atmospheres with vertical mixing induced disequilibrium chemistry with sub-solar to super-solar atmospheric metallicities and Carbon-to-Oxygen ratio. The atmospheric models have been computed using the open-source radiative-convective equilibrium model PICASO. The model grid samples equilibrium temperatures between 275-2400 K and log(g) between 3.25-5.5. The mixing parameter log(Kzz) has been varied from 2-9 in cgs units. The [M/H] and C/O has been varied between [M/H]=-1.0 to [M/H]=+1.0 and C/O=0.22 to C/O=1.14.
Code Language(s): N/A
Last updated: May. 21, 2024
A python library that serves two purposes: run RADEX directly from python and create model spectra from RADEX outputs.
A number of libraries exist for the first purpose. However, most either launch the RADEX compiled binary as a subprocess or wrap the original code. In the former case, the creating of subprocesses can interfere with many Python multiprocessing methods. In the latter, running multiple models simultanously can be problematic due to the use of F77 common blocks in RADEX.
SpectralRadex uses F2PY to compile a version of RADEX written in modern Fortran, most importantly dropping the use of common blocks. As a result, RADEX models can be run in parallel.
Code Language(s): Python, Fortran
Last updated: May. 21, 2024
An open-source TESS FFI pipeline to access TESS data, produce noise-corrected light curves, and search for planets transiting evolved stars, with an emphasis on detecting planets around subgiant and RGB stars. The giants pipeline produces a one-page PDF summary for each target including the following vetting materials. Built with Lightkurve.
Code Language(s): Python3
Last updated: May. 13, 2024
TLCM is a software package to analyze the light curves of transiting exoplanets.
The code fits the light curves with quadratic limb darkening law, and the limb darkening coefficients can be different for the two objects considered.
Code Language(s): IDL
Last updated: Apr. 23, 2024
Version: 96
OoT (Out-of-Transit) calculates the light curves and radial velocity signals due to a planet orbiting a star. It explicitly models the effects of tides, orbital motion, relativistic beaming, and reflection of the stars light by the planet. The code can also be used to model secondary eclipses.
Code Language(s): Python
Last updated: Apr. 10, 2024
SPCA is an open-source, modular, and automated pipeline for Spitzer Phase Curve Analyses.
Code Language(s): Python3
Last updated: Apr. 10, 2024
Version: 0.3
nuance uses linear models and gaussian processes (using JAX-based tinygp) to simultaneously search for planetary transits while modeling correlated noises (e.g. stellar variability) in a tractable way.
nuance is written for python 3 and can be installed using pip.
Code Language(s): Python3
Last updated: Apr. 10, 2024
Version: 0.6.0
The NASA Exoplanet Archive is an online astronomical exoplanet and stellar catalog and data service that collates and cross-correlates astronomical data and information on exoplanets and their host stars, and provides tools to work with these data. The archive is dedicated to collecting and serving important public data sets involved in the search for and characterization of extrasolar planets and their host stars. These data include stellar parameters (such as positions, magnitudes, and temperatures), exoplanet parameters (such as masses and orbital parameters) and discovery/characterization data (such as published radial velocity curves, photometric light curves, images, and spectra).
Code Language(s): N/A
Last updated: Apr. 10, 2024
This catalog is a working tool providing all the latest detections and data announced by professional astronomers, useful to facilitate progress in exoplanetology. It contains data about objects lighter than 60 Jupiter masses, which are orbiting stars/brown dwarf or are free floating. It also provides databases of planets in binary systems and circumstellar disks.
Code Language(s): N/A
Last updated: Apr. 3, 2024
The exovetter package provide statistical metrics and quick visualizations needed when evaluating a periodic transit found in time domain photometry, such as Kepler and TESS. This code wraps codes used to evaluate TESS, Kepler and K2 transit-like signals in order to remove obvious false positives.
Code Language(s): python
Last updated: Mar. 28, 2024
Version: 0.0.6
The TIKE (Time series Integrated Knowledge Engine) is a new service being offered by STScI to support astronomers working with the time series data archived at MAST, such as data from NASA's TESS, Kepler and K2 missions. This tool is built on the Pangeo deployment of JupyterHub, using Kubernetes in AWS. TIKE is a platform where astronomers can make use of data science utilities, astronomy software, and community software packages to retrieve and analyze data sets without having to download the data to their machines or maintain their own set of python packages.
Code Language(s): Docker, k8s, AWS, Jupyterhub
Last updated: Mar. 27, 2024
Version: 0.12.0
Gollum is a tool for spectral visualization and analysis. It boasts both a programmatic interface and a visual interface that help users analyze stellar and substellar spectra, with support included for a set of precomputed synthetic spectral model grids.
Code Language(s): Python3
Last updated: Mar. 27, 2024
Version: 0.4.1
A simple tool to process near-infrared high-resolution spectra for the atmospheric characterisation of transiting exoplanets. The code remove the stellar and Earth atmosphere spectra and correct for systematics in a data-driven way (e.g. principal component analysis or auto-encoders). It contains a planet atmosphere retrieval (nested sampling algorithm). The code is initially designed to work with telluric-corrected SPIRou transmission spectra, but could be easily adapted to other instruments (e.g. GEMINI-IGRINS, VLT-CRIRES+, ESO-NIRP) and to emission spectroscopy.
Code Language(s): Python3
Last updated: Mar. 26, 2024
V1.0 of CUTE data reduction pipeline.
This software is intented to be fully automated, aimed at producing science-quality output with a single command line with zero user interference for CUTE data. It can be easily used for any single order spectral data in any wavelength without any modification.
Code Language(s): IDL
Last updated: Mar. 26, 2024
The Python line-by-line RADiation model for planetary atmosphereS (PyRADS) is a 1D line-by-line radiation code. The default version is for longwave radiation (no scattering), a version for shortwave radiation (with scattering) is also available on github.
Citation: Koll & Cronin (2018), Proceedings of the National Academy of Sciences, vol. 115, issue 41, pp.10293-10298.
Code Language(s): Python3
Last updated: Mar. 25, 2024
The MAss-Radius DIaGRAm with Sliders (MARDIGRAS) is a visualization tool that allows a simple and easy manipulation of mass-radius relationships (also known as iso-composition curves) with interactive sliders. Each slider controls one of the key parameters of the models implemented in the figure (core mass fraction, envelope mass fraction, equilibrium temperature, etc.).
To run the program, download the repository and run with python (no installation needed):
git clone https://github.com/an0wen/MARDIGRAS
cd MARDIGRAS
python mardigras.py
Code Language(s): Python3
Last updated: Mar. 25, 2024
Version: v0.1
Tidal-chronology standalone tool to estimate the age of massive close-in planetary systems.
This tool is specifically developed for massive close-in planetary systems: Mp > 0.5 Mjup and 0.5 < Mstar/Msun < 1.0.
TATOO currently only works with python3.5.
Code Language(s): Python3
Last updated: Mar. 22, 2024
A gnuplot script for Monte Carlo simulations of disk and stellar tidal torques acting on hot Jupiters.
Details are described in the research paper by René Heller (2018), "Formation of hot Jupiters through Disk Migration and Evolving Stellar Tides", Astronomy & Astrophysics. This gnuplot script was used to generate Figure 3b in this paper.
Code Language(s): gnuplot
Last updated: Mar. 22, 2024
Atmospheric Athena is a code intended to simulate hydrodynamic escape from close-in giant planets in 3D. It uses the Athena hydrodynamics code (v4.1) with a new ionizing radiative transfer implementation based on Krumholz et al, 2007, to self-consistently model photoionization driven winds from the planet. The code is fully compatible with static mesh refinement and MPI parallelization.
Code Language(s): C
Last updated: Mar. 22, 2024
Formerly known as supreme-SPOON, exoTEDRF is an end-to-end pipeline for the reduction of JWST exoplanet time series observations (NIRISS and NIRSpec currently supported, MIRI in development).
Code Language(s): Python3
Last updated: Mar. 22, 2024
A tool to produce empirical 2D point spread functions for JWST NIRISS/SOSS observations. These PSFs are necessary input for the ATOCA extraction algorithm implemented in the STScI calibration pipeline.
Code Language(s): Python3
Last updated: Mar. 22, 2024
Version: v2.1.0
Optool computes dust opacities and scattering matrices, for specific grain sizes or averaged over size distributions. It is derived from OpacityTool (ascl:2104.009) and implements the Distribution of Hollow Spheres (DHS) statistical method to approximate irregular and low porosity grains. Mie theory is available as a limiting case of DHS. It also implements the Tazaki Modified Mean Field Theory (MMF) to treat fractal and highly porous aggregates. The refractive index data for many astronomically relevant materials are compiled into the code, and external refractive index data can be used as well.
Code Language(s): Fortran, Python3
Last updated: Mar. 22, 2024
This is a Python-based population synthesis codebase that uses the Genesis database of planet formation models (Mulders et al. 2020). It consists of independent stages of internal structure and atmopsheric evolution models that can be used to synthesize a population of small exoplanets for comparison with observed domgraphics, e.g., from Kepler. It also offers statistical tools for drawing comparisons with observed distributions and studying occurrence trends. By invoking migration models (e.g., from Genesis), one can explore the occurrence patterns of the speculative water worlds and generate a list of potential targets using GPS.
Code Language(s): Python3
Last updated: Mar. 22, 2024
Version: 1.0
The library CALCEPH accesses binary planetary ephemeris files, including INPOPxx, JPL DExxx, and SPICE ephemeris files. This library, available for the operating system Linux, MacOS and WIndows, provides a C Application Programming Interface (API) and, optionally, Fortran 77/2003, Python 2/3 and octave/Matlab interfaces to be called by the application. These functions provide access to many ephemeris file at the same time for parallel computations.
Code Language(s): C, Fortran, Python, matlab
Last updated: Mar. 22, 2024
BOOTTRAN calculates error bars for Keplerian orbital parameters for both single- and multiple-planet systems. It takes the best-fit parameters and radial velocity data (BJD, velocity, errors) and calculates the error bars from sampling distribution estimated via bootstrapping. It is recommended to be used together with the RVLIN (ascl:1210.031) package, which find best-fit Keplerian orbital parameters.
Code Language(s): IDL
Last updated: Mar. 22, 2024
Posidonius is a N-body code for simulating planetary and/or binary systems which implements the WHFAST/IAS15 integrators (Rein & Tamayo, 2015; Rein & Spiegel, 2015) and the tidal model used in Mercury-T (Bolmont et al. 2015). The bodies in the simulation can be static or follow predefined evolutionary models matching FGKML stars and gaseous planets. The simulations can account for several different effects such as tidal forces, rotational-flattening effects, general relativity corrections, protoplanetary disk, stellar wind. Posidonius has a better spin integration than Mercury-T, it's more than six times faster, it conserves the total angular momentum of the system one order of magnitude.
Code Language(s): Rust
Last updated: Mar. 22, 2024
This toolset includes a difference image analysis pipeline, which employs a delta-function kernel, useful for reducing TESS Full Frame Images. The data extracted using the pipeline for the first two years of TESS imagery is available for inspection at https://filtergraph.com/tess_ffi.
Code Language(s): IDL, Python3
Last updated: Mar. 21, 2024
Open source code for the numerical model IsoFATE: Isotopic Fractionation via ATmospheric Escape. IsoFATE models mass fractionation of planetary atmospheres due to molecular diffusion for H, He, and an arbitrary number of trace species (e.g. D, O). The model includes EUV-driven photoevaporation and core-powered mass loss.
Code Language(s): Python3
Last updated: Mar. 11, 2024
luas (from the Irish word for speed) is a small library aimed at building Gaussian processes (GPs) primarily for two-dimensional data sets. This has particularly useful applications when it comes to joint-fitting spectroscopic transit light curves, as demonstrated in Fortune et al. (2024). By utilising different optimisations - such as using Kronecker product algebra - we can make the application of GPs to 2D data sets which may have dimensions of 100s-1000s along both dimensions possible within a reasonable timeframe. luas can be used with popular inference frameworks such as NumPyro and PyMC for which there are tutorials to help you get started.
Code Language(s): Python3
Last updated: Mar. 11, 2024
Version: v0.0.1
The Habitable Worlds Observatory Preliminary Input Catalog (HPIC) is a list of ~13,000 nearby bright stars that will be potential targets for the Habitable Worlds Observatory in its search for Earth-sized planets around Sun-like stars. It was constructed using the TESS and Gaia DR3 catalogs, and uses an automated pipeline to compile stellar measurements and derived astrophysical properties for all stars.
Code Language(s): N/A
Last updated: Mar. 11, 2024
Version: 1.0
A Python noise model for directly imaging exoplanets with a coronagraph-equipped telescope. The original IDL code for this coronagraph model was developed and published by Tyler Robinson and collaborators (Robinson, Stapelfeldt & Marley 2016). This open-source Python version has been expanded upon in a few key ways, most notably, the Telescope, Planet, and Star objects used for reflected light coronagraph noise modeling can now be used for transmission and emission spectroscopy noise modeling, making this model a general purpose exoplanet noise model for many different types of observations.
Code Language(s): Python3
Last updated: Mar. 11, 2024
Mini-chem is a kinetic chemistry network solver primarily for gas giant atmospheric modelling, pared down from the large chemical networks. This makes use of 'net forward reaction tables', which reduce the number of reactions and species required to be evolved in the ODE solvers significantly. Mini-chem's NCHO network currently consists of only 12 species with 10 reactions, making it a lightweight and easy to couple network to large scale 3D GCM models, or other models of interest (such as 1D or 2D kinetic modelling efforts).
Code Language(s): Fortran
Last updated: Mar. 8, 2024
cortecs is a Python package for compressing opacity files used in radiative transfer. We offer a few different types of compression methods with a range of flexibility, from polynomial to neural networks. We also provide utility functions for working with opacity files, such as chunking and interpolating them onto different grids.
Code Language(s): Python3
Last updated: Mar. 8, 2024
Version: v0.3.1
TRES is a numerical framework for simulating hierarchical triple systems of stars and giant planets (M>0.2 M_Jupiter). It accounts for three-body dynamics, stellar evolution and various interactions. TRES-exo is an extension of the original code (Toonen et al. 2016) specifically designed to simulate giant circumbinary planets and their evolution.
Code Language(s): Python, C
Last updated: Feb. 6, 2024
Spright is a fast Bayesian radius-density-mass relation for small planets. The package allows one to predict planetary masses, densities, and RV semi-amplitudes given the planet's radius or planetary radii given the planet's mass.
The package offers an easy-to-use command line script for people not overly interested in coding and a nearly-as-easy-to-use set of Python classes for those who prefer to code. The command line script can directly create publication-quality plots, and the classes offer a full access to the predicted numerical distributions.
Code Language(s): Python3
Last updated: Jan. 19, 2024
VCAL-SPHERE, for VIP-based Calibration of VLT/SPHERE data, is a versatile pipeline for high-contrast imaging of exoplanets and circumstellar disks. The pipeline covers all steps of data reduction, including raw calibration, pre-processing and post-processing (i.e., modeling and subtraction of the stellar halo), for the IFS, IRDIS-DBI and IRDIS-CI modes (and combinations thereof) of the VLT instrument SPHERE. The three main steps of the reduction correspond to different modules, where the first follows the recommended EsoRex (ascl:1504.003) workflow and associated recipes with occasional inclusion of VIP (ascl:1603.003) routines.
Code Language(s): Python3
Last updated: Jan. 16, 2024
Fast orbit fitting of directly imaged multi-planetary systems. The deconfuser quickly fits orbits to planet detections in 2D images, guarantees that all orbits within a certain tolerance are found, and ranks partitions of detections by planets (decides which assignment of detection-to-planet fits the data best).
Pogorelyuk et al. 2022 describes the deconfusion algorithm and estimates of confusion rates from simulated planetary systems using the deconfuser.
Code Language(s): Python3
Last updated: Jan. 5, 2024
AESTRA (Auto-Encoding STellar Radial-velocity and Activity) is a deep learning method for precise radial velocity measurements in the presence of stellar activity noise. The architecture combines a convolutional radial-velocity estimator and a spectrum auto-encoder called spender. For an in-depth understanding of the spectrum auto-encoder, see Melchior et al. 2023 and Liang et al. 2023.
Code Language(s): Python3
Last updated: Jan. 2, 2024
For warm rocky planets, broadly Venus-like planets, the high temperatures and moderate pressures at the base of their atmospheres may enable thermochemical equilibrium between rock and gas. This links the composition of the surface to that of the observable atmosphere. sai is a repository containing files for the GGchem equilibrium chemistry code, and associated helper functions, which we used to find a boundary in surface pressure-temperature space which simultaneously separates distinct mineralogical regimes and atmospheric regimes, potentially enabling inference of surface mineralogy from spectroscopic observations of the atmosphere (Byrne+23, MNRAS).
Code Language(s): Python3
Last updated: Jan. 2, 2024
VSPEC (Variable Star PhasE Curve) is an exoplanet modeling suite that combines NASA’s
Planetary Spectrum Generator (PSG) with a custom variable star. Originally built to simulate the infrared excess of non-transiting planets, the code supports transit, eclipse, phase curve geometries as well as spots, faculae, flares, granulation, and the transit light source effect. Install it with pip or see the documentation linked below.
Code Language(s): Python3
Last updated: Jan. 2, 2024
Version: 0.3.0
pycrires runs the CRIRES+ recipes of EsoRex. The pipeline organizes the raw data, creates SOF and configuration files, runs the calibration and science recipes, and creates plots of the images and extracted spectra. Additionally, it corrects remaining inaccuracies in the wavelength solution and the spectrum curvature. pycrires also provides dedicated routines for the extraction, calibration, and detection of spatially-resolved objects such as directly imaged planets.
Code Language(s): Python3
Last updated: Dec. 27, 2023
ExPRES (Exoplanetary and Planetary Radio Emission Simulator) is a versatile tool that computes the observation opportunities of planetary radio emissions, based on the radio source beaming patterns and the observer’s location.
The ExPRES code is assuming that auroral radio waves are emitted through the Cyclotron Maser Instability (CMI). This emission mechanism can transfer free energy present in the electron distribution function in the source, into the ambient electromagnetic fluctuation background, thus amplifying waves at a frequency close to the local electron cyclotron frequency, as a resonator.
Code Language(s): IDL, Python3
Last updated: Nov. 27, 2023
Version: 1.2.0
MAGPy-RV models data with Gaussian Process regression and affine invariant Monte Carlo Markov Chain parameter searching. Developed to model intrinsic, quasi-periodic variations induced by the host star in radial velocity (RV) surveys for the detection of exoplanets and the accurate measurements of their orbital parameters and masses, it now includes a variety of kernels and models and can be applied to any time-series analysis. MAGPy-RV includes publication level plotting, efficient posterior extraction, and export-ready LaTeX results tables. It also handles multiple datasets at once and can model offsets and systematics from multiple instruments.
Code Language(s): Python3
Last updated: Nov. 27, 2023
NcorpiON is an N-body software developed for the time-efficient integration of collisional and fragmenting systems of planetesimals or moonlets orbiting a central mass. It features a fragmentation model, based on crater scaling and ejecta models, able to realistically simulate a violent impact.
NcorpiON is designed for the study of accreting or fragmenting disks of planetesimal or moonlets. It detects collisions and computes mutual gravity faster than REBOUND, and unlike other N-body integrators, it can resolve a collision by fragmentation. The fast multipole expansions are implemented up to order six to allow for a high precision in mutual gravity computation.
Code Language(s): C
Last updated: Nov. 27, 2023
PBjam is toolbox for modeling the oscillation spectra of solar-like oscillators. This involves two main parts: identifying a set of modes of interest, and accurately modeling those modes to measure their frequencies.
Currently, the mode identification is based on fitting the asymptotic relation to the l=2,0 pairs, relying on the cumulative sum of prior knowledge gained from NASA's Kepler mission to inform the fitting process.
Modeling the modes, or 'peakbagging', is done using the HMC sampler from pymc3, which fits a Lorentzian to each of the identified modes, with much fewer priors than during he mode ID process.
Code Language(s): Python3
Last updated: Nov. 17, 2023
Version: 1.0.0
The Data & Analysis Center for Exoplanets (DACE) is a PlanetS web-platform located at the University of Geneva (CH) dedicated to extrasolar planets data visualisation, exchange and analysis. DACE provides the research and education community with an enhanced access to exoplanet data with a suite of statistical tools for data analysis. Published observational data such as high resolution spectra, radial velocities, photometric light curves and high contrast imaging measurements are available online. Planetary systems formation and evolution can be studied as well as their long term dynamical evolution.
Code Language(s): N/A
Last updated: Nov. 9, 2023
tapify is a Python package that implements a suite of multitaper spectral estimation techniques for analyzing time series data. It supports analysis of both evenly and unevenly sampled time series data.
The multitaper statistic was first proposed by Thomson (1982) as a non-parametric estimator of the spectrum of a time series. It is attractive because it tackles the problems of bias and consistency, which makes it an improvement over the classical periodogram for evenly sampled data and the Lomb-Scargle periodogram for uneven sampling. In basic statistical terms, this estimator allows us to confidently look at the properties of a time series in the frequency or Fourier domain.
Code Language(s): Python3
Last updated: Nov. 9, 2023
MADYS (Manifold Age Determination for Young Stars) determines astrophysical parameters (such as age, mass, radius and Teff) of young stellar and substellar objects. The code automatically retrieves and cross-matches photometry from several catalogs, estimates interstellar extinction, and derives parameter estimates for individual objects through isochronal fitting. Harmonizing the heterogeneity of publicly-available isochrone grids, MADYS enables its users to choose amongst >140 grids from >20 models. Its versatility allows for a wide range of scientific applications, ranging from the characterization of directly imaged planets to the study of stellar associations.
Code Language(s): Python3
Last updated: Nov. 9, 2023
This website is designed to optimize resources and facilitate collaboration in follow-up studies of exoplanet candidates. ExoFOP serves as a repository for project and community-gathered data by allowing upload and display of data and derived astrophysical parameters.
Code Language(s): N/A
Last updated: Oct. 26, 2023
pycdata is a module to import datasets from various telescopes/instruments in
pycheops. pycheops is a tool specifically designed to model CHEOPS observations of transits, eclipses and phase curves. While being a genius tool, what it lacks is a facility to model datasets from other telescopes/instruments, even the PSF photometry produced by
PIPE. pycdata can be used to import datasets from PIPE, TESS and Kepler/K2 in pycheops thus enabling a joint lightcurve analysis of PIPE, TESS, Kepler/K2 data along with CHEOPS data in pycheops.
Code Language(s): Python3
Last updated: Oct. 24, 2023
Version: 1.3.0
ExoMDN is a machine-learning-based exoplanet interior inference model using Mixture Density Networks. The model is trained on more than 5.6 million synthetic planet interior structures.
Given mass, radius, and equilibrium temperature, ExoMDN is capable of providing a full inference of the interior structure of low-mass exoplanets in under a second without the need for a dedicated interior model.
Code Language(s): Python3
Last updated: Oct. 19, 2023
A static, refactored version of Exo_Transmit (
Kempton et al. 2017,
Teal et al. 2022,
Corrales et al. 2023) for computing exoplanet transmission spectra with the new tholin species. This code uses optical constants from tholins grown in the laboratory and computed cross-sections (Mie) for a wide range of particle sizes, for wavelengths of 0.13-10 micron.
Code Language(s): C
Last updated: Oct. 17, 2023
PCM_LBL is a 1D radiative-convective code designed to simulate the climates of diverse planetary atmospheres, from present-day Earth to early Mars and exoplanets. The code is written in modular modern Fortran and uses a 'brute-force' spectral approach where absorption coefficients are computed on a fixed spectral grid directly from line data. This allows climate calculations to be performed more simply and at higher accuracy than in a correlated-k approach.
Code Language(s): Fortran 90
Last updated: Oct. 17, 2023
Version: 1.0
This module replicates some features of the GEOCLIM model, originally written in Fortran, but now in Julia to make them easier to use.
The module implements these formulations to estimate global silicate weathering rates from gridded climatology, typically taken from the results of a global climate model like CCSM or FOAM. It is intended to estimate weathering during periods of Earth history when the continental configuration was radically different, typically more than 100 million years ago. For more information about the original GEOCLIM, see the Methods/Supplement of Goddéris et al.
Code Language(s): Julia
Last updated: Oct. 17, 2023
Version: 0.1.14
photoevolver is a Python module that evolves the gaseous envelope of planets backwards and forward in time, taking into account internal structure and cooling rate, atmospheric mass loss processes, and the stellar X-ray emission history.
Code Language(s): Python3, C
Last updated: Oct. 13, 2023
Version: 2.0
The smart is a Markov Chain Monte Carlo (MCMC) forward-modeling framework for spectroscopic data, currently working for high-resolution spectrometers including Keck/NIRSPEC, SDSS/APOGEE, Gemini/IGRINS, Lick/HPF, Keck/HIRES and medium-resolution spectrometers including Keck/OSIRIS and Keck/NIRES.
For NIRSPEC users, required adjustments need to be made before reducing private data using NIRSPEC-Data-Reduction-Pipeline(NSDRP), to perform telluric wavelength calibrations, and to forward model spectral data. The code is currently being developed.
Code Language(s): Python3
Last updated: Sep. 29, 2023
Version: 1.0
CROCODILE provides the statistical framework to interpret the three main observables of directly-imaged exoplanetary atmospheres, namely photometry, low-resolution spectroscopy, and medium (and higher) resolution cross-correlation spectroscopy. These will be measured by the next generation of instruments such as ERIS at the Very Large Telescope, MIRI aboard the James Webb Space Telescope, and METIS at the future Extremely Large Telescope.
Code Language(s): Python
Last updated: Aug. 2, 2023
Mister plotter (mr-plotter) is a user-friendly Python tool that creates paper-ready mass-radius diagrams with your favorite theoretical models. It also includes the ability to color-code diagrams based on any published stellar or planetary property collected in the NASA Exoplanet Archive.
Code Language(s): Python3
Last updated: Jul. 5, 2023
Version: 1
MAGIC is a machine learning framework to efficiently and accurately infer the microlensing parameters of binary events with realistic data quality. In MAGIC, binary microlensing parameters are divided into two groups and inferred separately with different neural networks. The key feature of MAGIC is the introduction of neural controlled differential equation, which provides the capability to handle light curves with irregular sampling and large data gaps. MAGIC is able to locate degenerate solutions in real events even when large data gaps are introduced. As irregular samplings are common in astronomical surveys, it also has implications to other studies that involve time series.
Code Language(s): Python3
Last updated: Jun. 15, 2023
SWAMPE is a Python package for modeling the dynamics of exoplanetary atmospheres. SWAMPE is an intermediate-complexity, two-dimensional shallow-water general circulation model. Benchmarked for synchronously rotating hot Jupiters and sub-Neptunes, the code is modular and could be easily modified to model dissimilar space objects, from Brown Dwarfs to terrestrial, potentially habitable exoplanets. SWAMPE can be easily run on a personal laptop.
Code Language(s): Python
Last updated: Jun. 6, 2023
Version: 1.0.0
Bioverse is a quantitative framework for assessing the diagnostic power of a statistical exoplanet survey. It combines Gaia-based stellar samples with Kepler-derived exoplanet demographics and a mission simulator that enables exploration of a variety of observing, follow-up, and characterization strategies.
Uniquely, Bioverse contains a versatile module for population-level hypothesis testing supporting trade studies and survey optimization. It currently supports direct imaging or transit missions, but its modularity makes it adaptable to any mission concept that makes measurements on a sample of exoplanets.
Code Language(s): Python3
Last updated: Jun. 5, 2023
Version: 1.1.1
Latest version of TS (Turbospectrum), with NLTE capabilities.
Computation of stellar spectra (flux and intensities) in 1D or average <3D> stellar atmosphere models.
In order to compute NLTE stellar spectra, additional data is needed, downloadable outside GitHub.
See documentation in DOC folder
Python wrappers are available at
https://github.com/EkaterinaSe/TurboSpectrum-Wrapper/ and
https://github.com/JGerbs13/TSFitPy
They allow interpolation between models and fitting of spectra to derive stellar parameters.
Code Language(s): Fortran, Python3
Last updated: Jun. 5, 2023
Applefy calculates detection limits for exoplanet high contrast imaging (HCI) datasets. The package provides a number of features and functionalities to improve the accuracy and robustness of contrast curve calculations. Applefy implements the classical approach based on the t-test as well as the parametric boostrap test for non-Gaussian residual noise. Written in Python, it computes contrast curves and contrast grids.
Code Language(s): Python
Last updated: May. 26, 2023
Tiberius is a Python library for reducing time series spectra and fitting exoplanet transit light curves. This can be used to extract spectra from JWST (all 4 instruments), along with ground-based long-slit spectrographs and Keck/NIRSPEC echelle spectra (beta).
The light curve fitting routines can be used as as standalone to fit, for example, HST light curves extracted with other methods.
Code Language(s): Python
Last updated: May. 22, 2023
Version: 0.1.0
The "light-curve" project is a toolbox for analyzing irregular time-series data, consisting of two components: a feature extractor and a dm-dt mapper. Feature extraction is available as Rust and Python libraries, including various feature extractors like magnitude statistics, shape-based features, Lomb-Scargle periodogram peaks, and parametric fits. The dm-dt mapper represents observation pairs as 2-D points based on magnitude and time differences, available in the same Python library, the Rust library, and a binary executable for generating PNG images.
Code Language(s): Python, Rust
Last updated: May. 4, 2023
This model of geological carbon fluxes leverages widely used geochemical codes of solid-melt equilibria for silicate rocks (MELTS) and of equilibria and kinetics of water-rock interactions (PHREEQC). Coupled with a simple numerical computation of global thermal evolution, this model enables investigation of the effects of planet size (mass) and bulk, surface, and upper mantle composition on carbon cycling through geologic time. Its applicable size range (0.5 to 2 Earth masses) is limited by the fidelity of the geodynamic model. The applicable range of compositions is limited by those that can be handled by MELTS and PHREEQC.
Code Language(s): C
Last updated: Feb. 27, 2023
The MATRIX ToolKit has been specially designed to establish detection limits of photometry data sets by performing robust injection-and-recovery analyses on a three dimensional grid of scenarios (orbital period vs planetary radius vs transit epoch). This kind of scientific detection threshold determination can now be done with a simple python command with the significant addition of taking into account different transit epochs, which helps to establish a more reliable detection rate for a given period and radius.
Code Language(s): Python3
Last updated: Feb. 17, 2023
WATSON (Visual Vetting and Analysis of Transits from Space ObservatioNs is a lightweight software package that enables a comfortable visual vetting of a transiting signal candidate from Kepler, K2 and TESS missions. WATSON looks for transit-like signals that could be generated by other sources or instrument artifacts. The code runs simplified tests on scenarios including:
- Transit shape model fit
- Odd-even transits checks
- Centroids shifts
- Optical ghost effects
- Transit source offsets
- and more...
With these data, we compute metrics to alert scientists about problematic signals.
Code Language(s): Python3
Last updated: Feb. 17, 2023
PEPITA is a Python package that allows making predictions for the precision of exoplanet parameters using transit light-curves, without the need of performing a fit to the data. Behind scenes, it makes use of the Information Analysis techniques to predict the best precision that can be obtained by fitting a light-curve without actually needing to perform the fit.
Code Language(s): Python3
Last updated: Feb. 14, 2023
Version: 0.0.1
PyMieScatt is a comprehensive forward and inverse Mie theory solver for Python 3. This package calculates relevant parameters such as absorption, scattering, extinction, asymmetry, backscatter, and more. It also contains single-line functions to calculate optical coefficients (in Mm-1) of ensembles of particles in lognormal (with single or multiple modes) or custom size distributions.
The inverse calculations retrieve the complex refractive index from laboratory measurements of scattering and absorption (or backscatter), useful for studying atmospheric organic aerosol of unknown composition.
Read more in
our JQSRT paper!
Code Language(s): Python3
Last updated: Feb. 7, 2023
Version: 1.8
SHERLOCK is an end-to-end pipeline that allows the users to explore the data from space-based missions to search for planetary candidates. It can be used to recover alerted candidates by the automatic pipelines such as SPOC and the QLP, the so-called Kepler objects of interest (KOIs) and TESS objects of interest (TOIs), and to search for candidates that remain unnoticed due to detection thresholds, lack of data exploration or poor photometric quality.
Code Language(s): Python3
Last updated: Jan. 18, 2023
Here we present PACMAN, an end-to-end pipeline developed to reduce and analyze HST/WFC3 data. The pipeline includes both spectral extraction and light curve fitting. The foundation of PACMAN has been already used in numerous publications (e.g., Kreidberg et al., 2014; Kreidberg et al., 2018) and these papers have already accumulated hundreds of citations.
Code Language(s): Python3
Last updated: Dec. 27, 2022
Code Language(s): fortran
Last updated: Dec. 15, 2022
Version: v1
We present SpecMatch-Empirical, a tool for measuring the fundamental properties of stars from their spectra by comparing them against an empirical spectral library of FGKM stars. The spectral library comprises high-resolution, high signal-to-noise observed spectra from Keck/HIRES for 404 touchstone stars with well-determined stellar parameters derived from interferometry, asteroseismology, and spectrophotometry. The code achieves accuracies of 100K, 15%, and 0.09 dex in Teff, Rstar, and [Fe/H] respectively for FGKM dwarfs.
Code Language(s): Python3
Last updated: Dec. 9, 2022
Astroquery is a collection of tools for requesting data from databases hosted on remote servers with interfaces exposed on the internet, including those with web pages but without formal application program interfaces. These tools are built on the Python requests package, which is used to make HTTP requests, and astropy, which provides most of the data parsing functionality. Astroquery modules generally attempt to replicate the web page interface provided by a given service as closely as possible, making the transition from browser-based to command-line interaction easy. Astroquery enables the creation of fully reproducible workflows from data acquisition through publication.
Code Language(s): Python3
Last updated: Dec. 7, 2022
The spaceKLIP pipeline enables to reduce & analyze JWST NIRCam & MIRI coronagraphy data. It provides functions to run the official jwst stage 1 and 2 data reduction pipelines with several modifications that were made to improve the quality of high-contrast imaging reductions. It then performs PSF subtraction based on the KLIP algorithm as implemented in the widely used pyKLIP package, outputs contrast curves, and enables forward model PSF fitting for any detected companions in order to extract their properties (offset and flux). The pipeline is still under heavy development.
Code Language(s): Python3
Last updated: Dec. 7, 2022
Butterpy is a Python-based tool for simulating star spot emergence, evolution, and decay as well as stellar rotational light curves. It is adapted from the physically motivated model used by Aigrain et al. (2015, MNRAS, 450, 3211) to test the recovery of stellar rotation periods using different frequency analysis techniques. Butterpy allows the user to simulate light curves of stars with variable activity level, rotation period, spot lifetime, magnetic cycle duration and overlap, spot emergence latitudes, and latitudinal differential rotation shear.
The name Butterpy is a portmanteau of "butterfly" (like the solar butterfly diagram) and "Python."
Code Language(s): Python 3
Last updated: Nov. 30, 2022
Kiauhoku is a Python package for interacting with, interpolating, and fitting stellar evolutionary tracks to observational data. It includes popular stellar model grids like MIST, Dartmouth, and GARSTEC, as well as a few custom YREC grids, with more being added over time.
From Hawaiian:
1. vt. To sense the span of a star's existence (i.e., its age).
2. n. The speed of a star (in this case, its rotational speed).
This name was created in partnership with Dr. Larry Kimura and Bruce Torres Fischer, a student participant in A Hua He Inoa, a program to bring Hawaiian naming practices to new astronomical discoveries. We are grateful for their collaboration.
Code Language(s): Python 3
Last updated: Nov. 30, 2022
The rfast tool is an ultra-quick planetary spectrum simulator and remote sensing tool, originally designed for rapid retrieval explorations for mission concept studies. Through a convenient runscript, users can generate a noise-free spectrum of a planetary environment, add instrumental noise, and perform inverse modeling. The rfast tool is capable of applications to simulated and real observations spanning reflected-light, thermal emission, and transit transmission.
Code Language(s): Python
Last updated: Nov. 21, 2022
Molecfit is a tool to correct for telluric absorption lines based on synthetic modelling of the Earth’s atmospheric transmission. It can be used with data obtained with various ground-based telescopes and instruments. It combines a publicly available radiative transfer code, a molecular line database, atmospheric profiles, and various kernels to model the instrument LSF. The atmospheric profiles are created by merging a standard atmospheric profile representative of a given observatory’s climate, of local meteorological data, and of dynamically retrieved altitude profiles for temperature, pressure, and humidity.
Code Language(s): C, ESO Common Pipeline Library (CPL), Python
Last updated: Nov. 18, 2022
PYSHELLSPEC is an astrophysical tool for modeling of binary systems with circumstellar matter (e.g. accretion disk, jet, shell), computation of interferometric observables |V2|, arg T3, |T3|, |dV|, arg dV, comparison of light curves, spectro-interferometry, spectra, and SED with observations, and both global and local optimisation of system parameters. It is based on Shellspec, a long-characteristic LTE radiation transfer code by Budaj & Richards (2004).
Code Language(s): Python3, Fortran
Last updated: Nov. 17, 2022
AnalyticLC is an accurate photometry, radial velocity, and astrometry modeling tool. It is based on a fourth-order expansion of the Disturbing Function, incorporating 3D orbital dynamics. The analytic approach of AnalyticLC elucidates the relation between orbital dynamics and observable quantities. In addition, it offers advantages for analyzing observations with a long time span, a scenario becoming increasingly common in this era of multiple space missions. AnalyticLC has been used to interpret Kepler data and obtain estimates of more than a hundred exoplanets' physical and orbital properties.
Code Language(s): Matlab
Last updated: Nov. 14, 2022
Explicitly including Keplerian dynamics in the transit search allows Optimal BLS to enhance transit detectability while allowing such searches to be done with much-reduced resources and time. By using the (standard) BLS, one is either fairly insensitive to long-period planets or less sensitive to short-period planets and computationally slower by a significant factor of ~330 (for a 3 yr long dataset). Physical system parameters, such as the host star's size and mass, directly affect transit search. This understanding can then be used to optimize the search for every star individually. The code is well-used by the community.
Code Language(s): Matlab, Octave
Last updated: Nov. 14, 2022
Version: 1.0
The Polygon + Segments model allows modeling the light curve of an exoplanet with rings. This high-precision model includes full ring geometry as well as possible ring transparency and the host star’s limb darkening. Additionally, it can model oblate ringless planets as an opaque “ring” (same shape as a planet). pyPplusS is also computationally efficient, requiring just a 1D integration over a small range, making it faster than existing techniques. The algorithm at its core is further generalized to compute the light curve of any set of convex primitive shapes in transit (e.g. multiple planets, oblate planets, moons, rings, combination thereof, etc.) while accounting for their overlaps.
Code Language(s): Python3
Last updated: Nov. 14, 2022
Version: 1.0
Spectroscopy Made Easy (SME) is a software tool that fits an observed spectrum of a star with a model spectrum. Since its initial release in 1996, SME has been a suite of IDL routines that call a dynamically linked library, which is compiled from C++ and Fortran. This classic IDL version of SME is available for download.
In 2018, we began began reimplementing the IDL part of SME in python 3, adopting an object oriented paradigm and continuous integration practices (code repository, build automation, self-testing, frequent builds).
Code Language(s): Python3
Last updated: Oct. 25, 2022
Version: 0.9
ATOCA is used to extract and decontaminate spectroscopic images with multiple sources or diffraction orders. The inputs are, for all orders and sources: the wavelength solutions, the trace profiles, the throughputs and the spectral resolution kernels. From this, ATOCA can model simultaneously the detector and extract the spectra. See
Darveau-Bernier et al. (2022) for more details.
Code Language(s): Python3
Last updated: Oct. 14, 2022
A significant proper motion difference between two catalogues for a given star is a good indication of the presence of a perturbing body. FORECAST allows you to identify the region where a companion compatible with the measured Δμ should appear if the star is directly imaged. It also provides an estimate of the mass of the companion compatible with the astrometric signal at each position in the allowed region. FORECAST maps can be used both to identify and confirm potential direct imaged sub-stellar candidates.
Code Language(s): N/A
Last updated: Oct. 10, 2022
Exo-DMC (Exoplanet Detection Map Calculator) is a Monte Carlo tool for the statistical analysis of exoplanet surveys results. It combines the information on the target stars with the instrument detection limits to estimate the probability of detection of a given synthetic planet population, ultimately generating detection probability maps. The Exo-DMC is the latest (although the first one in Python) rendition of the MESS (Multi-purpose Exoplanet Simulation System). Like MESS, the DMC allows for a high level of flexibility in terms of possible assumptions on the synthetic planet population to be used for the determination of the detection probability.
Code Language(s): python3
Last updated: Oct. 10, 2022
Version: v1.0-alpha
Blasé introduces a powerful new approach to whole-spectrum fitting: clone 10,000+ spectral lines from a precomputed synthetic spectral model template, and then learn the perturbations to those lines through comparison to real data. Each spectral line has 4 parameters, yielding possibly 40,000+ parameters. The technique hinges on the magic of autodiff, the enabling technology behind Machine Learning, to tune all of those parameters precisely and quickly. The tool has conceivable extensions to Doppler imaging, Precision RV's, abundances, and more. It is built in PyTorch, with native GPU support.
Code Language(s): Python, PyTorch
Last updated: Oct. 10, 2022
Version: 0.3
SysSimPyPlots is a Python package for loading, plotting, and otherwise visualizing the simulated catalogs generated from ExoplanetsSysSim, a comprehensive forward modeling framework for studying planetary systems based on the Kepler mission. In particular, it is designed to work with the SysSim clustered planetary system models (
https://github.com/ExoJulia/SysSimExClusters) that characterize the underlying occurrence and intra-system correlations of multi-planet systems.
Code Language(s): Python3
Last updated: Sep. 30, 2022
Version: v1.1.0
SysSimPyMMEN is a Python package for inferring the minimum-mass extrasolar nebula (MMEN), a power-law profile for the minimum mass in disk solids required to form the existing exoplanets if they formed in their present locations. It is designed to work with the SysSim clustered planetary system models (
https://github.com/ExoJulia/SysSimExClusters) that characterize the underlying occurrence and intra-system correlations of multi-planet systems, but can be easily applied to any other planetary system by the user.
Code Language(s): Python3
Last updated: Sep. 30, 2022
Version: v1.0.0
RAPOC (Rosseland and Planck Opacity Converter) is a Python 3 code that calculates Rosseland and Planck mean opacities from wavelength-dependent opacities for a given temperature, pressure, and wavelength range. In addition to being user-friendly and rapid, RAPOC can interpolate between discrete data points, making it flexible and widely applicable to the astrophysical and Earth-sciences fields, as well as in engineering. For the input data, RAPOC can use ExoMol and DACE data, or any user-defined data, provided that it is in a readable format.
Code Language(s): Python3
Last updated: Sep. 30, 2022
Version: 1.0.5
Kamodo allows model developers to represent simulation results as mathematical functions which may be manipulated directly by end users. Kamodo handles unit conversion transparently and supports interactive science discovery through jupyter notebooks with minimal coding and is accessible through python.
Code Language(s): Python3
Last updated: Sep. 26, 2022
Public Fortran 90 code for linear wave and circulation calculations, developed originally for planetary atmospheres, with python scripts provided for data analysis.4 setups are provided:
2D_axi: eigenvector setup in spherical coordinates assuming axisymmetry around the axis of rotation. A longitudinal wavenumber, m, must therefore be provided.
2D_shallow: eigenvector setup for shallow water beta-plane. The latitude of the beta plane and characteristic height can be changed.
3D: eigenvector setup in full 3D, spherical coordinates.
3D_steady: linear circulation setup, hence matrix inversion. A forcing and a dissipation have to be implemented for a linear steady state to exist.
Code Language(s): Fortran
Last updated: Sep. 26, 2022
Tool for creating a Systematics-insensitive Periodogram (SIP) to detect long period rotation in NASA's TESS mission data. Read more in our published Research Note of the
American Astronomical Society. SIP is a method of detrending telescope systematics (the TESS scattered light) simultaneously with calculating a Lomb-Scargle periodogram. This allows us to estimate of the rotation rate of variables with a period of >30days when there are multiple sectors. You can read a more in-depth work of how SIP is used in NASA's Kepler/K2 data
here.
Code Language(s):
Last updated: Sep. 26, 2022
Version: v1.07
IGRINS RV is a python open source pipeline for extracting radial velocities (RVs) from spectra taken with the Immersion GRating INfrared Spectrometer (IGRINS). It uses a modified forward modeling technique that leverages telluric absorption lines as a common-path wavelength calibrator. IGRINS RV achieves an RV precision in the H and K bands of around 25-30 m/s for narrow-line stars, and it has successfully recovered the planet-induced RV signals of both HD 189733 and τ Boo A. Visit Stahl et al. 2021 to see the published paper.
Code Language(s):
Last updated: Sep. 26, 2022
AccretR is a planetary body accretion Monte Carlo code that calculates mass, radius and bulk composition along a specified growth track, for orderly/hierarchical, runaway, and random particle accretion models, optimized for icy ocean worlds in our Solar System (priors can be modified for other systems). Elements in the model include concentrations of: H, C, N, O, Na, Mg, Al, Si, S, Cl, K, Ca, and Fe. Maximal water is also computed, assuming all H goes into forming water. Accretional heat is also calculated.
Code Language(s): R
Last updated: Sep. 26, 2022
Version: 1.0.0 Apricot
FastChem 2 is a new version of the established semi-analytical thermochemical equilibrium code FastChem. Whereas the original version of FastChem is limited to atmospheres containing a significant amount of the element hydrogen, FastChem 2 is now also applicable to chemical mixtures dominated by any other species such as CO2, N2, or Si for example. The code is written in object-oriented C++ and also offers an optional Python module.
Code Language(s): C++, Python3
Last updated: Sep. 26, 2022
Version: 2
Staralt is a program that shows the observability of objects in various ways: either you can plot altitude against time for a particular night (Staralt), or plot the path of your objects across the sky for a particular night (Startrack), or plot how altitude changes over a year (Starobs), or get a table with the best observing date for each object (Starmult).
Code Language(s): PhP, Fortran
Last updated: Sep. 26, 2022
The Exoplanet Atmospheres Database is built for the community and maintained by the community. Exoplanet atmospheres is an exciting and vibrant field of research, where new discoveries and publications occur at a very fast pace, and it is easy to miss many interesting results. The main purpose of this database is to become a quick and useful repository of all available exoplanet atmospheres observations, and also to help in the gathering of useful references for a given planet or planet types.
Code Language(s): php
Last updated: Sep. 26, 2022