ASCL.net

Astrophysics Source Code Library

Making codes discoverable since 1999

Browsing Codes

Results 3801-7600 of 3830 (3726 ASCL, 104 submitted)

Previous12
Next
Order
Title Date
 
Mode
Abstract Compact
Per Page
50100250All
[ascl:2505.001] speclib: Tools for working with stellar spectral libraries

speclib provides a lightweight Python interface for loading, manipulating, and analyzing stellar spectra and model grids. The code can load a spectral grid into memory and linearly interpolate between temperature grid points to generate component spectra. speclib includes utilities for photometric synthesis, spectral resampling, and SED construction using stellar spectral libraries.

[ascl:2505.002] SWIFTGalaxy: Galaxy particle analyzer

SWIFTGalaxy analyzes particles belonging to individual simulated galaxies. The code provides a software abstraction of simulated galaxies produced by the SWIFT smoothed particle hydrodynamics code (ascl:1805.020) and extends the SWIFTSimIO module. SWIFTGalaxy inherits from and extends the functionality of the SWIFTDataset. It understands the output of halo finders and therefore which particles belong to a galaxy and its integrated properties. The particles occupy a coordinate frame that is enforced to be consistent, such that particles loaded on-the-fly will, for example, match rotations and translations of particles already in memory. Intuitive masking of particle datasets is also enabled. Finally, SWIFTGalaxy provides utilities that make working in cylindrical and spherical coordinate systems more convenient.

[ascl:2505.003] pyGCG: Python Grism Classification GUI

pyGCG provides a graphical user interface for viewing and classifying NIRISS-WFSS data products. Though originally designed for use by the GLASS-JWST collaboration, this software has been tested against the data products from the PASSAGE collaboration as well. pyGCG allows users to interactively browse a selection of reduced data products with the option of also writing classifications to a table.

[ascl:2505.004] Eureka!: Data reduction and analysis pipeline for JWST and HST time-series observations

Eureka! reduces and analyzes exoplanet time-series observations; though particularly focused on JWST data, it also handles HST observations. Starting with raw, uncalibrated FITS files, it reduces time-series data to precise exoplanet transmission and emission spectra. The code can perform flat-fielding, unit conversion, background subtraction, and optimal spectral extraction. It can generate a time series of 1D spectra for spectroscopic observations and a single light curve of flux versus time for photometric observations. Eureka! can also fit light curves with noise and astrophysical models using different optimization or sampling algorithms and is able to display the planet spectrum in figure and table form.

[ascl:2505.005] NumPyro: Probabilistic programming with NumPy

The lightweight probabilistic programming library NumPyro provides a NumPy backend for Pyro (ascl:2110.016). It relies on JAX for automatic differentiation and JIT compilation to GPU/CPU. The code focuses on providing a flexible substrate for users to build on, including Pyro Primitives, inference algorithms with a particular focus on MCMC algorithms such as Hamiltonian Monte Carlo, and distribution classes, constraints and bijective transforms. NumPyro also provides effect-handlers that can be extended to implement custom inference algorithms and inference utilities.

[ascl:2505.006] jnkepler: Differentiable N-body model for multi-planet systems

jnkepler models photometric and radial velocity data of multi-planet systems via N-body integration. Built with JAX, it leverages automatic differentiation for efficient computation of model gradients. This enables seamless integration with gradient-based optimizers and Hamiltonian Monte Carlo methods, including the No-U-Turn Sampler (NUTS) in NumPyro (ascl:2505.005). jnkepler is particularly suited for efficiently sampling from multi-planet posteriors involving a larger number of parameters and strong degeneracy.

[ascl:2505.007] Jitter: RV jitter prediction code

Jitter predicts radial-velocity (RV) jitter due to stellar oscillations and granulation, in terms of various sets of fundamental stellar properties. The code can also be used to set a prior for the jitter term as a component when modeling the Keplerian orbits of the exoplanets.

[ascl:2505.008] Aeolus: Object-oriented analysis of atmospheric model output

