What’s new?¶
This page gives some of the key improvements in each galpy
version. See the HISTORY.txt
file in the galpy source for full
details on what is new and different in each version.
v1.10¶
Version 1.10 is a largely incremental update to version 1.9, with a few new features, bug fixes, and small improvememts to the documentation. The major new additions are:
Added
KuzminLikeWrapperPotential
, a potential wrapper that allows one to make a Kuzmin-like or Miyamoto-Nagai-like potential out of any spherical or axisymmetric potential (evaluated in the plane, i.e., treated as a spherical potential). Kuzmin-like potentials are obtained by replacing the spherical radius r with \(\sqrt{R^2 + (a + |z|^2)}\), while Miyamoto-Nagai-like potentials are obtained by replacing the spherical radius with \(\sqrt{R^2 + (a + \sqrt{z^2 + b^2})^2}\). The standard KuzminDiskPotential and MiyamotoNagaiPotential are obtained by applying this procedure to a point-mass potential and the Kuzmin/Miyamoto-Nagai-like potentials generalize this to any spherical potential.Allow vector inputs of solar parameters to Orbit initialization:
ro
,zo
,vo
, andsolarmotion
. Useful when sampling over the uncertainty in the solar parameters.Increased support for using OpenMP with clang and, in particular, added OpenMP support in the released Mac wheels.
Converted all docstrings to numpy-style format with the help of GitHub Copilot.
v1.9¶
Version 1.9 contains two major new additions since version 1.8, a bunch of small updates and bug fixes, and a few deprecations. The major new additions are:
Specialized support for calculating and displaying surfaces of section for orbits. Surfaces of section for 3D and 2D potentials can now be computed using a dedicated integration technique
Orbit.SOS
or using a brute-force techniqueOrbit.bruteSOS
(for orbits for which te dedicated technique fails, e.g., orbits in a rotating frame). There is also support for directly plotting surfaces of section inOrbit.plotSOS
andOrbit.plotBruteSOS
. See Surfaces of section for more info.There is now general support for action-angle and reverse action-angle transformations for 1D potentials using the
galpy.actionAngle.actionAngleVertical
andgalpy.actionAngle.actionAngleVerticalInverse
classes. The inverse transformation is computing using a robust variation of the torus-mapper.
Important deprecations are:
galpy.util.bovy_coords
,galpy.util.bovy_plot
, andgalpy.util.bovy_conversion
have now been removed in favor of theirbovy_
lacking versions.phiforce
and associated Potential methods and functions have been removed in favor ofphitorque
and associated methods and functions.
Other user-facing improvements and additions are:
Potential classes, methods, and functions:
Made the potential input explicitly positional-only for all
galpy.potential
functions to avoid errors when specifying it as a keyword argument.Added general support for DissipativeForce instances in 2D.
Implemented NonInertialFrameForce in 2D.
Allow potentials’ density and surface density to be plotted on physical axes.
New and improved
Orbit
methods:Added
Orbit.animate3d
to display a 3D animation of an integrated orbit with an optional Milky-Way representation at the origin when plotting x,y,z.Improved the performance of Orbit.animate performance by using webgl, some UI tweaks. Also fixed using Orbit.animate in jupyterlab and retrolab.
Improvements to spherical distribution functions:
Made it possible to use an interpSphericalPotential as the potential in spherical distribution functions.
Added a method,
dMdE
, to calculate the differential energy distribution of spherical distribution functions.
v1.8¶
Version 1.8 contains two big new features and a variety of smaller improvements described below. In addition to this, version 1.8 is also the first version to fully drop Python 2.7 support (and, thus, all Python 2 support; note that Python 2 was already almost not supported before). Version 1.8 also represents the start of a new release cycle, in which we will attempt to release a new major version 1.x every year around July 1 and have two minor version releases at roughly four-month intervals in between (so around November 1 and March 1). Major releases will include this overview of what’s new since the last major version release.
Major new features:
galpy
now allows for a very general set of fictitious forces that arise when working in a non-inertial reference frame through the new potential class NonInertialFrameForce. The main driver for this new addition is to include the effect of the Milky Way’s barycenter acceleration due to the effect of the Large Magellanic Cloud on the orbits of stars, satellite galaxies, and star clusters in the Milky Way. How this can be done exactly is explained in the Example: Including the Milky Way center’s barycentric acceleration due to the Large Magellanic Cloud in orbit integrations section. But a much more general set of non-inertial reference frames are supported: any combination of barycenter acceleration and arbitrary rotations. See Orbit integration in non-inertial frames for some more info.A particle-spray technique for generating mock stellar streams has been added as galpy.df.streamspraydf. This roughly follows the Fardal et al. (2015) implementation, with some notable additions (e.g., the ability to generate a stream around the center of an orbiting satellite). The full
galpy
implementation is described in Qian et al. (2022).
Other user-facing improvements and additions are
Potential classes, methods, and functions:
Renamed
phiforce
–>phitorque
everywhere (includingpotential.evaluatephiforces
andpotential.evaluateplanarphiforces
), such that the method’s name actually reflect what it returns (a torque, not a force).phiforce
will be fully removed in version 1.9 and may later be re-used for the actual phi component of the force, so switch to the new name now.Added
SCFPotential.from_density
to directly initialize anSCFPotential
based on a density function. Allows for full correct and consistent handling of Quantity inputs and outputs.Added
TimeDependentAmplitudeWrapperPotential
for adding arbitrary time-dependence to the amplitude of any Potential/Force.Added
NullPotential
, a Potential with a constant value (useful, e.g.. to adjust the zero point of a potential, or for testing code in the absence of forces).Added Potential methods/functions
rE
andLcE
to compute the radius and angular momentum of an orbit with energy E. Also added these as Orbit methods for efficient calculation for collections of orbits.Added the
offset=
keyword toRotateAndTiltWrapperPotential
, which allows a Potential/Force instance to also be offset from (0,0,0) in addition to being rotated or tilted.
New and improved
Orbit
methods:Added a progress bar when integrating multiple objects in a single orbit instance (requires
tqdm
).Added
rE
andLcE
for the efficient computation of the radius and angular momentum of an orbit with energy E (this is efficient for many orbits in a singleOrbit
instance; see above).Updated existing and added new phase-space positions for MW satellite galaxies from Pace et al. (2022).
Updated existing and added new phase-space positions for MW globular clusters from Baumgardt et al. (2019), Vasiliev & Baumgardt (2021), and Baumgardt & Vasiliev (2021).
Allow actions to be computed for Orbit instances with actionAngle methods that don’t compute frequencies.
Updated spherical distribution functions:
Added necessary derivatives to allow spherical DFs to be constructed using PowerSphericalPotentialwCutoff and PlummerPotential.
Finally, galpy
can now also be compiled to WebAssembly using the
emscripten
compiler, as part of the pyodide
project. This allows for
galpy
use in the browser without installation at near-C speeds. See
Using galpy in web applications for more info. This, for example, powers the new “Try
galpy
” interactive session on this documentation’s home page.
v1.7¶
Version 1.7 adds many new features, mainly in the galpy.potential
and
galpy.df
modules. The biggest new additions are:
A general framework for spherical distribution functions defined using \(f(E,L)\) models. Specifically, general solutions for (a) isotropic \(f(E)\) models, (b) \(f(E,L)\) models with constant anisotropy \(\beta\), and (c) \(f(E,L)\) models with Osipkov-Merritt-type anisotropy are implemented for any potential/density pair (not necessarily self-consistent). These distribution functions can be evaluated, sampled exactly, and any moment of the distribution function can be calculated. Documentation of this is currently available at Spherical distribution functions. Distribution functions with constant anisotropy require the JAX.
In addition to the general solution, the distribution function of a few well-known distribution functions was added, including (a) Hernquist distribution functions that are isotropic, have constant anisotropy, or have Osipkov-Merritt type anisotropy; (b) an isotropic Plummer profile; (c) the isotropic NFW profile (either using the approx. from Widrow 2000 or using an improved approximation) and the Osipkov-Merritt NFW profile (new approximate form); (d) the King model (also added as a potential as KingPotential).
Other new additions include:
New or improved potentials and potential wrappers:
interpSphericalPotential: general class to build interpolated versions of spherical potentials.
AdiabaticContractionWrapperPotential: wrapper potential to adiabatically contract a spherical dark-matter halo in response to the adiabatic growth of a baryonic component.
TriaxialGaussianPotential: potential of a Gaussian stratified on triaxial ellipsoids (Emsellem et al. 1994).
PowerTriaxialPotential: potential of a triaxial power-law density (like
PowerSphericalPotential
, but triaxial).AnyAxisymmetricRazorThinDiskPotential: potential of an arbitrary razor-thin axisymmetric disk (not in C, mainly useful for rotation-curve modeling).
AnySphericalPotential: potential of an arbitrary spherical density distribution (not in C, mainly useful for rotation-curve modeling).
RotateAndTiltWrapperPotential: wrapper potential to re-orient a potential arbitrarily in three dimensions.
Other changes to Potential classes, methods, and functions:
Functions to compute the SCF density/potential expansion coefficients based on an N-body representation of the density (scf_compute_coeffs_spherical_nbody, scf_compute_coeffs_axi_nbody, and scf_compute_coeffs_nbody).
An NFWPotential can now be initialized using
rmax/vmax
, the radius and value of the maximum circular velocity.Potential functions and methods to compute the zero-velocity curve:
zvc
andzvc_range
. The latter computes the range in R over which the zero-velocity curve is defined, the former gives the positive z position on the zero-velocity curve for a given radius in this range.rhalf
Potential function/method for computing the half-mass radius.tdyn
Potential function/method for computing the dynamical time using the average density.Potential.mass
now always returns the mass within a spherical shell if only one argument is given. Implemented faster versions of many mass implementations using Gauss’ theorem (including SCFPotential and DiskSCFPotential).Mixed azimuthal,vertical 2nd derivatives for all non-axisymmetric potentials in function
evaluatephizderivs
and methodphizderiv
. Now all second derivatives in cylindrical coordinates are implemented.Function/method
plotSurfaceDensities/plotSurfaceDensity
for plotting, you’ll never guess, the surface density of a potential.Re-implementation of
DoubleExponentialDiskPotential
using the double-exponential formula for integrating Bessel functions, resulting in a simpler, more accurate, and more stable implementation. This potential is now accurate to ~machine precision.Potentials are now as much as possible numerically stable at
r=0
andr=inf
, meaning that they can be evaluated there.
Other additions and changes include:
Added the inverse action-angle transformations for the isochrone potential (in actionAngleIsochroneInverse) and for the one-dimensional harmonic oscillator (in actionAngleHarmonicInverse). Also added the action-angle calculation for the harmonic oscillator in actionAngleHarmonic. Why yes, I have been playing around with the TorusMapper a bit!
Renamed
galpy.util.bovy_coords
togalpy.util.coords
,galpy.util.bovy_conversion
togalpy.util.conversion
, andgalpy.util.bovy_plot
togalpy.util.plot
(but oldfrom galpy.util import bovy_X
will keep working for now). Also renamed some other internal utility modules in the same way (bovy_symplecticode
,bovy_quadpack
, andbovy_ars
; these are not kept backwards-compatible). Trying to make the code a bit less egotistical!Support for Python 3.9.
v1.6¶
This version mainly consists of changes to the internal functioning of
galpy
; some of the new outward-facing features are:
ChandrasekharDynamicalFrictionForce is now implemented in C, leading to 100x to 1000x speed-ups for orbit integrations using dynamical friction compared to the prior pure-Python version.
New potentials:
HomogeneousSpherePotential: the potential of a constant density sphere out to some radius R.
DehnenSphericalPotential: the Dehnen Spherical Potential from Dehnen (1993).
DehnenCoreSphericalPotential: the Dehnen Spherical Potential from (Dehnen 1993) with alpha=0 (corresponding to an inner core).
Some notable internal changes:
Fixed a bug in how
DiskSCFPotential
instances are passed to C for orbit integration that in particular affected theMcMillan17
Milky-Way potential (any hole in the surface density was effectively ignored in the C code in v1.5).The performance of orbit animations is significantly improved.
All main galpy C extensions are now compiled into a single shared-object library
libgalpy
.Binary wheels are now automatically built for Windows, Mac, and most major Linux distributions upon every push to the
master
(nowmain
) branch and these are automatically uploaded to PyPI upon release. See the Installation Instructions for more info. Binary wheels on Windows are also built for every push on AppVeyor, see the Windows installation instructions.
v1.5¶
This version will be the last to support Python 2.7 as this version of Python is reaching end-of-life on January 1 2020.
This version’s highlight is a fully re-written implementation of
galpy.orbit.Orbit
such that it can now contain and manipulate multiple objects at once.galpy.orbit.Orbit
can be initialized with an arbitrary shape of input objects in a variety of ways, manipulated in a manner similar to Numpy arrays, and allOrbit
methods work efficiently onOrbit
instances containing multiple objects. Some methods, such as orbit integration and those for fast orbital characterization are parallelized on multi-core machines.Orbit
instances can contain and manipulate millions of objects simultaneously now.Added the
galpy.potentials.mwpotentials
module with various Milky-Way-like potentials. Currently included are MWPotential2014, McMillan17 for the potential from McMillan (2017), models 1 through 4 from Dehnen & Binney (1998), and the three models from Irrgang et al. (2013). See this section of the API documentation for details.Added a (JSON) list with the phase-space coordinates of known objects (mainly Milky Way globular clusters and dwarf galaxies) for easy Orbit.from_name initialization. For ease of use, Orbit.from_name also supports tab completion for known objects in this list in IPython/Jupyter.
Added
galpy.potential.to_amuse
to create an AMUSE representation of any galpy potential, allowing galpy potentials to be used as external gravitational fields in AMUSE N-body simulations.New or improved potentials and potential wrappers:
MovingObjectPotential: Re-wrote
potential.MovingObjectPotential
to allow general mass distributions for the moving object, implemented now as standard galpy potentials. Also added a C implementation of this potential for fast orbit integration.IsothermalDiskPotential: The one-dimensional potential of an isothermal self-gravitating disk (sech^2 profile).
NumericalPotentialDerivativesMixin: a Mixin class to add numerically-computed forces and second derivatives to any Potential class, allowing new potentials to be implemented quickly by only implementing the potential itself and obtaining all forces and second derivatives numerically.
DehnenSmoothWrapperPotential: Can now decay rather than grow a potential by setting
decay=True
.Added support to combine Potential instances or lists thereof through the addition operator. E.g.,
pot= pot1+pot2+pot3
to create the combined potential of the three component potentials (pot1,pot2,pot3). Each of these components can be a combined potential itself. As before, combined potentials are simply lists of potentials, so this is simply an alternative (and perhaps more intuitive) way to create these lists.Added support to adjust the amplitude of a Potential instance through multiplication of the instance by a number or through division by a number. E.g.,
pot= 2.*pot1
returns a Potential instance that is the same as pot1, except that the amplitude is twice larger. Similarly,pot= pot1/2.
decreases the amplitude by a factor of two. This is useful, for example, to quickly change the mass of a potential. Only works for Potential instances, not for lists of Potential instances.
New or improved
galpy.orbit.Orbit
functionality and methods:Added support for 1D orbit integration in C.
Added support to plot arbitrary combinations of the basic Orbit attributes by giving them as an expression (e.g.,
orb.plot(d2='vR*R/r+vz*z/r')
); requires the numexpr package.Switched default Sun’s vertical height zo parameter for Orbit initialization to be the value of 20.8 pc from Bennett & Bovy (2019).
Add Python and C implementation of Dormand-Prince 8(5,3) integrator.
Pre-v1.5¶
v1.4¶
Added dynamical friction as the ChandrasekharDynamicalFrictionForce class, an implementation of dynamical friction based on the classical Chandrasekhar formula (with recent tweaks from the literature to better represent the results from N-body simulations).
A general
EllipsoidalPotential
superclass for implementing potentials with densities that are constant on ellipsoids (functions of \(m^2 = x^2 + y^2/b^2 + z^2/c^2\)). Also implemented in C. Implementing new types of ellipsoidal potentials now only requires three simple functions to be defined: the density as a function of m, its derivative with respect to m, and its integral with respect to m^2. Makes implementing any ellipsoidal potential a breeze. See examples in the new-potentials section below.New or improved potentials and potential wrappers:
CorotatingRotationWrapperPotential: wrapper to make a pattern (e.g., a SpiralArmsPotential) wind up over time such that it is always corotating (see Hunt et al. (2018) for an example of this).
GaussianAmplitudeWrapperPotential: wrapper to modulate the amplitude of a (list of)
Potential
(s) with a Gaussian.PerfectEllipsoidPotential: Potential of a perfect triaxial ellipsoid (de Zeeuw 1985).
SphericalShellPotential: Potential of a thin, spherical shell.
RingPotential: Potential of a circular ring.
Re-implemented
TwoPowerTriaxialPotential
,TriaxialHernquistPotential
,TriaxialJaffePotential
, andTriaxialNFWPotential
using the generalEllipsoidalPotential
class.
New
Potential
methods and functions:Use nested lists of
Potential
instances wherever lists ofPotential
instances can be used. Allows easy adding of components (e.g., a bar) to previously defined potentials (which may be lists themselves): new_pot= [pot,bar_pot].rtide and ttensor: compute the tidal radius of an object and the full tidal tensor.
surfdens method and evaluateSurfaceDensities function to evaluate the surface density up to a given z.
r2deriv and evaluater2derivs: 2nd derivative wrt spherical radius.
evaluatephi2derivs: second derivative wrt phi.
evaluateRphiderivs: mixed (R,phi) derivative.
New or improved
galpy.orbit.Orbit
functionality and methods:Orbit.from_name to initialize an
Orbit
instance from an object’s name. E.g.,orb= Orbit.from_name('LMC')
.Orbit initialization without arguments is now the orbit of the Sun.
Orbits can be initialized with a SkyCoord.
Default
solarmotion=
parameter is now ‘schoenrich’ for the Solar motion of Schoenrich et al. (2010).rguiding: Guiding-center radius.
Lz: vertical component of the angular momentum.
If astropy version > 3, Orbit.SkyCoord method returns a SkyCoord object that includes the velocity information and the Galactocentric frame used by the Orbit instance.
galpy.df.jeans
module with tools for Jeans modeling. Currently only contains the functions sigmar and sigmalos to calculate the velocity dispersion in the radial or line-of-sight direction using the spherical Jeans equation in a given potential, density profile, and anisotropy profile (anisotropy can be radially varying).Support for compilation on Windows with MSVC.
v1.3¶
A fast and precise method for approximating an orbit’s eccentricity, peri- and apocenter radii, and maximum height above the midplane using the Staeckel approximation (see Mackereth & Bovy 2018). Can determine these parameters to better than a few percent accuracy in as little as 10 \(\mu\mathrm{s}\) per object, more than 1,000 times faster than through direct orbit integration. See this section of the documentation for more info.
A general method for modifying
Potential
classes through potential wrappers—simple classes that wrap existing potentials to modify their behavior. See this section of the documentation for examples and this section for information on how to easily define new wrappers. Example wrappers include SolidBodyRotationWrapperPotential to allow any potential to rotate as a solid body and DehnenSmoothWrapperPotential to smoothly grow any potential. See this section of the galpy.potential API page for an up-to-date list of wrappers.New or improved potentials:
DiskSCFPotential: a general Poisson solver well suited for galactic disks
Bar potentials SoftenedNeedleBarPotential and FerrersPotential (latter only in Python for now)
3D spiral arms model SpiralArmsPotential
Henon & Heiles (1964) potential HenonHeilesPotential
Triaxial version of LogarithmicHaloPotential
3D version of DehnenBarPotential
Generalized version of CosmphiDiskPotential
New or improved
galpy.orbit.Orbit
methods:Method to display an animation of an integrated orbit in jupyter notebooks: Orbit.animate. See this section of the documentation.
Improved default method for fast calculation of eccentricity, zmax, rperi, rap, actions, frequencies, and angles by switching to the Staeckel approximation with automatically-estimated approximation parameters.
Improved plotting functions: plotting of spherical radius and of arbitrary user-supplied functions of time in Orbit.plot, Orbit.plot3d, and Orbit.animate.
actionAngleStaeckel
upgrades:actionAngleStaeckel
methods now allow for different focal lengths delta for different phase-space points and for the order of the Gauss-Legendre integration to be specified (default: 10, which is good enough when using actionAngleStaeckel to compute approximate actions etc. for an axisymmetric potential).Added an option to the estimateDeltaStaeckel function to facilitate the return of an estimated delta parameter at every phase space point passed, rather than returning a median of the estimate at each point.
galpy.df.schwarzschilddf:the simple Schwarzschild distribution function for a razor-thin disk (useful for teaching).
v1.2¶
Full support for providing inputs to all initializations, methods, and functions as astropy Quantity with units and for providing outputs as astropy Quantities.
galpy.potential.TwoPowerTriaxialPotential
, a set of triaxial potentials with iso-density contours that are arbitrary, similar, coaxial ellipsoids whose ‘radial’ density is a (different) power-law at small and large radii: 1/m^alpha/(1+m)^beta-alpha (the triaxial generalization of TwoPowerSphericalPotential, with flattening in the density rather than in the potential; includes triaxial Hernquist and NFW potentials.galpy.potential.SCFPotential
, a class that implements general density/potential pairs through the basis expansion approach to solving the Poisson equation of Hernquist & Ostriker (1992). Also implemented functions to compute the coefficients for a given density function. See more explanation here.galpy.actionAngle.actionAngleTorus
: an experimental interface to Binney & McMillan’s TorusMapper code for computing positions and velocities for given actions and angles. See the installation instructions for how to properly install this. See this section and thegalpy.actionAngle
API page for documentation.galpy.actionAngle.actionAngleIsochroneApprox
(Bovy 2014) now implemented for the general case of a time-independent potential.galpy.df.streamgapdf
, a module for modeling the effect of a dark-matter subhalo on a tidal stream. See Sanders et al. (2016). Also includes the fast methods for computing the density along the stream and the stream track for a perturbed stream from Bovy et al. (2016).Orbit.flip
can now flip the velocities of an orbit in-place by specifyinginplace=True
. This allows correct velocities to be easily obtained for backwards-integrated orbits.galpy.potential.PseudoIsothermalPotential
, a standard pseudo-isothermal-sphere potential.galpy.potential.KuzminDiskPotential
, a razor-thin disk potential.Internal transformations between equatorial and Galactic coordinates are now performed by default using astropy’s coordinates module. Transformation of (ra,dec) to Galactic coordinates for general epochs.
v1.1¶
Full support for Python 3.
galpy.potential.SnapshotRZPotential
, a potential class that can be used to get a frozen snapshot of the potential of an N-body simulation.Various other potentials:
PlummerPotential
, a standard Plummer potential;MN3ExponentialDiskPotential
, an approximation to an exponential disk using three Miyamoto-Nagai potentials (Smith et al. 2015);KuzminKutuzovStaeckelPotential
, a Staeckel potential that can be used to approximate the potential of a disk galaxy (Batsleer & Dejonghe 1994).Support for converting potential parameters to NEMO format and units.
Orbit fitting in custom sky coordinates.