Astropy

Latest version: v7.0.1

Safety actively analyzes 724004 Python packages for vulnerabilities to keep your Python projects secure.

Scan your dependencies

Page 12 of 19

2.0.1

Not secure
==========================

Bug Fixes
---------

astropy.constants
^^^^^^^^^^^^^^^^^

- Fixed Earth radius to be the IAU2015 value for the equatorial radius.
The polar value had erroneously been used in 2.0. [6400]

astropy.coordinates
^^^^^^^^^^^^^^^^^^^

- Added old frame attribute classes back to top-level namespace of
``astropy.coordinates``. [6357]

astropy.io.fits
^^^^^^^^^^^^^^^

- Scaling an image always uses user-supplied values when given. Added
defaults for scaling when bscale/bzero are not present (float images).
Fixed a small bug in when to reset ``_orig_bscale``. [5955]

astropy.modeling
^^^^^^^^^^^^^^^^

- Fixed a bug in initializing compound models with units. [6398]

astropy.nddata
^^^^^^^^^^^^^^

- Updating CCDData.read() to be more flexible with inputs, don't try to
delete keywords that are missing from the header. [6388]

astropy.tests
^^^^^^^^^^^^^
- Fixed the test command that is run from ``setuptools`` to allow it to
gracefully handle keyboard interrupts and pass them on to the ``pytest``
subprocess. This prompts ``pytest`` to teardown and display useful traceback
and test information [6369]

astropy.visualization
^^^^^^^^^^^^^^^^^^^^^

- Ticks and tick labels are now drawn in front of, rather than behind,
gridlines in WCS axes. This improves legibility in situations where
tick labels may be on the interior of the axes frame, such as the right
ascension axis of an all-sky Aitoff or Mollweide projection. [6361]

astropy.wcs
^^^^^^^^^^^

- Fix the missing wcskey part in _read_sip_kw, this will cause error when
reading sip wcs while there is no default CRPIX1 CRPIX2 keywords and only
CRPIX1n CRPIX2n in header. [6372]

2.0

Not secure
========================

New Features
------------

astropy.constants
^^^^^^^^^^^^^^^^^

- Constants are now organized into version modules, with physical CODATA
constants in the ``codata2010`` and ``codata2014`` sub-modules,
and astronomical constants defined by the IAU in the ``iau2012`` and
``iau2015`` sub-modules. The default constants in ``astropy.constants``
in Astropy 2.0 have been updated from ``iau2012`` to ``iau2015`` and
from ``codata2010`` to ``codata2014``. The constants for 1.3 can be
accessed in the ``astropyconst13`` sub-module and the constants for 2.0
(the default in ``astropy.constants``) can also be accessed in the
``astropyconst20`` sub-module [6083]

- The GM mass parameters recommended by IAU 2015 Resolution B 3 have been
added as ``GM_sun``, ``GM_jup``, and ``GM_earth``, for the Sun,
Jupiter and the Earth. [6083]

astropy.convolution
^^^^^^^^^^^^^^^^^^^

- Major change in convolution behavior and keyword arguments. Additional
details are in the API section. [5782]

- Convolution with un-normalized and un-normalizable kernels is now possible.
[5782]

- Add a new argument, ``normalization_rtol``, to ``convolve_fft``, allowing
the user to specify the relative error tolerance in the normalization of
the convolution kernel. [5649, 5177]

- Models can now be convoluted using ``convolve`` or ``convolve_fft``,
which generates a regular compound model. [6015]

astropy.coordinates
^^^^^^^^^^^^^^^^^^^

- Frame attributes set on ``SkyCoord`` are now always validated, and any
ndarray-like operation (like slicing) will also be done on those. [5751]

- Caching of all possible frame attributes was implemented. This greatly
speeds up many ``SkyCoord`` operations. [5703, 5751]

- A class hierarchy was added to allow the representation layer to store
differentials (i.e., finite derivatives) of coordinates. This is intended
to enable support for velocities in coordinate frames. [5871]

- ``replicate_without_data`` and ``replicate`` methods were added to
coordinate frames that allow copying an existing frame object with various
reference or copy behaviors and possibly overriding frame attributes. [6182]

- The representation class instances can now contain differential objects.
This is primarily useful for internal operations that will provide support
for transforming velocity components in coordinate frames. [6169]

- ``EarthLocation.to_geodetic()`` (and ``EarthLocation.geodetic``) now return
namedtuples instead of regular tuples. [6237]

- ``EarthLocation`` now has ``lat`` and ``lon`` properties (equivalent to, but
preferred over, the previous ``latitude`` and ``longitude``). [6237]

- Added a ``radial_velocity_correction`` method to ``SkyCoord`` to do compute
barycentric and heliocentric velocity corrections. [5752]

- Added a new ``AffineTransform`` class for coordinate frame transformations.
This class supports matrix operations with vector offsets in position or
any differential quantities (so far, only velocity is supported). The
matrix transform classes now subclass from the base affine transform.
[6218]

- Frame objects now have experimental support for velocity components. Most
frames default to accepting proper motion components and radial velocity,
and the velocities transform correctly for any transformation that uses
one of the ``AffineTransform``-type transformations. For other
transformations a finite-difference velocity transformation is available,
although it is not as numerically stable as those that use
``AffineTransform``-type transformations. [6219, 6226]

astropy.io.ascii
^^^^^^^^^^^^^^^^

- Allow to specify encoding in ``ascii.read``, only for Python 3 and with the
pure-Python readers. [5448]

- Writing latex tables with only a ``tabular`` environment is now possible by
setting ``latexdict['tabletyle']`` to ``None``. [6205]

- Allow ECSV format to support reading and writing mixin columns like
``Time``, ``SkyCoord``, ``Latitude``, and ``EarthLocation``. [6181]

astropy.io.fits
^^^^^^^^^^^^^^^

- Checking available disk space before writing out file. [5550, 4065]