The Aeolus library, written in Python, analyzes and plots climate model output using modules to work with 3D general circulation models of planetary atmospheres. The code provides various functions tailored to exoplanet research, e.g., in the context of tidally-locked exoplanets. Generic (planet-independent constants) and basic constants of the Earth atmosphere are also provided. Aeolus can store model-specific variable and coordinate names in one container, which can be passed to various functions, and can also calculate the synthetic transmission spectrum.

[ascl:2505.009] BEM: Random forest for exoplanets

BEM predicts the radius of exoplanets based on their planetary and stellar parameters. The code uses the random forests machine learning algorithm to derive reliable radii, especially for planets between 4 R⊕ and 20 R⊕ for which the error is under 25%. BEM computes error bars for the radius predictions and can also create diagnostic plots.

[ascl:2505.010] Exo-MerCat: Exoplanet Merged Catalog with Virtual Observatory connection

Exo-MerCat generates a catalog of known and candidate exoplanets, collecting and selecting the most precise measurement for all interesting planetary and orbital parameters contained in exoplanet databases. It retrieves a common name for the planet target, linking its host star name with the preferred identifier in the most well-known stellar databases, and accounts for the presence of multiple aliases for the same target. The code standardizes the output and notation differences and homogenizes the data in a VO-aware way. Exo-MerCat also provides a graphical user interface to filter data based on the user's constraints and generate automatic plots that are commonly used in the exoplanetary community.

[ascl:2505.011] eclipsoid: Transit models for ellipsoidal planets in Jax

Eclipsoid provides a general framework allowing rotational deformation to be modeled in transits, occultations, phase curves, transmission spectra and more of bodies in orbit around each other, such as an exoplanet orbiting a host star. It is an extension of jaxoplanet (ascl:2504.028).

[ascl:2505.012] ExoLyn: Multi-species cloud modeling in atmospheric retrieval

The 1D cloud model code ExoLyn solves the transport equation of cloud particles and vapor under cloud condensation rates that are self-consistently calculated from thermodynamics. It can be combined with optool (ascl:2104.010) to calculate solid opacities and with petitRADTRANS (ascl:2207.014) to generate transmission or emission spectra. The code balances physical consistency with computational efficiency, opening the possibility of joint retrieval of exoplanets' gas and cloud components. ExoLyn has been designed to study cloud formation across a variety of planets, such as hot Jupiters, sub-Neptunes, and self-luminous planets.

[ascl:2505.013] tBilby: Transdimensional inference for gravitational-wave astronomy with Bilby

tBilby is a trans-dimensional Bayesian inference tool based on the Bilby (ascl:1901.011) inference package. It provides tools and examples to facilitate trans-dimensional Bayesian inference and offers a high degree of flexibility in constructing models and defining priors. tBilby seeks to further develop trans-dimensional Bayesian inference.

[ascl:2505.014] afterglowpy: Compute and fit GRB afterglows

afterglowpy models Gamma-ray burst afterglows. It computes synchrotron radiation from an external shock and is capable of handling both structured jets and off-axis observers. The code provides fully trans-relativistic shock evolution through a constant density medium, on-the-fly integration over the equal-observer-time slices of the shock surface, and includes an approximate prescription for jet spreading. afterglowpy has been calibrated to the BoxFit code (ascl:2306.059) and produces similar light curves for top hat jets (within 50% when same parameters are used) both on- and off-axis.

[ascl:2505.015] CETRA: Cambridge Exoplanet Transit Recovery Algorithm

CETRA (Cambridge Exoplanet Transit Recovery Algorithm) detects transit by performing a linear transit search followed by a phase-folding of the former into a periodic signal search, using a physically motivated transit model to improve detection sensitivity. Implemented with NVIDIA’s CUDA platform, the code outperforms traditional methods like Box Least Squares and Transit Least Squares in both sensitivity and speed. It can also be used to identify transits that aren't periodic in the input light curve. CETRA is designed to be run on detrended light curves.

[ascl:2505.016] iSLAT: Interactive Spectral-Line Analysis Tool

