diff --git a/CHANGES.rst b/CHANGES.rst index 5815e933733..7e1a5926b1f 100644 --- a/CHANGES.rst +++ b/CHANGES.rst @@ -1,3 +1,268 @@ +Version 5.2 (2022-12-12) +======================== + +New Features +------------ + +astropy.coordinates +^^^^^^^^^^^^^^^^^^^ + +- Adds new topocentric ITRS frame and direct transforms to and from the observed + frames ``AltAz`` and ``HADec`` with the ability to add or remove refraction + corrections as required. Since these frames are all within the ITRS, there are + no corrections applied other than refraction in the transforms. This makes the + topocentric ITRS frame and these transforms convenient for observers of near + Earth objects where stellar aberration should be omitted. [#13398] + +- Allow comparing ``SkyCoord`` to frames with data. [#13477] + +astropy.cosmology +^^^^^^^^^^^^^^^^^ + +- Cosmology instance can be parsed from or converted to a HTML table using + the new HTML methods in Cosmology's ``to/from_format`` I/O. [#13075] + +- A new comparison function has been added -- ``cosmology_equal()`` -- that + mirrors its ``numpy`` counterpart but allows for the arguments to be converted + to a ``Cosmology`` and to compare flat cosmologies with their non-flat + equivalents. [#13104] + +- Cosmology equivalence for flat FLRW cosmologies has been generalized to apply + to all cosmologies using the FlatCosmology mixin. [#13261] + +- The cosmological redshift unit now has a physical type of ``"redshift"``. [#13561] + +astropy.io.ascii +^^^^^^^^^^^^^^^^ + +- Add ability to read and write a fixed width ASCII table that includes additional + header rows specifying any or all of the column dtype, unit, format, and + description. This is available in the ``fixed_width`` and + ``fixed_width_two_line`` formats via the new ``header_rows`` keyword argument. [#13734] + +astropy.io.fits +^^^^^^^^^^^^^^^ + +- Added support to the ``io.fits`` API for reading and writing file paths of the + form ``~/file.fits`` or ``~/file.fits``, referring to the home + directory of the current user or the specified user, respectively. [#13131] + +- Added support for opening remote and cloud-hosted FITS files using the + ``fsspec`` package, which has been added as an optional dependency. [#13238] + +astropy.io.votable +^^^^^^^^^^^^^^^^^^ + +- Added support in ``io.votable`` for reading and writing file paths of the form + ``~/file.xml`` or ``~/file.xml``, referring to the home directory of + the current user or the specified user, respectively. [#13149] + +astropy.modeling +^^^^^^^^^^^^^^^^ + +- Add option to non-linear fitters which enables automatic + exclusion of non-finite values from the fit data. [#13259] + +astropy.nddata +^^^^^^^^^^^^^^ + +- Modified ``Cutout2D`` to allow objects of type ``astropy.io.fits.Section`` + to be passed to the ``data`` parameter. [#13238] + +- Add a PSF image representation to ``astropy.nddata.NDData`` and ``astropy.nddata.CCDData``. [#13743] + +astropy.table +^^^^^^^^^^^^^ + +- An Astropy table can now be converted to a scalar NumPy object array. For NumPy + >= 1.20, a list of Astropy tables can be converted to an NumPy object array of + tables. [#13469] + +astropy.time +^^^^^^^^^^^^ + +- Added the ``astropy.time.Time.mean()`` method which also enables the ``numpy.mean()`` function to be used on instances of ``astropy.time.Time``. [#13508] + +- Improve the performance of getting the string representation of a large ``Time`` + or ``TimeDelta`` object. This is done via a new ``to_string()`` method that does + the time string format conversion only for the outputted values. Previously the + entire array was formatted in advance. [#13555] + +astropy.units +^^^^^^^^^^^^^ + +- It is now possible to use unit format names as string format specifiers for a + ``Quantity``, e.g. ``f'{1e12*u.m/u.s:latex_inline}'`` now produces the string + ``'$1 \\times 10^{12} \\; \\mathrm{m\\,s^{-1}}$'``. [#13050] + +- Ensure that the ``argmin`` and ``argmax`` methods of ``Quantity`` support the + ``keepdims`` argument when numpy does (numpy version 1.22 and later). [#13329] + +- ``numpy.lib.recfunctions.merge_arrays()`` is registered with numpy overload for + ``Quantity``. [#13669] + +- Added SI prefixes for quecto ("q", :math:`10^{-30}`), ronto ("r", + :math:`10^{-27}`), ronna ("R", :math:`10^{27}`), and quetta ("Q", + :math:`10^{30}`). [#14046] + +astropy.utils +^^^^^^^^^^^^^ + +- Added the ``use_fsspec``, ``fsspec_kwargs``, and ``close_files`` arguments + to ``utils.data.get_readable_fileobj``. [#13238] + +- Ensure that the ``argmin`` and ``argmax`` methods of ``Masked`` instances + support the ``keepdims`` argument when numpy does (numpy version 1.22 and + later). [#13329] + +astropy.visualization +^^^^^^^^^^^^^^^^^^^^^ + +- Add helper functions for WCSAxes instances to draw the instrument beam and a physical scale. [#12102] + +- Add a ``scatter_coord`` method to the ``wcsaxes`` functionality based on the + existing ``plot_coord`` method but that calls ``matplotlib.pyplot.scatter``. [#13562] + +- Added a ``sinh`` stretch option to ``simple_norm``. [#13746] + +- It is now possible to define "tickable" gridlines for the purpose of placing ticks or tick labels in the interior of WCSAxes plots. [#13829] + + +API Changes +----------- + +astropy.convolution +^^^^^^^^^^^^^^^^^^^ + +- Removed deprecated ``MexicanHat1DKernel`` and ``MexicanHat2DKernel`` + classes. Please use ``RickerWavelet1DKernel`` and + ``RickerWavelet2DKernel`` instead. [#13300] + +astropy.units +^^^^^^^^^^^^^ + +- Multiplying a ``LogQuantity`` like ``Magnitude`` with dimensionless physical + units by an array will no longer downcast to ``Quantity``. [#12579] + +- Quantity normally upcasts integer dtypes to floats, unless the dtype is + specifically provided. + Before this happened when ``dtype=None``; now the default has been changed to + ``dtype=numpy.inexact`` and ``dtype=None`` has the same meaning as in `numpy`. [#12941] + +- In "in-place unit changes" of the form ``quantity <<= new_unit``, the result + will now share memory with the original only if the conversion could be done + through a simple multiplication with a scale factor. Hence, memory will not be + shared if the quantity has integer ```dtype``` or is structured, or when the + conversion is through an equivalency. [#13638] + +- When ``Quantity`` is constructed from a structured array and ``unit`` is + ``None``, the default unit is now structured like the input data. [#13676] + +astropy.utils +^^^^^^^^^^^^^ + +- ``astropy.utils.misc.suppress`` has been removed, use ``contextlib.suppress`` + instead. ``astropy.utils.namedtuple_asdict`` has been removed, instead use + method ``._asdict`` on a ``namedtuple``. ``override__dir__`` has been deprecated + and will be removed in a future version, see the docstring for the better + alternative. [#13636] + +- ``astropy.utils.misc.possible_filename`` has been removed. [#13661] + +astropy.visualization +^^^^^^^^^^^^^^^^^^^^^ + +- Rename number-of-samples keyword ``nsamples`` in ``ZScaleInterval`` to align + with the ``n_samples`` keyword used in all other ``Interval`` classes in + this module. [#13810] + + +Bug Fixes +--------- + +astropy.convolution +^^^^^^^^^^^^^^^^^^^ + +- Fixed convolution Kernels to ensure the that returned kernels + are normalized to sum to one (e.g., ``Gaussian1DKernel``, + ``Gaussian2DKernel``). Also fixed the Kernel ``truncation`` calculation. [#13299] + +- Fix import error with setuptools v65.6.0 by replacing + ``numpy.ctypeslib.load_library`` with Cython to load the C convolution + extension. [#14035] + +astropy.coordinates +^^^^^^^^^^^^^^^^^^^ + +- ``BaseCoordinateFrame.get_frame_attr_names()`` had a misleading name, + because it actually provided a ``dict`` of attribute names and + their default values. It is now deprecated and replaced by ``BaseCoordinateFrame.get_frame_attr_defaults()``. + The fastest way to obtain the attribute names is ``BaseFrame.frame_attributes.keys()``. [#13484] + +- Fixed bug that caused ``earth_orientation.nutation_matrix()`` to error instead of returning output. [#13572] + +- Ensure that ``angle.to_string()`` continues to work after pickling, + and that units passed on to ``to_string()`` or the ``Angle`` + initializer can be composite units (like ``u.hour**1``), which might + result from preceding calculations. [#13933] + +astropy.io.fits +^^^^^^^^^^^^^^^ + +- ``report_diff_values()`` have now two new parameters ``rtol`` and ``atol`` to make the + report consistent with ``numpy.allclose`` results. + This fixes ``FITSDiff`` with multi-dimensional columns. [#13465] + +astropy.io.votable +^^^^^^^^^^^^^^^^^^ + +- Fixed two bugs in validator.validator.make_validation_report: + - ProgressBar iterator was not called correctly. + - make_validation_report now handles input string urls correctly. [#14102] + +astropy.timeseries +^^^^^^^^^^^^^^^^^^ + +- Fixed a performance regression in ``timeseries.aggregate_downsample`` + introduced in Astropy 5.0 / #11266. [#13069] + +astropy.units +^^^^^^^^^^^^^ + +- Unit changes of the form ``quantity <<= new_unit`` will now work also if the + quantity is integer. The result will always be float. This means that the result + will not share memory with the original. [#13638] + +- Ensure dimensionless quantities can be added inplace to regular ndarray. [#13913] + +astropy.utils +^^^^^^^^^^^^^ + +- Fixed an incompatibility with latest Python 3.1x versions that kept + ``astropy.utils.data.download_file`` from switching to TLS+FTP mode. [#14092] + +- ``np.quantile`` and ``np.percentile`` can now be used on ``Masked`` + arrays and quantities also with ``keepdims=True``. [#14113] + +astropy.visualization +^^^^^^^^^^^^^^^^^^^^^ + +- Significantly improve performance of ``ManualInterval`` when both limits + are specified manually. [#13898] + + +Other Changes and Additions +--------------------------- + +- The deprecated private ``astropy._erfa`` module has been removed. Use + ``pyerfa``, which is a dependency of ``astropy`` and can be imported directly + using ``import erfa``. [#13317] + +- The minimum version required for numpy is now 1.20 and that for scipy 1.5. [#13885] + +- Updated the bundled CFITSIO library to 4.2.0. [#14020] + + Version 5.1.1 (2022-10-23) ========================== @@ -153,7 +418,7 @@ astropy.wcs list of changes - see http://www.atnf.csiro.au/people/mcalabre/WCS/CHANGES or `astropy/cextern/wcslib/CHANGES `_. [#13635] -- Fixed WCS validation not working properly if HDUList is needed +- Fixed WCS validation not working properly if HDUList is needed for multi-extension FITS file. [#13668] diff --git a/docs/changes/13317.other.rst b/docs/changes/13317.other.rst deleted file mode 100644 index a36bb0b4dce..00000000000 --- a/docs/changes/13317.other.rst +++ /dev/null @@ -1,3 +0,0 @@ -The deprecated private ``astropy._erfa`` module has been removed. Use -``pyerfa``, which is a dependency of ``astropy`` and can be imported directly -using ``import erfa``. diff --git a/docs/changes/13885.other.rst b/docs/changes/13885.other.rst deleted file mode 100644 index 7793f6a863b..00000000000 --- a/docs/changes/13885.other.rst +++ /dev/null @@ -1 +0,0 @@ -The minimum version required for numpy is now 1.20 and that for scipy 1.5. diff --git a/docs/changes/14020.other.rst b/docs/changes/14020.other.rst deleted file mode 100644 index f30a4129fe9..00000000000 --- a/docs/changes/14020.other.rst +++ /dev/null @@ -1 +0,0 @@ -Updated the bundled CFITSIO library to 4.2.0. diff --git a/docs/changes/convolution/13299.bugfix.rst b/docs/changes/convolution/13299.bugfix.rst deleted file mode 100644 index 0c5390b4165..00000000000 --- a/docs/changes/convolution/13299.bugfix.rst +++ /dev/null @@ -1,3 +0,0 @@ -Fixed convolution Kernels to ensure the that returned kernels -are normalized to sum to one (e.g., ``Gaussian1DKernel``, -``Gaussian2DKernel``). Also fixed the Kernel ``truncation`` calculation. diff --git a/docs/changes/convolution/13300.api.rst b/docs/changes/convolution/13300.api.rst deleted file mode 100644 index 57f9718c1b9..00000000000 --- a/docs/changes/convolution/13300.api.rst +++ /dev/null @@ -1,3 +0,0 @@ -Removed deprecated ``MexicanHat1DKernel`` and ``MexicanHat2DKernel`` -classes. Please use ``RickerWavelet1DKernel`` and -``RickerWavelet2DKernel`` instead. diff --git a/docs/changes/convolution/14035.bugfix.rst b/docs/changes/convolution/14035.bugfix.rst deleted file mode 100644 index 9629af4f953..00000000000 --- a/docs/changes/convolution/14035.bugfix.rst +++ /dev/null @@ -1,3 +0,0 @@ -Fix import error with setuptools v65.6.0 by replacing -``numpy.ctypeslib.load_library`` with Cython to load the C convolution -extension. diff --git a/docs/changes/coordinates/13398.feature.rst b/docs/changes/coordinates/13398.feature.rst deleted file mode 100644 index f238e7544a5..00000000000 --- a/docs/changes/coordinates/13398.feature.rst +++ /dev/null @@ -1,6 +0,0 @@ -Adds new topocentric ITRS frame and direct transforms to and from the observed -frames ``AltAz`` and ``HADec`` with the ability to add or remove refraction -corrections as required. Since these frames are all within the ITRS, there are -no corrections applied other than refraction in the transforms. This makes the -topocentric ITRS frame and these transforms convenient for observers of near -Earth objects where stellar aberration should be omitted. diff --git a/docs/changes/coordinates/13477.feature.rst b/docs/changes/coordinates/13477.feature.rst deleted file mode 100644 index f5165ab915d..00000000000 --- a/docs/changes/coordinates/13477.feature.rst +++ /dev/null @@ -1 +0,0 @@ -Allow comparing ``SkyCoord`` to frames with data. diff --git a/docs/changes/coordinates/13484.bugfix.rst b/docs/changes/coordinates/13484.bugfix.rst deleted file mode 100644 index f8ebee8dc90..00000000000 --- a/docs/changes/coordinates/13484.bugfix.rst +++ /dev/null @@ -1,4 +0,0 @@ -``BaseCoordinateFrame.get_frame_attr_names()`` had a misleading name, -because it actually provided a ``dict`` of attribute names and -their default values. It is now deprecated and replaced by ``BaseCoordinateFrame.get_frame_attr_defaults()``. -The fastest way to obtain the attribute names is ``BaseFrame.frame_attributes.keys()``. diff --git a/docs/changes/coordinates/13572.bugfix.rst b/docs/changes/coordinates/13572.bugfix.rst deleted file mode 100644 index 7e06f7819f7..00000000000 --- a/docs/changes/coordinates/13572.bugfix.rst +++ /dev/null @@ -1 +0,0 @@ -Fixed bug that caused ``earth_orientation.nutation_matrix()`` to error instead of returning output. diff --git a/docs/changes/coordinates/13933.bugfix.rst b/docs/changes/coordinates/13933.bugfix.rst deleted file mode 100644 index f5c967ec8ff..00000000000 --- a/docs/changes/coordinates/13933.bugfix.rst +++ /dev/null @@ -1,4 +0,0 @@ -Ensure that ``angle.to_string()`` continues to work after pickling, -and that units passed on to ``to_string()`` or the ``Angle`` -initializer can be composite units (like ``u.hour**1``), which might -result from preceding calculations. diff --git a/docs/changes/cosmology/13075.feature.rst b/docs/changes/cosmology/13075.feature.rst deleted file mode 100644 index e6206f0aa0e..00000000000 --- a/docs/changes/cosmology/13075.feature.rst +++ /dev/null @@ -1,2 +0,0 @@ -Cosmology instance can be parsed from or converted to a HTML table using -the new HTML methods in Cosmology's ``to/from_format`` I/O. diff --git a/docs/changes/cosmology/13104.feature.rst b/docs/changes/cosmology/13104.feature.rst deleted file mode 100644 index d0e8bca81fa..00000000000 --- a/docs/changes/cosmology/13104.feature.rst +++ /dev/null @@ -1,4 +0,0 @@ -A new comparison function has been added -- ``cosmology_equal()`` -- that -mirrors its ``numpy`` counterpart but allows for the arguments to be converted -to a ``Cosmology`` and to compare flat cosmologies with their non-flat -equivalents. diff --git a/docs/changes/cosmology/13261.feature.rst b/docs/changes/cosmology/13261.feature.rst deleted file mode 100644 index 7e75f3646b2..00000000000 --- a/docs/changes/cosmology/13261.feature.rst +++ /dev/null @@ -1,2 +0,0 @@ -Cosmology equivalence for flat FLRW cosmologies has been generalized to apply -to all cosmologies using the FlatCosmology mixin. diff --git a/docs/changes/cosmology/13561.feature.rst b/docs/changes/cosmology/13561.feature.rst deleted file mode 100644 index a2a61823d61..00000000000 --- a/docs/changes/cosmology/13561.feature.rst +++ /dev/null @@ -1 +0,0 @@ -The cosmological redshift unit now has a physical type of ``"redshift"``. diff --git a/docs/changes/io.ascii/13734.feature.rst b/docs/changes/io.ascii/13734.feature.rst deleted file mode 100644 index 05090543b97..00000000000 --- a/docs/changes/io.ascii/13734.feature.rst +++ /dev/null @@ -1,4 +0,0 @@ -Add ability to read and write a fixed width ASCII table that includes additional -header rows specifying any or all of the column dtype, unit, format, and -description. This is available in the ``fixed_width`` and -``fixed_width_two_line`` formats via the new ``header_rows`` keyword argument. diff --git a/docs/changes/io.fits/13131.feature.rst b/docs/changes/io.fits/13131.feature.rst deleted file mode 100644 index 67211f05a15..00000000000 --- a/docs/changes/io.fits/13131.feature.rst +++ /dev/null @@ -1,3 +0,0 @@ -Added support to the ``io.fits`` API for reading and writing file paths of the -form ``~/file.fits`` or ``~/file.fits``, referring to the home -directory of the current user or the specified user, respectively. diff --git a/docs/changes/io.fits/13238.feature.rst b/docs/changes/io.fits/13238.feature.rst deleted file mode 100644 index 2b00055b30a..00000000000 --- a/docs/changes/io.fits/13238.feature.rst +++ /dev/null @@ -1,2 +0,0 @@ -Added support for opening remote and cloud-hosted FITS files using the -``fsspec`` package, which has been added as an optional dependency. diff --git a/docs/changes/io.fits/13465.bugfix.rst b/docs/changes/io.fits/13465.bugfix.rst deleted file mode 100644 index 4a499e2cab0..00000000000 --- a/docs/changes/io.fits/13465.bugfix.rst +++ /dev/null @@ -1,3 +0,0 @@ -``report_diff_values()`` have now two new parameters ``rtol`` and ``atol`` to make the -report consistent with ``numpy.allclose`` results. -This fixes ``FITSDiff`` with multi-dimensional columns. diff --git a/docs/changes/io.votable/13149.feature.rst b/docs/changes/io.votable/13149.feature.rst deleted file mode 100644 index 061b47977cd..00000000000 --- a/docs/changes/io.votable/13149.feature.rst +++ /dev/null @@ -1,3 +0,0 @@ -Added support in ``io.votable`` for reading and writing file paths of the form -``~/file.xml`` or ``~/file.xml``, referring to the home directory of -the current user or the specified user, respectively. diff --git a/docs/changes/io.votable/14102.bugfix.rst b/docs/changes/io.votable/14102.bugfix.rst deleted file mode 100644 index f6a657259cb..00000000000 --- a/docs/changes/io.votable/14102.bugfix.rst +++ /dev/null @@ -1,3 +0,0 @@ -Fixed two bugs in validator.validator.make_validation_report: -- ProgressBar iterator was not called correctly. -- make_validation_report now handles input string urls correctly. diff --git a/docs/changes/modeling/13259.feature.rst b/docs/changes/modeling/13259.feature.rst deleted file mode 100644 index 2c43b007fd1..00000000000 --- a/docs/changes/modeling/13259.feature.rst +++ /dev/null @@ -1,2 +0,0 @@ -Add option to non-linear fitters which enables automatic -exclusion of non-finite values from the fit data. diff --git a/docs/changes/nddata/13238.feature.rst b/docs/changes/nddata/13238.feature.rst deleted file mode 100644 index 43fe823915f..00000000000 --- a/docs/changes/nddata/13238.feature.rst +++ /dev/null @@ -1,2 +0,0 @@ -Modified ``Cutout2D`` to allow objects of type ``astropy.io.fits.Section`` -to be passed to the ``data`` parameter. \ No newline at end of file diff --git a/docs/changes/nddata/13743.feature.rst b/docs/changes/nddata/13743.feature.rst deleted file mode 100644 index cb2d993eb4f..00000000000 --- a/docs/changes/nddata/13743.feature.rst +++ /dev/null @@ -1 +0,0 @@ -Add a PSF image representation to ``astropy.nddata.NDData`` and ``astropy.nddata.CCDData``. diff --git a/docs/changes/table/13469.feature.rst b/docs/changes/table/13469.feature.rst deleted file mode 100644 index 830a3242667..00000000000 --- a/docs/changes/table/13469.feature.rst +++ /dev/null @@ -1,3 +0,0 @@ -An Astropy table can now be converted to a scalar NumPy object array. For NumPy ->= 1.20, a list of Astropy tables can be converted to an NumPy object array of -tables. diff --git a/docs/changes/time/13508.feature.rst b/docs/changes/time/13508.feature.rst deleted file mode 100644 index d6dffaa3b3d..00000000000 --- a/docs/changes/time/13508.feature.rst +++ /dev/null @@ -1 +0,0 @@ -Added the ``astropy.time.Time.mean()`` method which also enables the ``numpy.mean()`` function to be used on instances of ``astropy.time.Time``. diff --git a/docs/changes/time/13555.feature.rst b/docs/changes/time/13555.feature.rst deleted file mode 100644 index 29b3737241d..00000000000 --- a/docs/changes/time/13555.feature.rst +++ /dev/null @@ -1,4 +0,0 @@ -Improve the performance of getting the string representation of a large ``Time`` -or ``TimeDelta`` object. This is done via a new ``to_string()`` method that does -the time string format conversion only for the outputted values. Previously the -entire array was formatted in advance. diff --git a/docs/changes/timeseries/13069.bugfix.rst b/docs/changes/timeseries/13069.bugfix.rst deleted file mode 100644 index d90f71d3496..00000000000 --- a/docs/changes/timeseries/13069.bugfix.rst +++ /dev/null @@ -1,2 +0,0 @@ -Fixed a performance regression in ``timeseries.aggregate_downsample`` -introduced in Astropy 5.0 / #11266. diff --git a/docs/changes/units/12579.api.rst b/docs/changes/units/12579.api.rst deleted file mode 100644 index a399020a82f..00000000000 --- a/docs/changes/units/12579.api.rst +++ /dev/null @@ -1,2 +0,0 @@ -Multiplying a ``LogQuantity`` like ``Magnitude`` with dimensionless physical -units by an array will no longer downcast to ``Quantity``. diff --git a/docs/changes/units/12941.api.rst b/docs/changes/units/12941.api.rst deleted file mode 100644 index d77244912d6..00000000000 --- a/docs/changes/units/12941.api.rst +++ /dev/null @@ -1,4 +0,0 @@ -Quantity normally upcasts integer dtypes to floats, unless the dtype is -specifically provided. -Before this happened when ``dtype=None``; now the default has been changed to -``dtype=numpy.inexact`` and ``dtype=None`` has the same meaning as in `numpy`. diff --git a/docs/changes/units/13050.feature.rst b/docs/changes/units/13050.feature.rst deleted file mode 100644 index ba9b4efe00a..00000000000 --- a/docs/changes/units/13050.feature.rst +++ /dev/null @@ -1,3 +0,0 @@ -It is now possible to use unit format names as string format specifiers for a -``Quantity``, e.g. ``f'{1e12*u.m/u.s:latex_inline}'`` now produces the string -``'$1 \\times 10^{12} \\; \\mathrm{m\\,s^{-1}}$'``. diff --git a/docs/changes/units/13329.feature.rst b/docs/changes/units/13329.feature.rst deleted file mode 100644 index bc3fd84a83b..00000000000 --- a/docs/changes/units/13329.feature.rst +++ /dev/null @@ -1,2 +0,0 @@ -Ensure that the ``argmin`` and ``argmax`` methods of ``Quantity`` support the -``keepdims`` argument when numpy does (numpy version 1.22 and later). diff --git a/docs/changes/units/13638.api.rst b/docs/changes/units/13638.api.rst deleted file mode 100644 index cad6274fa84..00000000000 --- a/docs/changes/units/13638.api.rst +++ /dev/null @@ -1,5 +0,0 @@ -In "in-place unit changes" of the form ``quantity <<= new_unit``, the result -will now share memory with the original only if the conversion could be done -through a simple multiplication with a scale factor. Hence, memory will not be -shared if the quantity has integer ```dtype``` or is structured, or when the -conversion is through an equivalency. diff --git a/docs/changes/units/13638.bugfix.rst b/docs/changes/units/13638.bugfix.rst deleted file mode 100644 index 5683f94a31e..00000000000 --- a/docs/changes/units/13638.bugfix.rst +++ /dev/null @@ -1,3 +0,0 @@ -Unit changes of the form ``quantity <<= new_unit`` will now work also if the -quantity is integer. The result will always be float. This means that the result -will not share memory with the original. diff --git a/docs/changes/units/13669.feature.rst b/docs/changes/units/13669.feature.rst deleted file mode 100644 index 0186a434904..00000000000 --- a/docs/changes/units/13669.feature.rst +++ /dev/null @@ -1,2 +0,0 @@ -``numpy.lib.recfunctions.merge_arrays()`` is registered with numpy overload for -``Quantity``. diff --git a/docs/changes/units/13676.api.rst b/docs/changes/units/13676.api.rst deleted file mode 100644 index 966372f06ce..00000000000 --- a/docs/changes/units/13676.api.rst +++ /dev/null @@ -1,2 +0,0 @@ -When ``Quantity`` is constructed from a structured array and ``unit`` is -``None``, the default unit is now structured like the input data. diff --git a/docs/changes/units/13913.bugfix.rst b/docs/changes/units/13913.bugfix.rst deleted file mode 100644 index 02e125fdc9e..00000000000 --- a/docs/changes/units/13913.bugfix.rst +++ /dev/null @@ -1 +0,0 @@ -Ensure dimensionless quantities can be added inplace to regular ndarray. diff --git a/docs/changes/units/14046.feature.rst b/docs/changes/units/14046.feature.rst deleted file mode 100644 index baccc3cd315..00000000000 --- a/docs/changes/units/14046.feature.rst +++ /dev/null @@ -1,3 +0,0 @@ -Added SI prefixes for quecto ("q", :math:`10^{-30}`), ronto ("r", -:math:`10^{-27}`), ronna ("R", :math:`10^{27}`), and quetta ("Q", -:math:`10^{30}`). diff --git a/docs/changes/utils/13238.feature.rst b/docs/changes/utils/13238.feature.rst deleted file mode 100644 index e4d021a3b9a..00000000000 --- a/docs/changes/utils/13238.feature.rst +++ /dev/null @@ -1,2 +0,0 @@ -Added the ``use_fsspec``, ``fsspec_kwargs``, and ``close_files`` arguments -to ``utils.data.get_readable_fileobj``. diff --git a/docs/changes/utils/13329.feature.rst b/docs/changes/utils/13329.feature.rst deleted file mode 100644 index 4e0edadb53e..00000000000 --- a/docs/changes/utils/13329.feature.rst +++ /dev/null @@ -1,3 +0,0 @@ -Ensure that the ``argmin`` and ``argmax`` methods of ``Masked`` instances -support the ``keepdims`` argument when numpy does (numpy version 1.22 and -later). diff --git a/docs/changes/utils/13636.api.rst b/docs/changes/utils/13636.api.rst deleted file mode 100644 index 2e4f55c91f5..00000000000 --- a/docs/changes/utils/13636.api.rst +++ /dev/null @@ -1,5 +0,0 @@ -``astropy.utils.misc.suppress`` has been removed, use ``contextlib.suppress`` -instead. ``astropy.utils.namedtuple_asdict`` has been removed, instead use -method ``._asdict`` on a ``namedtuple``. ``override__dir__`` has been deprecated -and will be removed in a future version, see the docstring for the better -alternative. diff --git a/docs/changes/utils/13661.api.rst b/docs/changes/utils/13661.api.rst deleted file mode 100644 index 9005b34658c..00000000000 --- a/docs/changes/utils/13661.api.rst +++ /dev/null @@ -1 +0,0 @@ -``astropy.utils.misc.possible_filename`` has been removed. diff --git a/docs/changes/utils/14092.bugfix.rst b/docs/changes/utils/14092.bugfix.rst deleted file mode 100644 index 7cf04cf31ba..00000000000 --- a/docs/changes/utils/14092.bugfix.rst +++ /dev/null @@ -1,2 +0,0 @@ -Fixed an incompatibility with latest Python 3.1x versions that kept -``astropy.utils.data.download_file`` from switching to TLS+FTP mode. diff --git a/docs/changes/utils/14113.bugfix.rst b/docs/changes/utils/14113.bugfix.rst deleted file mode 100644 index e47eb285748..00000000000 --- a/docs/changes/utils/14113.bugfix.rst +++ /dev/null @@ -1,2 +0,0 @@ - ``np.quantile`` and ``np.percentile`` can now be used on ``Masked`` - arrays and quantities also with ``keepdims=True``. diff --git a/docs/changes/visualization/12102.feature.rst b/docs/changes/visualization/12102.feature.rst deleted file mode 100644 index 5a851c73c28..00000000000 --- a/docs/changes/visualization/12102.feature.rst +++ /dev/null @@ -1 +0,0 @@ -Add helper functions for WCSAxes instances to draw the instrument beam and a physical scale. diff --git a/docs/changes/visualization/13562.feature.rst b/docs/changes/visualization/13562.feature.rst deleted file mode 100644 index cfc1031cb32..00000000000 --- a/docs/changes/visualization/13562.feature.rst +++ /dev/null @@ -1,2 +0,0 @@ -Add a ``scatter_coord`` method to the ``wcsaxes`` functionality based on the -existing ``plot_coord`` method but that calls ``matplotlib.pyplot.scatter``. diff --git a/docs/changes/visualization/13746.feature.rst b/docs/changes/visualization/13746.feature.rst deleted file mode 100644 index 4aae55a1998..00000000000 --- a/docs/changes/visualization/13746.feature.rst +++ /dev/null @@ -1 +0,0 @@ -Added a ``sinh`` stretch option to ``simple_norm``. diff --git a/docs/changes/visualization/13810.api.rst b/docs/changes/visualization/13810.api.rst deleted file mode 100644 index 5077cead1b5..00000000000 --- a/docs/changes/visualization/13810.api.rst +++ /dev/null @@ -1,3 +0,0 @@ -Rename number-of-samples keyword ``nsamples`` in ``ZScaleInterval`` to align -with the ``n_samples`` keyword used in all other ``Interval`` classes in -this module. diff --git a/docs/changes/visualization/13829.feature.rst b/docs/changes/visualization/13829.feature.rst deleted file mode 100644 index b8e3aae96be..00000000000 --- a/docs/changes/visualization/13829.feature.rst +++ /dev/null @@ -1 +0,0 @@ -It is now possible to define "tickable" gridlines for the purpose of placing ticks or tick labels in the interior of WCSAxes plots. diff --git a/docs/changes/visualization/13898.bugfix.rst b/docs/changes/visualization/13898.bugfix.rst deleted file mode 100644 index 8e77b25cecd..00000000000 --- a/docs/changes/visualization/13898.bugfix.rst +++ /dev/null @@ -1,2 +0,0 @@ -Significantly improve performance of ``ManualInterval`` when both limits -are specified manually.