- Change behavior to warn about units that are not FITS-compliant when
writing a FITS file but not when reading. [5675]

- Added absolute tolerance parameter when comparing FITS files. [4729]

- New convenience function ``printdiff`` to print out diff reports. [5759]

- Allow to instantiate a ``BinTableHDU`` directly from a ``Table`` object.
[6139]

astropy.io.misc
^^^^^^^^^^^^^^^

- YAML representer now also accepts numpy types. [6077]

astropy.io.registry
^^^^^^^^^^^^^^^^^^^

- New functions to unregister readers, writers, and identifiers. [6217]

astropy.modeling
^^^^^^^^^^^^^^^^

- Added ``SmoothlyBrokenPowerLaw1D`` model. [5656]

- Add ``n_submodels`` shared method to single and compound models, which
allows users to get the number of components of a given single (compound)
model. [5747]

- Added a ``name`` setter for instances of ``_CompoundModel``. [5741]

- Added FWHM properties to Gaussian and Moffat models. [6027]

- Added support for evaluating models and setting the results for inputs
outside the bounding_box to a user specified ``fill_value``. This
is controlled by a new optional boolean keyword ``with_bounding_box``. [6081]

- Added infrastructure support for units on parameters and during
model evaluation and fitting, added support for units on all
functional, power-law, polynomial, and rotation models where this
is appropriate. A new BlackBody1D model has been added.
[4855, 6183, 6204, 6235]

astropy.nddata
^^^^^^^^^^^^^^

- Added an image class, ``CCDData``. [6173]

astropy.stats
^^^^^^^^^^^^^

- Added ``biweight_midcovariance`` function. [5777]

- Added ``biweight_scale`` and ``biweight_midcorrelation``
functions. [5991]

- ``median_absolute_deviation`` and ``mad_std`` have ``ignore_nan`` option
that will use ``np.ma.median`` with nans masked out or ``np.nanmedian``
instead of ``np.median`` when computing the median. [5232]

- Implemented statistical estimators for Ripley's K Function. [5712]

- Added ``SigmaClip`` class. [6206]

- Added ``std_ddof`` keyword option to ``sigma_clipped_stats``.
[6066, 6207]

astropy.table
^^^^^^^^^^^^^

- Issue a warning when assigning a string value to a column and
the string gets truncated. This can occur because numpy string
arrays are fixed-width and silently drop characters which do not
fit within the fixed width. [5624, 5819]

- Added functionality to allow ``astropy.units.Quantity`` to be written
as a normal column to FITS files. [5910]

- Add support for Quantity columns (within a ``QTable``) in table
``join()``, ``hstack()`` and ``vstack()`` operations. [5841]

- Allow unicode strings to be stored in a Table bytestring column in
Python 3 using UTF-8 encoding. Allow comparison and assignment of
Python 3 ``str`` object in a bytestring column (numpy ``'S'`` dtype).
If comparison with ``str`` instead of ``bytes`` is a problem
(and ``bytes`` is really more logical), please open an issue on GitHub.
[5700]

- Added functionality to allow ``astropy.units.Quantity`` to be read
from and written to a VOtable file. [6132]

- Added support for reading and writing a table with mixin columns like
``Time``, ``SkyCoord``, ``Latitude``, and ``EarthLocation`` via the
ASCII ECSV format. [6181]

- Bug fix for ``MaskedColumn`` insert method, where ``fill_value`` attribute
was not being passed along to the copy of the ``MaskedColumn`` that was
returned. [7585]

astropy.tests
^^^^^^^^^^^^^

- ``enable_deprecations_as_exceptions`` function now accepts additional
user-defined module imports and warning messages to ignore. [6223, 6334]

astropy.units
^^^^^^^^^^^^^

- The ``astropy.units.quantity_input`` decorator will now convert the output to
the unit specified as a return annotation under Python 3. [5606]

- Passing a logarithmic unit to the ``Quantity`` constructor now returns the
appropriate logarithmic quantity class if ``subok=True``. For instance,
``Quantity(1, u.dex(u.m), subok=True)`` yields ``<Dex 1.0 dex(m)>``. [5928]

- The ``quantity_input`` decorator now accepts a string physical type in
addition to of a unit object to specify the expected input ``Quantity``'s
physical type. For example, ``u.quantity_input(x='angle')`` is now
functionally the same as ``u.quantity_input(x=u.degree)``. [3847]

- The ``quantity_input`` decorator now also supports unit checking for
optional keyword arguments and accepts iterables of units or physical types
for specifying multiple valid equivalent inputs. For example,
``u.quantity_input(x=['angle', 'angular speed'])`` or
``u.quantity_input(x=[u.radian, u.radian/u.yr])`` would both allow either
a ``Quantity`` angle or angular speed passed in to the argument ``x``.
[5653]

- Added a new equivalence ``molar_mass_amu`` between g/mol to
atomic mass units. [6040, 6113]

- ``Quantity`` has gained a new ``to_value`` method which returns the value
of the quantity in a given unit. [6127]