iSLAT (the interactive Spectral-Line Analysis Tool) provides an interactive interface for the visualization, exploration, and analysis of molecular spectra. Synthetic spectra are made using a simple slab model; the code uses molecular data from HITRAN. iSLAT has been tested on spectra at infrared wavelengths as observed at different resolving powers (R = 700-90,000) with JWST-MIRI, Spitzer-IRS, VLT-CRIRES, and IRTF-ISHELL.

[ascl:2505.017] TD-CARMA: Estimates of gravitational lens time delays with flexible CARMA processes

TD-CARMA estimates cosmological time delays to model observed and irregularly sampled light curves as realizations of a continuous auto-regressive moving average (CARMA) process using MultiNest (ascl:1109.006) for Bayesian inference. TD-CARMA accounts for heteroskedastic measurement errors and microlensing, an additional source of independent extrinsic long-term variability in the source brightness.

[ascl:2505.018] SCATTERING: Solve the coupled equations for a given scattering system

The SCATTERING code solves the coupled equations for a given scattering system, provides the scattering S-matrix elements, and calculates the state-to-state cross-sections. Its approach is different from codes such as MOLSCAT (ascl:1206.004) or Hibridon (ascl:2505.020), as SCATTERING solves coupled equations in the body-fixed (BF) frame, where the coupling matrix exhibits a predominantly block-diagonal structure with blocks interconnected by centrifugal terms. This significantly reduces computational time and memory requirements.

[ascl:2505.019] AIRI: Algorithms for computational imaging

The AIRI (AI for Regularization in radio-interferometric Imaging) algorithms are Plug-and-Play (PnP) algorithms propelled by learned regularization denoisers and endowed with robust convergence guarantees. The (unconstrained) AIRI algorithm is built on a Forward-Backward optimization algorithmic backbone enabling handling soft data-fidelity terms. AIRI's primary application is to solve large-scale high-resolution high-dynamic range inverse problems for RI in radio astronomy, more specifically 2D planar monochromatic intensity imaging.

[ascl:2505.020] Hibridon: Time-independent non-reactive quantum scattering calculations

Hibridon solves the close-coupled equations which occur in the quantum treatment of inelastic atomic and molecular collisions. Gas-phase scattering, photodissociation, collisions of atoms and/or molecules with flat surfaces, and bound states of weakly-bound complexes can be treated.

[ascl:2506.001] CTD: Cumulative Time Dilation

Cumulative Time Dilation (CTD) calculates and plots the total time dilation experienced by a point (Earth) located at the center of a spherical mass-energy distribution. There are both analytical and numerical solutions for two different descriptions of how gravity acts across cosmological distances. The calculations are done for universes filled with a single energy type (dark energy; matter, including dark matter; or radiation) as well as the concordance model.

[ascl:2506.002] MAGIC: Automatic analysis of realistic microlensing light curves

The MAGIC (Microlensing Analysis Guided by Intelligent Computation) PyTorch framework efficiently and accurately infers the microlensing parameters of binary events with realistic data quality. The code divides binary microlensing parameters into two groups, which are inferred separately with different neural networks. The neural controlled differential equation handles light curves with irregular sampling and large data gaps. MAGIC can achieve fractional uncertainties of a few percent on the binary mass ratio and separation, and can locate the degenerate solutions even when large data gaps are introduced. As irregular samplings are common in astronomical surveys, this code may be useful for other time series studies.

[ascl:2506.003] SMART: Forward-modeling framework for spectroscopic data

SMART (Spectral Modeling Analysis and RV Tool) forward models spectral data. The method works best in those spectral orders with both strong telluric absorption features for accurate wavelength calibration and sufficient structure in the stellar spectrum to distinguish it from the telluric absorption. The code uses Markov Chain Monte Carlo (MCMC) methods to determine stellar parameters such as effective temperature, surface gravity, and rotational velocity, and calibration factors, including continuum and wavelength corrections, instrumental line-spread function (LSF), and strength of telluric absorption. SMART has been used with Keck/NIRSPEC, SDSS/APOGEE, Gemini/IGRINS high-resolution near-infrared spectrometers, among others, and with medium-resolution spectrometers, including Keck/OSIRIS and Keck/NIRES

[ascl:2506.004] TESS-cont: TESS contamination tool

TESS-cont quantifies the flux fraction coming from nearby stars in the TESS photometric aperture of any observed target. The package identifies the main contaminant Gaia DR2/DR3 sources, quantifies their individual and total flux contributions to the aperture, and determines whether any of these stars could be the origin of the observed transit and variability signals. Written in Python, TESS-cont is based on building the pixel response functions (PRFs) of nearby Gaia sources and computing their flux distributions across the TESS Target Pixel Files (TPFs) or Full Frame Images (FFIs).

[ascl:2506.005] VBMicrolensing: Microlensing computations for single, binary, and multiple lenses

VBMicrolensing performs efficient computation in gravitational microlensing events using the advanced contour integration method, supporting single, binary and multiple lenses. It calculates magnification by single, binary and multiple lenses, centroid of the images generated by single and binary lenses, and critical curves and caustics of binary and multiple lenses. It also computes complete light curves including several higher order effects, such as limb darkening of the source, binary source, parallax, xallarap, and circular and elliptic orbital motion.

VBMicrolensing is written as a C++ library and wrapped as a Python package; the code can be called from either C++ or Python. This package encompasses VBBinaryLensing (ascl:1809.004), which is at the basis of several platforms for microlensing modeling. VBBinaryLensing will still be available as a legacy software, but will no longer be maintained.

[ascl:2506.006] Gen TSO: Graphical interface to simulate JWST exoplanet time-series observations

Gen TSO estimates signal-to-noise ratios for transit/eclipse depths through an interactive graphical interface, similar to the JWST Exposure Time Calculator (ETC). This interface leverages the ETC by combining its noise simulator, Pandeia, with additional exoplanet resources from the NASA Exoplanet Archive, the Gaia DR3 catalog, and the TrExoLiSTS database of JWST programs. Gen TSO calculates S/Ns for all JWST instruments for the spectroscopic time-series modes available as of the Cycle 4 GO call. It also simulates target acquisition on the science targets or, when needed, on nearby stellar targets.

[ascl:2506.007] excalibuhr: High-resolution spectral data reduction

The excalibuhr end-to-end pipeline extracts high-resolution spectra designed for VLT/CRIRES+. The package preprocesses raw calibration files, including darks, flats, and lamp frames, and can trace spectral orders on 2D detector images. It applies calibrations to science frames, can remove the sky background by nodding subtraction, and combines frames per nodding position. excalibuhr can also extract 1D spectrum and perform wavelength and flux calibration.

[ascl:2506.008] DART-Vetter: Convolutional Neural Network to distinguish planetary transits from false positives

DART-Vetter distinguishes planetary candidates from false positives detected in any transiting survey, and is tailored for photometric data collected from space-based missions. The Convolutional Neural Network is trained on Kepler and TESS Threshold Crossing Events (TCEs), and processes only light curves folded on the period of the relative signal. DART-Vetter has a simple and compact architecture; it is lightweight enough to be executed on personal laptops.

[ascl:2506.009] GRIP: Generic data Reduction for nulling Interferometry Package

GRIP (Generic data Reduction for nulling Interferometry Package) reduces nulling data with enhanced statistical self-calibration methods from any nulling interferometric instrument within a single and consistent framework. The toolbox self-calibrates null depth measurements by fitting a model of the instrumental perturbations to histograms of data. The model is generated using a simulator of the instrument built into the package for the main operating nullers or provided by the user. GRIP handles baseline discrimination and spectral dispersion and features several optimizing strategy, including least squares, maximum likelihood, and MCMC with emcee (ascl:1303.002), and works on GPU using the cupy library.

[ascl:2506.010] easyCHEM: Chemical abundances in exoplanet atmospheres calculator

easyCHEM calculates chemical equilibrium abundances (including condensation) and adiabatic gradients by minimization of the so-called Gibbs free energy. Ancillary outputs are the atmospheric adiabatic temperature gradient and mean molar mass. Because easyCHEM incorporates the dgesv routine from LAPACK (ascl:2104.020) for fast matrix inversion,external math libraries are not required.

Previous12
Next

Would you like to view a random code?