- ``Quantity`` now supports the ` operator for matrix multiplication that
was introduced in Python 3.5, for all supported versions of numpy. [6144]

- ``Quantity`` supports the new ``__array_ufunc__`` protocol introduced in
numpy 1.13. As a result, operations that involve unit conversion will be
sped up considerably (by up to a factor of two for costly operations such
as trigonometric ones). [2583]

astropy.utils
^^^^^^^^^^^^^

- Added a new ``dataurl_mirror`` configuration item in ``astropy.utils.data``
that is used to indicate a mirror for the astropy data server. [5547]

- Added a new convenience method ``get_cached_urls`` to ``astropy.utils.data``
for getting a list of the URLs in your cache. [6242]

astropy.wcs
^^^^^^^^^^^

- Upgraded the included wcslib to version 5.16. [6225]

The minimum required version of wcslib in is 5.14.


API Changes
-----------

astropy.analytic_functions
^^^^^^^^^^^^^^^^^^^^^^^^^^

- This entire sub-package is deprecated because blackbody has been moved to
``astropy.modeling.blackbody``. [6191]

astropy.convolution
^^^^^^^^^^^^^^^^^^^

- Major change in convolution behavior and keyword arguments.
``astropy.convolution.convolve_fft`` replaced ``interpolate_nan`` with
``nan_treatment``, and ``astropy.convolution.convolve`` received a new
``nan_treatment`` argument. ``astropy.convolution.convolve`` also no longer
double-interpolates interpolates over NaNs, although that is now available
as a separate ``astropy.convolution.interpolate_replace_nans`` function. See
`the backwards compatibility note
<https://docs.astropy.org/en/v2.0.16/convolution/index.html#a-note-on-backward-compatibility-pre-v2-0>`_
for more on how to get the old behavior (and why you probably don't want to.)
[5782]

astropy.coordinates
^^^^^^^^^^^^^^^^^^^

- The ``astropy.coordinates.Galactic`` frame previously was had the cartesian
ordering 'w', 'u', 'v' (for 'x', 'y', and 'z', respectively). This was an
error and against the common convention. The 'x', 'y', and 'z' axes now
map to 'u', 'v', and 'w', following the right-handed ('u' points to
the Galactic center) convention. [6330]

- Removed deprecated ``angles.rotation_matrix`` and
``angles.angle_axis``. Use the routines in
``coordinates.matrix_utilities`` instead. [6170]

- ``EarthLocation.latitude`` and ``EarthLocation.longitude`` are now
deprecated in favor of ``EarthLocation.lat`` and ``EarthLocation.lon``.
They former will be removed in a future version. [6237]

- The ``FrameAttribute`` class and subclasses have been renamed to just contain
``Attribute``. For example, ``QuantityFrameAttribute`` is now
``QuantityAttribute``. [6300]

astropy.cosmology
^^^^^^^^^^^^^^^^^

- Cosmological models do not include any contribution from neutrinos or photons
by default -- that is, the default value of Tcmb0 is 0. This does not affect
built in models (such as WMAP or Planck). [6112]

astropy.io.fits
^^^^^^^^^^^^^^^

- Remove deprecated ``NumCode`` and ``ImgCode`` properties on FITS
``_ImageBaseHDU``. Use module-level constants ``BITPIX2DTYPE`` and
``DTYPE2BITPIX`` instead. [4993]

- ``comments`` meta key (which is ``io.ascii``'s table convention) is output
to ``COMMENT`` instead of ``COMMENTS`` header. Similarly, ``COMMENT``
headers are read into ``comments`` meta [6097]

- Remove compatibility code which forced loading all HDUs on close. The old
behavior can be used with ``lazy_load_hdus=False``. Because of this change,
trying to access the ``.data`` attribute from an HDU which is not loaded
now raises a ``IndexError`` instead of a ``ValueError``. [6082]

- Deprecated ``clobber`` keyword; use ``overwrite``. [6203]

- Add EXTVER column to the output of ``HDUList.info()``. [6124]

astropy.modeling
^^^^^^^^^^^^^^^^

- Removed deprecated ``Redshift`` model; Use ``RedshiftScaleFactor``. [6053]

- Removed deprecated ``Pix2Sky_AZP.check_mu`` and ``Pix2Sky_SZP.check_mu``
methods. [6170]

- Deprecated ``GaussianAbsorption1D`` model, as it can be better represented
by subtracting ``Gaussian1D`` from ``Const1D``. [6200]

- Added method ``sum_of_implicit_terms`` to ``Model``, needed when performing
a linear fit to a model that has built-in terms with no corresponding
parameters (primarily the ``1*x`` term of ``Shift``). [6174]

astropy.nddata
^^^^^^^^^^^^^^

- Removed deprecated usage of parameter ``propagate_uncertainties`` as a
positional keyword. [6170]

- Removed deprecated ``support_correlated`` attribute. [6170]

- Removed deprecated ``propagate_add``, ``propagate_subtract``,
``propagate_multiply`` and ``propagate_divide`` methods. [6170]

astropy.stats
^^^^^^^^^^^^^

- Removed the deprecated ``sig`` and ``varfunc`` keywords in the
``sigma_clip`` function. [5715]

- Added ``modify_sample_size`` keyword to ``biweight_midvariance``
function. [5991]

astropy.table
^^^^^^^^^^^^^

- In Python 3, when getting an item from a bytestring Column it is now
converted to ``str``. This means comparing a single item to a ``bytes``
object will always fail, and instead one must compare with a ``str``
object. [5700]

- Removed the deprecated ``data`` property of Row. [5729]

- Removed the deprecated functions ``join``, ``hstack``, ``vstack`` and
``get_groups`` from np_utils. [5729]

- Added ``name`` parameter to method ``astropy.table.Table.add_column`` and
``names`` parameter to method ``astropy.table.Table.add_columns``, to
provide the flexibility to add unnamed columns, mixin objects and also to
specify explicit names. Default names will be used if not
specified. [5996]

- Added optional ``axis`` parameter to ``insert`` method for ``Column`` and
``MaskedColumn`` classes. [6092]

astropy.units
^^^^^^^^^^^^^

- Moved ``units.cgs.emu`` to ``units.deprecated.emu`` due to ambiguous
definition of "emu". [4918, 5906]

- ``jupiterMass``, ``earthMass``, ``jupiterRad``, and ``earthRad`` no longer
have their prefixed units included in the standard units. If needed, they
can still be found in ``units.deprecated``. [5661]

- ``solLum``,``solMass``, and ``solRad`` no longer have their prefixed units
included in the standard units. If needed, they can still be found in
``units.required_by_vounit``, and are enabled by default. [5661]

- Removed deprecated ``Unit.get_converter``. [6170]

- Internally, astropy replaced use of ``.to(unit).value`` with the new
``to_value(unit)`` method, since this is somewhat faster. Any subclasses
that overwrote ``.to``, should also overwrite ``.to_value`` (or
possibly just the private ``._to_value`` method. (If you did this,
please let us know what was lacking that made this necessary!). [6137]

astropy.utils
^^^^^^^^^^^^^

- Removed the deprecated compatibility modules for Python 2.6 (``argparse``,
``fractions``, ``gzip``, ``odict``, ``subprocess``) [5975,6157,6164]

- Removed the deprecated ``zest.releaser`` machinery. [6282]

astropy.visualization
^^^^^^^^^^^^^^^^^^^^^

- Removed the deprecated ``scale_image`` function. [6170]

astropy.vo
^^^^^^^^^^

- Cone Search now issues deprecation warning because it is moved to
Astroquery 0.3.5 and will be removed from Astropy in a future version.
[5558, 5904]

- The ``astropy.vo.samp`` package has been moved to ``astropy.samp``, and no
longer supports HTTPS/SSL. [6201, 6213]

astropy.wcs
^^^^^^^^^^^

- Removed deprecated ``wcs.rotateCD``. [6170]


Bug Fixes
---------

astropy.convolution
^^^^^^^^^^^^^^^^^^^

- Major change in convolution behavior and keyword arguments:
``astropy.convolution.convolve`` was not performing normalized convolution
in earlier versions of astropy. [5782]

- Direct convolution previously implemented the wrong definition of
convolution. This error only affects *asymmetric* kernels. [6267]

astropy.coordinates
^^^^^^^^^^^^^^^^^^^

- The ``astropy.coordinates.Galactic`` frame had an incorrect ordering for the
'u', 'v', and 'w' cartesian coordinates. [6330]

- The ``astropy.coordinates.search_around_sky``,
``astropy.coordinates.search_around_3d``, and ``SkyCoord`` equivalent methods
now correctly yield an ``astropy.coordinates.Angle`` as the third return type
even if there are no matches (previously it returned a raw Quantity). [6347]

astropy.io.ascii
^^^^^^^^^^^^^^^^

- Fix an issue where the fast C-reader was dropping table comments for a
table with no data lines. [8274]

astropy.io.fits
^^^^^^^^^^^^^^^

- ``comments`` meta key (which is ``io.ascii``'s table convention) is output
to ``COMMENT`` instead of ``COMMENTS`` header. Similarly, ``COMMENT``
headers are read into ``comments`` meta [6097]

- Use more sensible fix values for invalid NAXISj header values. [5935]

- Close file on error to avoid creating a ``ResourceWarning`` warning
about an unclosed file. [6168, 6177]

astropy.modeling
^^^^^^^^^^^^^^^^

- Creating a compound model where one of the submodels is
a compound model whose parameters were changed now uses the
updated parameters and not the parameters of the original model. [5741]

- Allow ``Mapping`` and ``Identity`` to be fittable. [6018]

- Gaussian models now impose positive ``stddev`` in fitting. [6019]

- OrthoPolynomialBase (Chebyshev2D / Legendre2D) models were being evaluated
incorrectly when part of a compound model (using the parameters from the
original model), which in turn caused fitting to fail as a no-op. [6085]

- Allow ``Ring2D`` to be defined using ``r_out``. [6192]

- Make ``LinearLSQFitter`` produce correct results with fixed model
parameters and allow ``Shift`` and ``Scale`` to be fitted with
``LinearLSQFitter`` and ``LevMarLSQFitter``. [6174]

astropy.stats
^^^^^^^^^^^^^

- Allow to choose which median function is used in ``mad_std`` and
``median_absolute_deviation``. And allow to use these functions with
a multi-dimensional ``axis``. [5835]

- Fixed ``biweight_midvariance`` so that by default it returns a
variance that agrees with the standard definition. [5991]

astropy.table
^^^^^^^^^^^^^

- Fix a problem with vstack for bytes columns in Python 3. [5628]

- Fix QTable add/insert row for multidimensional Quantity. [6092]

astropy.time
^^^^^^^^^^^^

- Fixed the initial condition of ``TimeFITS`` to allow scale, FITS scale
and FITS realization to be checked and equated properly. [6202]

astropy.visualization
^^^^^^^^^^^^^^^^^^^^^

- Fixed a bug that caused the default WCS to return coordinates offset by
one. [6339]

astropy.vo
^^^^^^^^^^

- Fixed a bug in vo.samp when stopping a hub for which a lockfile was
not created. [6211]


Other Changes and Additions
---------------------------

- Numpy 1.7 and 1.8 are no longer supported. [6006]

- Python 3.3 is no longer supported. [6020]

- The bundled ERFA was updated to version 1.4.0. [6239]

- The bundled version of pytest has now been removed, but the
astropy.tests.helper.pytest import will continue to work properly.
Affiliated packages should nevertheless transition to importing pytest
directly rather than from astropy.tests.helper. This also means that
pytest is now a formal requirement for testing for both Astropy and
for affiliated packages. [5694]

1.3.3

Not secure
==========================

Bug Fixes
---------

astropy.coordinates
^^^^^^^^^^^^^^^^^^^

- Fixed a bug where ``StaticMatrixTransform`` erroneously copied frame
attributes from the input coordinate to the output frame. In practice, this
didn't actually affect any transforms in Astropy but may change behavior for
users who explicitly used the ``StaticMatrixTransform`` in their own code.
[6045]

- Fixed ``get_icrs_coordinates`` to loop through all the urls in case one
raises an exception. [5864]

astropy.io.fits
^^^^^^^^^^^^^^^

- Fix table header not written out properly when ``fits.writeto()``
convenience function is used. [6042]

- Fix writing out read-only arrays. [6036]

- Extension headers are written out properly when the ``fits.update()``
convenience function is used. [6058]

- Angstrom, erg, G, and barn are no more reported as deprecated FITS units.
[5929]

astropy.table
^^^^^^^^^^^^^

- Fix problem with Table pprint/pformat raising an exception for
non-UTF-8 compliant bytestring data. [6117]

astropy.units
^^^^^^^^^^^^^

- Allow strings 'nan' and 'inf' as Quantity inputs. [5958]

- Add support for ``positive`` and ``divmod`` ufuncs (new in numpy 1.13).
[5998, 6020, 6116]

astropy.utils
^^^^^^^^^^^^^

- On systems that do not have ``pkg_resources`` non-numerical additions to
version numbers like ``dev`` or ``rc1`` are stripped in ``minversion`` to
avoid a ``TypeError`` in ``distutils.version.LooseVersion`` [5944]

- Fix ``auto_download`` setting ignored in ``Time.ut1``. [6033]

astropy.visualization
^^^^^^^^^^^^^^^^^^^^^

- Fix bug in ManualInterval which caused the limits to be returned incorrectly
if set to zero, and fix defaults for ManualInterval in the presence of NaNs.
[6088]

- Get rid of warnings that occurred when slicing a cube due to the tick
locator trying to find ticks for the sliced axis. [6104]

- Accept normal Matplotlib keyword arguments in set_xlabel and set_ylabel
functions. [5686, 5692, 6060]

- Fix a bug that caused labels to be missing from frames with labels that
could change direction mid-axis, such as EllipticalFrame. Also ensure
that empty tick labels do not cause any warnings. [6063]

1.3.2

Not secure
==========================

Bug Fixes
---------

astropy.coordinates
^^^^^^^^^^^^^^^^^^^

- Ensure that checking equivalence of ``SkyCoord`` objects works with
non-scalar attributes [5884, 5887]

- Ensure that transformation to frames with multi-dimensional attributes
works as expected [5890, 5897]

- Make sure all ``BaseRepresentation`` objects can be output as strings.
[5889, 5897]

astropy.units
^^^^^^^^^^^^^

- Add support for ``heaviside`` ufunc (new in numpy 1.13). [5920]

astropy.utils
^^^^^^^^^^^^^

- Fix to allow the C-based _fast_iterparse() VOTable XML parser to
relloc() its buffers instead of overflowing them. [5824, 5869]


Other Changes and Additions
---------------------------

- File permissions are revised in the released source distribution. [5912]

1.3.1

Not secure
==========================

New Features
------------

astropy.utils
^^^^^^^^^^^^^

- The ``deprecated_renamed_argument`` decorator got a new ``pending``
parameter to suppress the deprecation warnings. [5761]

Bug Fixes
---------

astropy.coordinates
^^^^^^^^^^^^^^^^^^^

- Changed ``SkyCoord`` so that frame attributes which are not valid for the
current ``frame`` (but are valid for other frames) are stored on the
``SkyCoord`` instance instead of the underlying ``frame`` instance (e.g.,
setting ``relative_humidity`` on an ICRS ``SkyCoord`` instance.) [5750]

- Ensured that ``position_angle`` and ``separation`` give correct answers for
frames with different equinox (see 5722). [5762]

astropy.io.fits
^^^^^^^^^^^^^^^

- Fix problem with padding bytes written for BinTable columns converted
from unicode [5280, 5287, 5288, 5296].

- Fix out-of-order TUNITn cards when writing tables to FITS. [5720]

- Recognize PrimaryHDU when non boolean values are present for the
'GROUPS' header keyword. [5808]

- Fix the insertion of new keywords in compressed image headers
(``CompImageHeader``). [5866]

astropy.modeling
^^^^^^^^^^^^^^^^

- Fixed a problem with setting ``bounding_box`` on 1D models. [5718]

- Fixed a broadcasting problem with weighted fitting of 2D models
with ``LevMarLSQFitter``. [5788]

- Fixed a problem with passing kwargs to fitters, specifically ``verblevel``. [5815]

- Changed FittingWithOutlierRemoval to reject on the residual to the fit [5831]

astropy.stats
^^^^^^^^^^^^^

- Fix the psd normalization for Lomb-Scargle periodograms in the presence
of noise. [5713]

- Fix bug in the autofrequency range when ``minimum_frequency`` is specified
but ``maximum_frequency`` is not. [5738]

- Ensure that a masked array is returned when sigma clipping fully masked
data. [5711]

astropy.table
^^^^^^^^^^^^^

- Fix problem where key for caching column format function was not
sufficiently unique. [5803]

- Handle sorting NaNs and masked values in jsviewer. [4052, 5572]

- Ensure mixin columns can be added to a table using a scalar value for the
right-hand side if the type supports broadcasting. E.g., for an existing
``QTable``, ``t['q'] = 3*u.m`` will now add a column as expected. [5820]

- Fixes the bug of setting/getting values from rows/columns of a table using
numpy array scalars. [5772]

astropy.units
^^^^^^^^^^^^^

- Fixed problem where IrreducibleUnits could fail to unpickle. [5868]

astropy.utils
^^^^^^^^^^^^^

- Avoid importing ``ipython`` in ``utils.console`` until it is necessary, to
prevent deprecation warnings when importing, e.g., ``Column``. [5755]

astropy.visualization
^^^^^^^^^^^^^^^^^^^^^

- Avoid importing matplotlib.pyplot when importing
astropy.visualization.wcsaxes. [5680, 5684]

- Ignore Numpy warnings that happen in coordinate transforms in WCSAxes.
[5792]

- Fix compatibility issues between WCSAxes and Matplotlib 2.x. [5786]

- Fix a bug that caused WCSAxes frame visual properties to not be copied
over when resetting the WCS. [5791]

astropy.extern
^^^^^^^^^^^^^^

- Fixed a bug where PLY was overwriting its generated files. [5728]

Other Changes and Additions
---------------------------

- Fixed a deprecation warning that occurred when running tests with
astropy.test(). [5689]

- The deprecation of the ``clobber`` argument (originally deprecated in 1.3.0)
in the ``io.fits`` write functions was changed to a "pending" deprecation
(without displaying warnings) for now. [5761]

- Updated bundled astropy-helpers to v1.3.1. [5880]

1.3

Not secure
========================

New Features
------------

astropy.convolution
^^^^^^^^^^^^^^^^^^^

- The ``convolve`` and ``convolve_fft`` arguments now support a ``mask`` keyword,
which allows them to also support ``NDData`` objects as inputs. [5554]

astropy.coordinates
^^^^^^^^^^^^^^^^^^^

- Added an ``of_address`` classmethod to ``EarthLocation`` to enable fast creation of
``EarthLocation`` objects given an address by querying the Google maps API [5154].

- A new routine, ``get_body_barycentric_posvel`` has been added that allows
one to calculate positions as well as velocities for solar system bodies.
For JPL kernels, this roughly doubles the execution time, so if one requires
only the positions, one should use ``get_body_barycentric``. [5231]

- Transformations between coordinate systems can use the more accurate JPL
ephemerides. [5273, 5436]

- Arithmetic on representations, such as addition of two representations,
multiplication with a ``Quantity``, or calculating the norm via ``abs``,
has now become possible. Furthermore, there are new methods ``mean``,
``sum``, ``dot``, and ``cross``. For all these, the representations are
treated as vectors in cartesian space (temporarily converting to
``CartesianRepresentation`` if necessary). [5301]
has now become possible. Furthermore, there are news methods ``mean``,
``sum``, ``dot``, and ``cross`` with obvious meaning. [5301]
multiplication with a ``Quantity`` has now become possible. Furthermore,
there are new methods ``norm``, ``mean``, ``sum``, ``dot``, and ``cross``.
In all operations, the representations are treated as vectors. They are
temporarily converted to ``CartesianRepresentation`` if necessary. [5301]

- ``CartesianRepresentation`` can be initialized with plain arrays by passing
in a ``unit``. Furthermore, for input with a vector array, the coordinates
no longer have to be in the first dimension, but can be at any ``xyz_axis``.
To complement the latter, a new ``get_xyz(xyz_axis)`` method allows one to
get a vector array out along a given axis. [5439]

astropy.io.ascii
^^^^^^^^^^^^^^^^

- Files with "Fortran-style" columns (i.e. double-precision scientific notation
with a character other than "e", like ``1.495978707D+13``) can now be parsed by
the fast reader natively. [5552]

- Allow round-tripping masked data tables in most formats by using an
empty string ``''`` as the default representation of masked values
when writing. [5347]

- Allow reading HTML tables with unicode column values in Python 2.7. [5410]

- Check for self-consistency of ECSV header column names. [5463]

- Produce warnings when writing an IPAC table from an astropy table that
contains metadata not supported by the IPAC format. [4700]

astropy.io.fits
^^^^^^^^^^^^^^^

- "Lazy" loading of HDUs now occurs - when an HDU is requested, the file is
only read up to the point where that HDU is found. This can mean a
substantial speedup when accessing files that have many HDUs. [5065]

astropy.io.misc
^^^^^^^^^^^^^^^

- Added ``io.misc.yaml`` module to support serializing core astropy objects
using the YAML protocol. [5486]

astropy.io.registry
^^^^^^^^^^^^^^^^^^^

- Added ``delay_doc_updates`` contextmanager to postpone the formatting of
the documentation for the ``read`` and ``write`` methods of the class to
optionally reduce the import time. [5275]

astropy.modeling
^^^^^^^^^^^^^^^^

- Added a class to combine astropy fitters and functions to remove outliers
e. g., sigma clip. [4760]

- Added a ``Tabular`` model. [5105]

- Added ``Hermite1D`` and ``Hermite2D`` polynomial models [5242]

- Added the injection of EntryPoints into astropy.modeling.fitting if
they inherit from Fitters class. [5241]

- Added bounding box to ``Lorentz1D`` and ``MexicanHat1D`` models. [5393]

- Added ``Planar2D`` functional model. [5456]

- Updated ``Gaussian2D`` to accept no arguments (will use default x/y_stddev
and theta). [5537]

astropy.nddata
^^^^^^^^^^^^^^

- Added ``keep`` and ``**kwargs`` parameter to ``support_nddata``. [5477]

astropy.stats
^^^^^^^^^^^^^

- Added ``axis`` keyword to ``biweight_location`` and
``biweight_midvariance``. [5127, 5158]

astropy.table
^^^^^^^^^^^^^

- Allow renaming mixin columns. [5469]

- Support generalized value formatting for mixin columns in tables. [5274]

- Support persistence of table indices when pickling and copying table. [5468]

astropy.tests
^^^^^^^^^^^^^

- Install both runtime and test dependencies when running the
./setup.py test command. These dependencies are specified by the
install_requires and tests_require keywords via setuptools. [5092]

- Enable easier subclassing of the TestRunner class. [5505]

astropy.time
^^^^^^^^^^^^

- ``light_travel_time`` can now use more accurate JPL ephemerides. [5273, 5436]

astropy.units
^^^^^^^^^^^^^

- Added ``pixel_scale`` and ``plate_scale`` equivalencies. [4987]

- The ``spectral_density`` equivalency now supports transformations of
luminosity density. [5151]

- ``Quantity`` now accepts strings consisting of a number and unit such
as '10 km/s'. [5245]

astropy.utils
^^^^^^^^^^^^^

- Added a new decorator: ``deprecated_renamed_argument``. This can be used to
rename a function argument, while it still allows for the use of the older
argument name. [5214]

astropy.visualization
^^^^^^^^^^^^^^^^^^^^^

- Added a ``make_lupton_rgb`` function to generate color images from three
greyscale images, following the algorithm of Lupton et al. (2004). [5535]

- Added ``data`` and ``interval`` inputs to the ``ImageNormalize``
class. [5206]

- Added a new ``simple_norm`` convenience function. [5206]

- Added a default stretch for the ``Normalization`` class. [5206].

- Added a default ``vmin/vmax`` for the ``ManualInterval`` class.
[5206].

- The ``wcsaxes`` subpackage has now been integrated in astropy as
``astropy.visualization.wcsaxes``. This allows plotting of astronomical
data/coordinate systems in Matplotlib. [5496]

astropy.wcs
^^^^^^^^^^^

- Improved ``footprint_to_file``: allow to specify the coordinate system, and
use by default the one from ``RADESYS``. Overwrite the file instead of
appending to it. [5494]


API Changes
-----------

astropy.convolution
^^^^^^^^^^^^^^^^^^^

- ``discretize_model`` now raises an exception if non-integer ranges are used.
Previously it had incorrect behavior but did not raise an exception. [5538]

astropy.coordinates
^^^^^^^^^^^^^^^^^^^

- ``SkyCoord``, ``ICRS``, and other coordinate objects, as well as the
underlying representations such as ``SphericalRepresentation`` and
``CartesianRepresentation`` can now be reshaped using methods named like the
numpy ones for ``ndarray`` (``reshape``, ``swapaxes``, etc.)
[4123, 5254, 5482]

- The ``obsgeoloc`` and ``obsgeovel`` attributes of ``GCRS`` and
``PrecessedGeocentric`` frames are now stored and returned as
``CartesianRepresentation`` objects, rather than ``Quantity`` objects.
Similarly, ``EarthLocation.get_gcrs_posvel`` now returns a tuple of
``CartesianRepresentation`` objects. [5253]

- ``search_around_3d`` and ``search_around_sky`` now return units
for the distance matching their input argument when no match is
found, instead of ``dimensionless_unscaled``. [5528]

astropy.io.ascii
^^^^^^^^^^^^^^^^

- ASCII writers now accept an 'overwrite' argument.
The default behavior is changed so that a warning will be
issued when overwriting an existing file unless ``overwrite=True``.
In a future version this will be changed from a warning to an
exception to prevent accidentally overwriting a file. [5007]

- The default representation of masked values when writing tables was
changed from ``'--'`` to the empty string ``''``. Previously any
user-supplied ``fill_values`` parameter would overwrite the class
default, but now the values are prepended to the class default. [5347]

astropy.io.fits
^^^^^^^^^^^^^^^

- The old ``Header`` interface, deprecated since Astropy 0.1 (PyFITS 3.1), has
been removed entirely. See :ref:`header-transition-guide` for explanations
on this change and help on the transition. [5310]

- The following functions, classes and methods have been removed:
``CardList``, ``Card.key``, ``Card.cardimage``, ``Card.ascardimage``,
``create_card``, ``create_card_from_string``, ``upper_key``,
``Header.ascard``, ``Header.rename_key``, ``Header.get_history``,
``Header.get_comment``, ``Header.toTxtFile``, ``Header.fromTxtFile``,
``new_table``, ``tdump``, ``tcreate``, ``BinTableHDU.tdump``,
``BinTableHDU.tcreate``.

- Removed ``txtfile`` argument to the ``Header`` constructor.

- Removed usage of ``Header.update`` with ``Header.update(keyword, value,
comment)`` arguments.

- Removed ``startColumn`` and ``endColumn`` arguments to the ``FITS_record``
constructor.

- The ``clobber`` argument in FITS writers has been renamed to
``overwrite``. This change affects the following functions and
methods: ``tabledump``, ``writeto``, ``Header.tofile``,
``Header.totextfile``, ``_BaseDiff.report``,
``_BaseHDU.overwrite``, ``BinTableHDU.dump`` and
``HDUList.writeto``. [5171]

- Added an optional ``copy`` parameter to ``fits.Header`` which controls if
a copy is made when creating an ``Header`` from another ``Header``.
[5005, 5326]

astropy.io.registry
^^^^^^^^^^^^^^^^^^^

- ``.fts`` and ``.fts.gz`` files will be automatically identified as
``io.fits`` files if no explicit ``format`` is given. [5211]

- Added an optional ``readwrite`` parameter for ``get_formats`` to filter
formats for read or write. [5275]

astropy.modeling
^^^^^^^^^^^^^^^^

- ``Gaussian2D`` now raises an error if ``theta`` is set at the same time as
``cov_matrix`` (previously ``theta`` was silently ignored). [5537]

astropy.table
^^^^^^^^^^^^^

- Setting an existing table column (e.g. ``t['a'] = [1, 2, 3]``) now defaults
to *replacing* the column with a column corresponding to the new value
(using ``t.replace_column()``) instead of doing an in-place update. Any
existing meta-data in the column (e.g. the unit) is discarded. An
in-place update is still done when the new value is not a valid column,
e.g. ``t['a'] = 0``. To force an in-place update use the pattern
``t['a'][:] = [1, 2, 3]``. [5556]

- Allow ``collections.Mapping``-like ``data`` attribute when initializing a
``Table`` object (``dict``-like was already possible). [5213]

astropy.tests
^^^^^^^^^^^^^

- The inputs to the ``TestRunner.run_tests()`` method now must be
keyword arguments (no positional arguments). This applies to the
``astropy.test()`` function as well. [5505]

astropy.utils
^^^^^^^^^^^^^

- Renamed ``ignored`` context manager in ``compat.misc`` to ``suppress``
to be consistent with https://bugs.python.org/issue19266 . [#5003]

astropy.visualization
^^^^^^^^^^^^^^^^^^^^^

- Deprecated the ``scale_image`` function. [5206]

- The ``mpl_normalize`` module (containing the ``ImageNormalize``
class) is now automatically imported with the ``visualization``
subpackage. [5491]

astropy.vo
^^^^^^^^^^

- The ``clobber`` argument in ``VOSDatabase.to_json()`` has been
renamed to ``overwrite``. [5171]

astropy.wcs
^^^^^^^^^^^

- ``wcs.rotateCD()`` was deprecated without a replacement. [5240]

Bug Fixes
---------

astropy.coordinates
^^^^^^^^^^^^^^^^^^^

- Transformations between CIRS and AltAz now correctly account for the
location of the observer. [5591]

- GCRS frames representing a location on Earth with multiple obstimes are now
allowed. This means that the solar system routines ``get_body``,
``get_moon`` and ``get_sun`` now work with non-scalar times and a
non-geocentric observer. [5253]

astropy.io.ascii
^^^^^^^^^^^^^^^^

- Fix issue with units or other astropy core classes stored in table meta.
[5605]

astropy.io.fits
^^^^^^^^^^^^^^^

- Copying a ``fits.Header`` using ``copy`` or ``deepcopy`` from the ``copy``
module will use ``Header.copy`` to ensure that modifying the copy will
not alter the other original Header and vice-versa. [4990, 5323]

- ``HDUList.info()`` no longer raises ``AttributeError`` in presence of
``BZERO``. [5508]

- Avoid exceptions with numpy 1.10 and up when using scaled integer data
where ``BZERO`` has float type but integer value. [4639, 5527]

- Converting a header card to a string now calls ``self.verify('fix+warn')``
instead of ``self.verify('fix')`` so headers with invalid keywords will
not raise a ``VerifyError`` on printing. [887,5054]

- ``FITS_Record._convert_ascii`` now converts blank fields to 0 when a
non-blank null column value is set. [5134, 5394]

astropy.io.registry
^^^^^^^^^^^^^^^^^^^

- ``read`` now correctly raises an IOError if a file with an unknown
extension can't be found, instead of raising IORegistryError:
"Format could not be identified." [4779]

astropy.time
^^^^^^^^^^^^

- Ensure ``Time`` instances holding a single ``delta_ut1_utc`` can be copied,
flattened, etc. [5225]

astropy.units
^^^^^^^^^^^^^

- Operations involving ``Angle`` or ``Distance``, or any other
``SpecificTypeQuantity`` instance, now also keep return an instance of the
same type if the instance was the second argument (if the resulting unit
is consistent with the specific type). [5327]

- Inplace operations on ``Angle`` and ``Distance`` instances now raise an
exception if the final unit is not equivalent to radian and meter, resp.
Similarly, views as ``Angle`` and ``Distance`` can now only be taken
from quantities with appropriate units, and views as ``Quantity`` can only
be taken from logarithmic quanties such as ``Magnitude`` if the physical
unit is dimensionless. [5070]

- Conversion from quantities to logarithmic units now correctly causes a
logarithmic quantity such as ``Magnitude`` to be returned. [5183]


astropy.wcs
^^^^^^^^^^^

- SIP distortion for an alternate WCS is correctly initialized now by
looking at the "CTYPE" values matching the alternate WCS. [5443]

Other Changes and Additions
---------------------------

- The bundled ERFA was updated to version 1.3.0. This includes the
leap second planned for 2016 Dec 31.

astropy.coordinates
^^^^^^^^^^^^^^^^^^^

- Initialization of ``Angle`` has been sped up for ``Quantity`` and ``Angle``
input. [4970]

- The use of ``np.matrix`` instances in the transformations has been
deprecated, since this class does not allow stacks of matrices. As a
result, the semi-public functions ``angles.rotation_matrix`` and
``angles.angle_axis`` are also deprecated, in favour of the new routines
with the same name in ``coordinates.matrix_utilities``. [5104]

- A new ``BaseCoordinateFrame.cache`` dictionary has been created to expose
the internal cache. This is useful when modifying representation data
in-place without using ``realize_frame``. Additionally, documentation for
in-place operations on coordinates were added. [5575]

- Coordinates and their representations are printed with a slightly different
format, following how numpy >= 1.12 prints structured arrays. [5423]

astropy.cosmology
^^^^^^^^^^^^^^^^^

- The default cosmological model has been changed to Planck 2015,
and the citation strings have been updated. [5372]

astropy.extern
^^^^^^^^^^^^^^

- Updated the bundled ``six`` module to version 1.10.0. [5521]

- Updated the astropy shipped version of ``PLY`` to version 3.9. [5526]

- Updated the astropy shipped version of jQuery to v3.3.1, and dataTables
to v1.10.12. [5564]

astropy.io.fits
^^^^^^^^^^^^^^^

- Performance improvements for tables with many columns. [4985]

- Removed obsolete code that was previously needed to properly
implement the append mode. [4793]

astropy.io.registry
^^^^^^^^^^^^^^^^^^^

- Reduced the time spent in the ``get_formats`` function. This also reduces
the time it takes to import astropy subpackages, i.e.
``astropy.coordinates``. [5262]

astropy.units
^^^^^^^^^^^^^

- The functions ``add_enabled_units``, ``set_enabled_equivalencies`` and
``add_enabled_equivalencies`` have been sped up by copying the current
``_UnitRegistry`` instead of building it from scratch. [5306]

- To build the documentation, the ``build_sphinx`` command has been deprecated
in favor of ``build_docs``. [5179]

- The ``--remote-data`` option to ``python setup.py test`` can now take
different arguments: ``--remote-data=none`` is the same as not specifying
``--remote-data`` (skip all tests that require the internet),
``--remote-data=astropy`` skips all tests that need remote data except those
that require only data from data.astropy.org, and ``--remote-data=any`` is
the same as ``--remote-data`` (run all tests that use remote data). [5506]

- The pytest ``recwarn`` fixture has been removed from the tests in favor of
``utils.catch_warnings``. [5489]

- Deprecated escape sequences in strings (Python 3.6) have been removed. [5489]

Page 12 of 19

© 2025 Safety CLI Cybersecurity Inc. All Rights Reserved.