forked from pool/python-astropy
Compare commits
14 Commits
Author | SHA256 | Date | |
---|---|---|---|
452482f367 | |||
5df760a9b7 | |||
d1fed10386 | |||
a67f4d1b46 | |||
cf78dec249 | |||
2381f7df5c | |||
925ed10f5d | |||
8f49b0399e | |||
6532101c85 | |||
dd1f482b1e | |||
b3a96b79c9 | |||
f483cb03d6 | |||
cdedbbd299 | |||
51c7b77f4a |
@@ -1,3 +0,0 @@
|
|||||||
version https://git-lfs.github.com/spec/v1
|
|
||||||
oid sha256:9ac834cdedc1f6b5ce6f941f7bfbbfc58fca861eb172bcf72dd90aff8f750970
|
|
||||||
size 7057076
|
|
3
astropy-7.1.0.tar.gz
Normal file
3
astropy-7.1.0.tar.gz
Normal file
@@ -0,0 +1,3 @@
|
|||||||
|
version https://git-lfs.github.com/spec/v1
|
||||||
|
oid sha256:c8f254322295b1b8cf24303d6f155bf7efdb6c1282882b966ce3040eff8c53c5
|
||||||
|
size 6976116
|
@@ -1,3 +1,418 @@
|
|||||||
|
-------------------------------------------------------------------
|
||||||
|
Wed Jul 23 11:26:33 UTC 2025 - Ben Greiner <code@bnavigator.de>
|
||||||
|
|
||||||
|
- Update to 7.1.0
|
||||||
|
## New Features
|
||||||
|
### astropy.coordinates
|
||||||
|
* search_around_sky and search_around_3D now accept
|
||||||
|
separations/distlimits broadcastable to the same shape as
|
||||||
|
coords1. [#17824]
|
||||||
|
### astropy.io.ascii
|
||||||
|
* Add functionality to read and write to a Table from the TDAT
|
||||||
|
format as part of the Unified File Read/Write Interface.
|
||||||
|
[#16780]
|
||||||
|
* io.ascii now supports on-the-fly decompression of
|
||||||
|
LZW-compressed files (typically “.Z” extension) via the
|
||||||
|
optional package uncompresspy. [#17960]
|
||||||
|
### astropy.io.fits
|
||||||
|
* Astropy can now not only read but also write headers that have
|
||||||
|
HIERARCH keys with long values, by allowing the use of CONTINUE
|
||||||
|
cards for those (as was already the case for regular FITS
|
||||||
|
keys). [#17748]
|
||||||
|
* Add strip_spaces option to Table.read to strip trailing
|
||||||
|
whitespaces in string columns. This will be activated by
|
||||||
|
default in the next major release. [#17777]
|
||||||
|
* io.fits now supports on-the-fly decompression of LZW-compressed
|
||||||
|
files (typically “.Z” extension) via the optional package
|
||||||
|
uncompresspy. [#17960]
|
||||||
|
* io.fits now supports on-the-fly decompression of
|
||||||
|
LZMA-compressed files (typically “.xz” extension) if the lzma
|
||||||
|
module is provided by the Python installation. [#17968]
|
||||||
|
### astropy.io.misc
|
||||||
|
* Add a fast Table CSV reader that uses the PyArrow read_csv()
|
||||||
|
function. This can be significantly faster and more
|
||||||
|
memory-efficient than the astropy.io.ascii fast reader. This
|
||||||
|
new reader can be used with Table.read() by setting
|
||||||
|
format="pyarrow.csv". [#17706]
|
||||||
|
### astropy.io.votable
|
||||||
|
* New module astropy.io.votable.dataorigin to extract Data Origin
|
||||||
|
information from INFO in VOTable. [#17839]
|
||||||
|
* CooSys VOTable elements now have a method to_astropy_frame that
|
||||||
|
returns the corresponding astropy built-in frame, when
|
||||||
|
possible. [#17999]
|
||||||
|
### astropy.modeling
|
||||||
|
* Added a fit_info= keyword argument to parallel_fit_dask to
|
||||||
|
allow users to preserve fit information from each individual
|
||||||
|
fit. [#17538]
|
||||||
|
### astropy.nddata
|
||||||
|
* Adds a utility class, astropy.nddata.Covariance, used to
|
||||||
|
construct, access, and store covariance matrices. The class
|
||||||
|
depends on use of the scipy.sparse module. [#16690]
|
||||||
|
* Add the limit_rounding_method parameter to Cutout2D,
|
||||||
|
overlap_slices, extract_array, and add_array to allow users to
|
||||||
|
specify the rounding method used when calculating the pixel
|
||||||
|
limits of the cutout. The default method is to use ceil.
|
||||||
|
[#17876]
|
||||||
|
### astropy.table
|
||||||
|
* Document that Table.group_by’s underlying sorting algorithm is
|
||||||
|
guaranteed to be stable. This reflects behavior that was
|
||||||
|
already present but undocumented, at least since astropy 6.0 .
|
||||||
|
[#17676]
|
||||||
|
### astropy.timeseries
|
||||||
|
* Downsampling now works correctly also on MaskedColumn and
|
||||||
|
MaskedQuantity with possibly masked elements. Furthermore, the
|
||||||
|
type of (Masked) column will now be properly preserved in
|
||||||
|
downsampling. [#18023]
|
||||||
|
### astropy.units
|
||||||
|
* Units with the “micro” prefix can now be imported using "μ" in
|
||||||
|
the name. For example, the microgram can now be imported with
|
||||||
|
from astropy.units import μg. [#17651]
|
||||||
|
* It is now possible to import angström, litre and ohm from
|
||||||
|
astropy.units using the Å, ℓ and Ω symbols. [#17829]
|
||||||
|
* Unit conversions between kelvins and degrees Rankine no longer
|
||||||
|
require the temperature equivalency. [#17985]
|
||||||
|
### astropy.utils
|
||||||
|
* Make commonly used Masked subclasses importable for ASDF
|
||||||
|
support.
|
||||||
|
* Registered types associated with ASDF converters must be
|
||||||
|
importable by their fully qualified name. Masked classes are
|
||||||
|
dynamically created and have apparent names like
|
||||||
|
astropy.utils.masked.core.MaskedQuantity although they aren’t
|
||||||
|
actually attributes of this module. Customize module attribute
|
||||||
|
lookup so that certain commonly used Masked classes are
|
||||||
|
importable.
|
||||||
|
* See:
|
||||||
|
- https://asdf.readthedocs.io/en/latest/asdf/extending/converters.html#entry-point-performance-considerations
|
||||||
|
- gh#astropy/asdf-astropy#253 [#17685]
|
||||||
|
* astropy.utils.data.download_file can now recover from a
|
||||||
|
TimeoutError when given a list of alternative source URLs.
|
||||||
|
Previously, only URLError exceptions were recoverable. An
|
||||||
|
exception is still being raised after trying all URLs provided
|
||||||
|
if none of them could be reached. [#17691]
|
||||||
|
* utils.data now supports on-the-fly decompression of
|
||||||
|
LZW-compressed files (typically “.Z” extension) via the
|
||||||
|
optional package uncompresspy. [#17960]
|
||||||
|
## API Changes
|
||||||
|
### astropy.coordinates
|
||||||
|
* On representations the method get_name has been deprecated in
|
||||||
|
favor of the class-level attribute name. The method will be
|
||||||
|
removed in a future release. [#17503]
|
||||||
|
### astropy.cosmology
|
||||||
|
* A new public module, astropy.cosmology.io, has been added to
|
||||||
|
provide support for reading, writing, and converting cosmology
|
||||||
|
instances.
|
||||||
|
* The private modules astropy.cosmology.funcs,
|
||||||
|
astropy.cosmology.parameter, astropy.cosmology.connect,
|
||||||
|
astropy.cosmology.core, and astropy.cosmology.flrw have been
|
||||||
|
deprecated. Their functionality remains accessible in the
|
||||||
|
astropy.cosmology module or in the new astropy.cosmology.io
|
||||||
|
module. [#17543]
|
||||||
|
* Comoving distances now accept an optional 2nd argument, where
|
||||||
|
the two-argument form is the comoving distance between two
|
||||||
|
redshifts. The one-argument form is the comoving distance from
|
||||||
|
redshift 0 to the input redshift. [#17701]
|
||||||
|
* A new public module, astropy.cosmology.traits, has been added
|
||||||
|
to provide building blocks for custom cosmologies. The
|
||||||
|
currently available traits are: -
|
||||||
|
astropy.cosmology.traits.ScaleFactor -
|
||||||
|
astropy.cosmology.traits.TemperatureCMB [#17702]
|
||||||
|
### astropy.extern
|
||||||
|
* Astropy used to bundle the javascript libraries jQuery and
|
||||||
|
DataTables for interactive (e.g. sorting by column values)
|
||||||
|
tables using the show_in_browser() method. This bundling
|
||||||
|
requires relatively large files in astropy itself, for a
|
||||||
|
relatively minor feature. Furthermore, the astropy developers
|
||||||
|
are not experts in javascript development, and javascript
|
||||||
|
libraries many need updates to improve on security
|
||||||
|
vulnerabilities. This change removes the bundled versions of
|
||||||
|
jQuery and DataTables from astropy, updates the default version
|
||||||
|
of the remote URLs to version 2.1.8 of DataTables, and sets the
|
||||||
|
default for show_in_browser(use_local_files=False) to use the
|
||||||
|
remote versions in all cases. If the method is called with
|
||||||
|
use_local_files=True, a warning is displayed and remote version
|
||||||
|
are used anyway. This may break the use of the method when
|
||||||
|
working offline, unless the javascript files are cached by the
|
||||||
|
browser from a previous online session. [#17521]
|
||||||
|
### astropy.table
|
||||||
|
* showtable CLI is now deprecated to avoid a name clash on
|
||||||
|
Debian; use showtable-astropy instead. [#18047]
|
||||||
|
* Fix issues in the handling of a call like tbl.loc[item] or
|
||||||
|
tbl.loc_indices[item] and make the behavior consistent with
|
||||||
|
pandas. Here tbl is a Table or QTable with an index defined.
|
||||||
|
* If item is an empty list or zero-length np.ndarray or an empty
|
||||||
|
slice, then previously tbl.loc[item] would raise a KeyError
|
||||||
|
exception. Now it returns the zero-length table tbl[[]].
|
||||||
|
* If item is a one-element list like ["foo"], then previously
|
||||||
|
tbl.loc[item] would return either a Row or a Table with
|
||||||
|
multiple row, depending on whether the index was unique. Now it
|
||||||
|
always returns a Table, consistent with behavior for
|
||||||
|
tbl.loc[[]] and tbl.loc[["foo", "bar"]].
|
||||||
|
* See astropy/astropy#18051 for more details. [#18051]
|
||||||
|
### astropy.units
|
||||||
|
* Passing fraction='multiline' to unit.to_string() will no longer
|
||||||
|
raise an exception if the given format does not support
|
||||||
|
multiline fractions, but rather give a warning and use an
|
||||||
|
inline fraction. [#17374]
|
||||||
|
* Automatic conversion of a str or bytes instance to a unit when
|
||||||
|
it is multiplied or divided with an existing unit or quantity
|
||||||
|
is deprecated. [#17586]
|
||||||
|
* Accessing the contents of the units.deprecated module now emits
|
||||||
|
deprecation warnings. The module may be removed in a future
|
||||||
|
version. [#17929]
|
||||||
|
### astropy.visualization
|
||||||
|
* All arguments from simple_norm are marked as future
|
||||||
|
keyword-only, with the exception of the first two (data and
|
||||||
|
stretch). A warning is now displayed if any other arguments are
|
||||||
|
passed positionally. [#17489]
|
||||||
|
## Bug Fixes
|
||||||
|
### astropy.io.fits
|
||||||
|
* Fix possible int overflow in the tile compression C code.
|
||||||
|
[#17995]
|
||||||
|
### astropy.io.votable
|
||||||
|
* In CooSys elements, the system was not checked for votable
|
||||||
|
version 1.5 [#17999]
|
||||||
|
### astropy.samp
|
||||||
|
* Fix setting logging level from the samp_hub command line.
|
||||||
|
Previously, samp_hub --log-level OFF was documented as
|
||||||
|
supported but actually caused an exception to be raised. The
|
||||||
|
patch infers valid choices from the standard library’s logging
|
||||||
|
module. A CRITICAL level will closely emulate the intended OFF
|
||||||
|
setting. [#17673]
|
||||||
|
### astropy.table
|
||||||
|
* Initializing a Table with rows or data set to [] or a numpy
|
||||||
|
array with zero size (e.g., np.array([[], []])) is now
|
||||||
|
equivalent to Table(data=None, ...) and creates a table with no
|
||||||
|
data values. This allows defining the table names and/or dtype
|
||||||
|
when creating the table, for instance: Table(rows=[],
|
||||||
|
names=["a", "b"], dtype=[int, float]). Previously this raised
|
||||||
|
an exception. [#17717]
|
||||||
|
* Fix issues in the handling of a call like tbl.loc[item] or
|
||||||
|
tbl.loc_indices[item] and make the behavior consistent with
|
||||||
|
pandas. Here tbl is a Table or QTable with an index defined.
|
||||||
|
* If item is an empty list or zero-length np.ndarray or an empty
|
||||||
|
slice, then previously tbl.loc[item] would raise a KeyError
|
||||||
|
exception. Now it returns the zero-length table tbl[[]].
|
||||||
|
* If item is a one-element list like ["foo"], then previously
|
||||||
|
tbl.loc[item] would return either a Row or a Table with
|
||||||
|
multiple row, depending on whether the index was unique. Now it
|
||||||
|
always returns a Table, consistent with behavior for
|
||||||
|
tbl.loc[[]] and tbl.loc[["foo", "bar"]].
|
||||||
|
* See astropy/astropy#18051 for more details. [#18051]
|
||||||
|
### astropy.timeseries
|
||||||
|
* Made TimeSeries.from_pandas and BinnedTimeSeries.read more
|
||||||
|
robust to subclassing. [#17351]
|
||||||
|
### astropy.units
|
||||||
|
* For the Angstrom unit in the CDS module, u.cds.Angstrom, the
|
||||||
|
string representation is now “Angstrom” (instead of “AA”),
|
||||||
|
consistent with what was always the case for u.Angstrom, and
|
||||||
|
conformant with the CDS standard. [#17536]
|
||||||
|
* Previously the string representation of the solMass unit in the
|
||||||
|
"cds" format depended on whether the unit was imported directly
|
||||||
|
from units or from units.cds. Although both representations
|
||||||
|
were valid according to the CDS standard, the inconsistency was
|
||||||
|
nonetheless needlessly surprising. The representation of
|
||||||
|
units.cds.solMass has been changed to match the representation
|
||||||
|
of units.solMass. [#17560]
|
||||||
|
* The degrees Rankine is now represented as
|
||||||
|
“$mathrm{{}^{circ}R}$” in the "latex" and "latex_inline"
|
||||||
|
formats and as “°R” in the "unicode" format. [#18049]
|
||||||
|
### astropy.utils
|
||||||
|
* Properly detect invalid LZMA files in utils.data. [#17984]
|
||||||
|
### astropy.visualization
|
||||||
|
* Fixed an issue when using plot_coord after slicing the WCS
|
||||||
|
object coordinates. [#18005]
|
||||||
|
## Performance Improvements
|
||||||
|
### astropy.timeseries
|
||||||
|
* Improved the aggregate_downsample performance using a new
|
||||||
|
default aggregate_func. [#17574]
|
||||||
|
### astropy.units
|
||||||
|
* Converting strings to units with Unit() is now up to 225%
|
||||||
|
faster. [#17399]
|
||||||
|
* UnitBase.compose() is now 20% faster. [#17425]
|
||||||
|
## Other Changes and Additions
|
||||||
|
* After import astropy, dir(astropy) will now list all
|
||||||
|
subpackages, including those that have not yet been loaded.
|
||||||
|
This also means tab completion will work as expected (e.g.,
|
||||||
|
from astropy.coo<TAB> will expand to from astropy.coordinates).
|
||||||
|
[#17598]
|
||||||
|
* Updated bundled WCSLIB version to 8.4, fixing issues in
|
||||||
|
wcs_chksum and wcs_fletcher32. For a full list of changes - see
|
||||||
|
astropy/cextern/wcslib/CHANGES. [#17886]
|
||||||
|
|
||||||
|
-------------------------------------------------------------------
|
||||||
|
Thu Mar 6 08:32:13 UTC 2025 - Ben Greiner <code@bnavigator.de>
|
||||||
|
|
||||||
|
- Suppress another hypothesis health check for the test suite
|
||||||
|
|
||||||
|
-------------------------------------------------------------------
|
||||||
|
Sun Feb 9 13:15:53 UTC 2025 - Ben Greiner <code@bnavigator.de>
|
||||||
|
|
||||||
|
- Update to 7.0.1
|
||||||
|
## API Changes
|
||||||
|
### astropy.table
|
||||||
|
* The use of the keyword use_local_files for the js viewer in
|
||||||
|
astropy.table.Table.show_in_browser is now deprecated.
|
||||||
|
Starting in Astropy 7.1 this keyword will be ignored and use
|
||||||
|
of it will issue a warning. The default behavior will be to
|
||||||
|
use the remote versions of jQuery and DataTables from a CDN.
|
||||||
|
[#17480]
|
||||||
|
## Bugfixes for:
|
||||||
|
* astropy.config
|
||||||
|
* astropy.coordinates
|
||||||
|
* astropy.io.ascii
|
||||||
|
* astropy.io.fits
|
||||||
|
* astropy.io.votable
|
||||||
|
* astropy.modeling
|
||||||
|
* astropy.table
|
||||||
|
* astropy.units
|
||||||
|
* astropy.visualization
|
||||||
|
- Major Release 7.0.0
|
||||||
|
* See https://docs.astropy.org/en/stable/whatsnew/7.0.html
|
||||||
|
for a detailed changelog. Headlines include:
|
||||||
|
* Full MaskedQuantity Support in QTable
|
||||||
|
* Coordinate frames can now be stored in tables
|
||||||
|
* Table show_in_notebook is back with ipydatagrid
|
||||||
|
* Ordering of table columns constructed from rows
|
||||||
|
* Table.pformat is now independent of terminal dimensions
|
||||||
|
* Quantity.to_string supports formatter for formatting
|
||||||
|
* NumPy constructor functions with a like argument are now supported with Quantity
|
||||||
|
* Change default type for meta attribute to dict and update ECSV writer
|
||||||
|
* Improve the Contributor Documentation
|
||||||
|
* Typing in astropy.stats
|
||||||
|
* Converting units on dask and other array-like objects
|
||||||
|
* Performance improvements in astropy.modeling
|
||||||
|
* Fitting models in parallel with N-dimensional data
|
||||||
|
* RGB image visualization enhancements
|
||||||
|
* New Lorentz2D model
|
||||||
|
* Faster guessing of formats in astropy.io.ascii
|
||||||
|
* Support VOTable version 1.5
|
||||||
|
* New SimpleNorm class
|
||||||
|
* New SigmaClippedStats class
|
||||||
|
* Automatic placement of axis and tick labels for WCSAxes
|
||||||
|
* Support for masks in coordinates
|
||||||
|
|
||||||
|
-------------------------------------------------------------------
|
||||||
|
Wed Nov 27 15:43:23 UTC 2024 - Ben Greiner <code@bnavigator.de>
|
||||||
|
|
||||||
|
- Update to 6.1.7
|
||||||
|
* Fix an issue in sigma-clipping where the use of np.copy() was
|
||||||
|
causing the input data mask to be discarded in cases where grow
|
||||||
|
was set. [#17402]
|
||||||
|
|
||||||
|
-------------------------------------------------------------------
|
||||||
|
Tue Nov 19 12:48:19 UTC 2024 - Dirk Müller <dmueller@suse.com>
|
||||||
|
|
||||||
|
- update to 6.1.6:
|
||||||
|
* Fixed instantiating Angle from a pandas Series object.
|
||||||
|
* Fixed calling np.nanvar and np.nanstd with Quantity out
|
||||||
|
argument.
|
||||||
|
|
||||||
|
-------------------------------------------------------------------
|
||||||
|
Fri Nov 8 14:50:37 UTC 2024 - Ben Greiner <code@bnavigator.de>
|
||||||
|
|
||||||
|
- Update to 6.1.5
|
||||||
|
## Bug Fixes
|
||||||
|
### astropy.coordinates
|
||||||
|
* Ensure that coordinates can be transformed to other coordinate
|
||||||
|
frames also if they have size zero (i.e., hold empty data
|
||||||
|
arrays). [#17013]
|
||||||
|
* Longitude and Latitude can no longer be initialized with
|
||||||
|
strings ending in “N” or “S”, and “E” or “W”, respectively,
|
||||||
|
since those suggest the other type. [#17132]
|
||||||
|
* np.nanvar(angle) now produces a Quantity with the correct unit,
|
||||||
|
rather than raising an exception. [#17239]
|
||||||
|
* Fix a crash when instantiating Angle (or Latitude, or
|
||||||
|
Longitude) from a non-numpy array (for instance pyarrow
|
||||||
|
arrays). [#17263]
|
||||||
|
### astropy.io.fits
|
||||||
|
* Fix access to VLA columns after slicing .data. [#16996]
|
||||||
|
### astropy.io.votable
|
||||||
|
* Updated xml writer for VOTable Resource elements to include
|
||||||
|
groups. [#17344]
|
||||||
|
### astropy.nddata
|
||||||
|
* Add support for positional only and keyword only arguments when
|
||||||
|
using the support_nddata decorator. [#17281]
|
||||||
|
### astropy.stats
|
||||||
|
* Fixed a bug where float32 inputs to sigma_clip and SigmaClip
|
||||||
|
were changed to float. [#17086]
|
||||||
|
### astropy.table
|
||||||
|
* Fix a crash when calling Column.pprint on a scalar column.
|
||||||
|
[#15749]
|
||||||
|
* Ensure that setting an existing column to a scalar always
|
||||||
|
properly fills it (rather than breaking the table if there was
|
||||||
|
only one column in it). [#17105]
|
||||||
|
### astropy.units
|
||||||
|
* The unit parsers are now better at recognizing unusual
|
||||||
|
composite units:
|
||||||
|
- units involving special unicode symbols, like “L☉/pc²”;
|
||||||
|
- units that include CDS units ending in a 0, like “eps0/s”;
|
||||||
|
- units including the degree symbol, “°”. For example, “°C/s”
|
||||||
|
is no longer incorrectly interpreted as “°C/s^2”. [#17011]
|
||||||
|
* Converting the ohm to a string with the OGIP unit formatter
|
||||||
|
(e.g. f"{u.ohm:ogip}") previously produced the string 'V / A',
|
||||||
|
but now produces 'ohm' as expected. [#17200]
|
||||||
|
* The OGIP unit formatter now handles the unit day and the
|
||||||
|
corresponding string "d" in full compliance with the standard.
|
||||||
|
[#17216]
|
||||||
|
* The "ogip" unit format now represents the unit angstrom as
|
||||||
|
"angstrom" instead of "0.1 nm". [#17241]
|
||||||
|
### astropy.utils
|
||||||
|
* Ensure that queries of .ut1_utc() and .pm_xy() return the
|
||||||
|
correct results also when passing in an empty array of times.
|
||||||
|
[#17013]
|
||||||
|
* Fixed a bug where astropy’s logger wouldn’t perform lazy string
|
||||||
|
interpolation. [#17196]
|
||||||
|
### astropy.visualization
|
||||||
|
* Fixed a bug that caused CoordinateHelper.get_axislabel() to
|
||||||
|
return an empty string instead of the default label if no label
|
||||||
|
has been explicitly provided. [#17175]
|
||||||
|
### astropy.wcs
|
||||||
|
* Fixed a bug that caused WCS.slice to ignore numpy_order and
|
||||||
|
always interpret the slices as if numpy_order was True, in the
|
||||||
|
specific case where the slices were such that dimensions in the
|
||||||
|
WCS would be dropped. [#17147]
|
||||||
|
- Release 6.1.4
|
||||||
|
## Bug Fixes
|
||||||
|
### astropy.coordinates
|
||||||
|
* Keep Latitude from printing long input arrays in their entirety
|
||||||
|
when failing limits check in _validate_angles, indicating their
|
||||||
|
range instead. [#13997]
|
||||||
|
* Avoid some components not being included in table output of
|
||||||
|
coordinates if the representation type was "unitspherical".
|
||||||
|
* In the process, also ensured that one can pass in the
|
||||||
|
radial_velocity keyword argument if one uses
|
||||||
|
differential_type="radial". [#16999]
|
||||||
|
### astropy.io.votable
|
||||||
|
* Ensure proper handling of null values during BINARY2
|
||||||
|
serialization. Previously, masks were handled in two different
|
||||||
|
ways for BINARY2 serialization, resulting in incorrect handling
|
||||||
|
of null values and errors. [#16091]
|
||||||
|
### astropy.stats
|
||||||
|
* Fixed a bug in biweight_location, biweight_scale, and
|
||||||
|
biweight_midvariance where the returned array shape would be
|
||||||
|
wrong if the input array had an axis length of 1 along any axis
|
||||||
|
that was not included in the axis keyword. Also fixed a bug in
|
||||||
|
these same functions where for constant data and axis set to a
|
||||||
|
tuple containing all axes, the returned value would be NaN
|
||||||
|
instead of the constant value. [#16964]
|
||||||
|
### astropy.table
|
||||||
|
* Ensure that initializing a QTable with explicit units` also
|
||||||
|
succeeds if one of the units is u.one. [#17048]
|
||||||
|
### astropy.units
|
||||||
|
* An exception is now raised if it is attempted to create a unit
|
||||||
|
with a scale of zero, avoiding bugs further downstream
|
||||||
|
(including surprising ones, such as a comparison of
|
||||||
|
np.ma.masked == u.one leading to a ZeroDivisionError). [#17048]
|
||||||
|
### astropy.wcs
|
||||||
|
* Fix a bug that caused the results from
|
||||||
|
local_partial_pixel_derivative to be incorrect when using
|
||||||
|
normalize_by_world=True (the matrix was previously normalized
|
||||||
|
along the wrong axis) [#17003]
|
||||||
|
## Other Changes and Additions
|
||||||
|
* Minimal requirement for (optional dependency) matplotlib was
|
||||||
|
bumped to 3.5.0, which is the oldest version with support for
|
||||||
|
Python 3.10 [#16993]
|
||||||
|
|
||||||
-------------------------------------------------------------------
|
-------------------------------------------------------------------
|
||||||
Fri Aug 30 15:11:17 UTC 2024 - Ben Greiner <code@bnavigator.de>
|
Fri Aug 30 15:11:17 UTC 2024 - Ben Greiner <code@bnavigator.de>
|
||||||
|
|
||||||
|
@@ -1,7 +1,7 @@
|
|||||||
#
|
#
|
||||||
# spec file for package python-astropy
|
# spec file for package python-astropy
|
||||||
#
|
#
|
||||||
# Copyright (c) 2024 SUSE LLC
|
# Copyright (c) 2025 SUSE LLC
|
||||||
#
|
#
|
||||||
# All modifications and additions to the file contributed by third parties
|
# All modifications and additions to the file contributed by third parties
|
||||||
# remain the property of their copyright owners, unless otherwise agreed
|
# remain the property of their copyright owners, unless otherwise agreed
|
||||||
@@ -25,7 +25,7 @@
|
|||||||
%define psuffix %{nil}
|
%define psuffix %{nil}
|
||||||
%endif
|
%endif
|
||||||
|
|
||||||
%define binaries fitsdiff fitsheader fitscheck fitsinfo fits2bitmap samp_hub showtable volint wcslint
|
%define binaries fitsdiff fitsheader fitscheck fitsinfo fits2bitmap samp_hub showtable volint wcslint showtable-astropy
|
||||||
|
|
||||||
# backwards compatibility for --without systemlibs
|
# backwards compatibility for --without systemlibs
|
||||||
%bcond_without systemlibs
|
%bcond_without systemlibs
|
||||||
@@ -49,7 +49,7 @@
|
|||||||
|
|
||||||
%{?sle15_python_module_pythons}
|
%{?sle15_python_module_pythons}
|
||||||
Name: python-astropy%{psuffix}
|
Name: python-astropy%{psuffix}
|
||||||
Version: 6.1.3
|
Version: 7.1.0
|
||||||
Release: 0
|
Release: 0
|
||||||
Summary: Community-developed python astronomy tools
|
Summary: Community-developed python astronomy tools
|
||||||
License: BSD-3-Clause
|
License: BSD-3-Clause
|
||||||
@@ -59,10 +59,10 @@ Source: https://files.pythonhosted.org/packages/source/a/astropy/astropy
|
|||||||
# Mark wcs headers as false positives for devel-file-in-non-devel-package
|
# Mark wcs headers as false positives for devel-file-in-non-devel-package
|
||||||
# These are used by the python files so they must be available.
|
# These are used by the python files so they must be available.
|
||||||
Source100: python-astropy-rpmlintrc
|
Source100: python-astropy-rpmlintrc
|
||||||
# https://docs.astropy.org/en/v6.1/install.html#requirements
|
# https://docs.astropy.org/en/stable/install.html#requirements
|
||||||
BuildRequires: %{python_module Cython >= 3 with %python-Cython < 3.1}
|
BuildRequires: %{python_module Cython >= 3 with %python-Cython < 4}
|
||||||
BuildRequires: %{python_module devel >= 3.9}
|
BuildRequires: %{python_module devel >= 3.11}
|
||||||
BuildRequires: %{python_module extension-helpers >= 1.0}
|
BuildRequires: %{python_module extension-helpers >= 1.0 with %python-extension-helpers < 2}
|
||||||
BuildRequires: %{python_module numpy-devel}
|
BuildRequires: %{python_module numpy-devel}
|
||||||
BuildRequires: %{python_module pip}
|
BuildRequires: %{python_module pip}
|
||||||
BuildRequires: %{python_module setuptools_scm >= 6.2}
|
BuildRequires: %{python_module setuptools_scm >= 6.2}
|
||||||
@@ -72,20 +72,18 @@ BuildRequires: fdupes
|
|||||||
BuildRequires: hdf5-devel
|
BuildRequires: hdf5-devel
|
||||||
BuildRequires: pkgconfig
|
BuildRequires: pkgconfig
|
||||||
BuildRequires: python-rpm-macros
|
BuildRequires: python-rpm-macros
|
||||||
Requires: python-PyYAML >= 3.13
|
Requires: python-PyYAML >= 6
|
||||||
Requires: python-astropy-iers-data >= 0.2024.7.29.0.32.7
|
Requires: python-astropy-iers-data >= 0.2025.4.28.0.37.27
|
||||||
Requires: python-numpy >= 1.23
|
Requires: python-numpy >= 1.23.2
|
||||||
Requires: python-packaging >= 19.0
|
Requires: python-packaging >= 22
|
||||||
Requires: python-pyerfa >= 2.0.1.1
|
Requires: python-pyerfa >= 2.0.1.1
|
||||||
Requires(post): update-alternatives
|
Requires(post): update-alternatives
|
||||||
Requires(postun): update-alternatives
|
Requires(postun): update-alternatives
|
||||||
# %%{_bindir}/showtable namespace clash
|
# %%{_bindir}/showtable namespace clash
|
||||||
Conflicts: perl-Data-ShowTable
|
Conflicts: perl-Data-ShowTable
|
||||||
# [recommended]
|
# [recommended]
|
||||||
Recommends: python-scipy >= 1.8
|
Recommends: python-scipy >= 1.9.2
|
||||||
Recommends: python-matplotlib >= 3.3
|
Recommends: python-matplotlib >= 3.6
|
||||||
Conflicts: python-matplotlib = 3.4.0
|
|
||||||
Conflicts: python-matplotlib = 3.5.2
|
|
||||||
# [all]
|
# [all]
|
||||||
Suggests: python-h5py
|
Suggests: python-h5py
|
||||||
Suggests: python-beautifulsoup4
|
Suggests: python-beautifulsoup4
|
||||||
@@ -100,7 +98,7 @@ Suggests: python-setuptools
|
|||||||
Suggests: python-mpmath
|
Suggests: python-mpmath
|
||||||
Suggests: python-asdf-astropy >= 0.3
|
Suggests: python-asdf-astropy >= 0.3
|
||||||
Suggests: python-Bottleneck
|
Suggests: python-Bottleneck
|
||||||
Suggests: python-pyarrow >= 5
|
Suggests: python-pyarrow >= 10.0.1
|
||||||
Suggests: python-fsspec >= 2023.4.0
|
Suggests: python-fsspec >= 2023.4.0
|
||||||
# Suggests: python-s3fs
|
# Suggests: python-s3fs
|
||||||
%if %{with system_expat}
|
%if %{with system_expat}
|
||||||
@@ -115,19 +113,19 @@ BuildRequires: %{python_module Bottleneck}
|
|||||||
BuildRequires: %{python_module asdf-astropy >= 0.3}
|
BuildRequires: %{python_module asdf-astropy >= 0.3}
|
||||||
BuildRequires: %{python_module beautifulsoup4}
|
BuildRequires: %{python_module beautifulsoup4}
|
||||||
BuildRequires: %{python_module bleach}
|
BuildRequires: %{python_module bleach}
|
||||||
BuildRequires: %{python_module dask-array}
|
BuildRequires: %{python_module dask-array >= 2022.5.1}
|
||||||
BuildRequires: %{python_module fsspec >= 2023.4.0}
|
BuildRequires: %{python_module fsspec >= 2023.4.0}
|
||||||
BuildRequires: %{python_module h5py}
|
BuildRequires: %{python_module h5py}
|
||||||
BuildRequires: %{python_module html5lib}
|
BuildRequires: %{python_module html5lib}
|
||||||
BuildRequires: %{python_module jplephem}
|
BuildRequires: %{python_module jplephem}
|
||||||
BuildRequires: %{python_module matplotlib >= 3.3}
|
BuildRequires: %{python_module matplotlib >= 3.6.0}
|
||||||
BuildRequires: %{python_module mpmath}
|
BuildRequires: %{python_module mpmath}
|
||||||
BuildRequires: %{python_module pandas}
|
BuildRequires: %{python_module pandas}
|
||||||
%ifnarch %arm
|
%ifnarch %arm
|
||||||
BuildRequires: %{python_module pyarrow >= 5}
|
BuildRequires: %{python_module pyarrow >= 10.0.1}
|
||||||
%endif
|
%endif
|
||||||
BuildRequires: %{python_module pytz}
|
BuildRequires: %{python_module pytz}
|
||||||
BuildRequires: %{python_module scipy >= 1.8}
|
BuildRequires: %{python_module scipy >= 1.9.2}
|
||||||
BuildRequires: %{python_module sortedcontainers}
|
BuildRequires: %{python_module sortedcontainers}
|
||||||
BuildRequires: %{python_module typing_extensions >= 4.0.0}
|
BuildRequires: %{python_module typing_extensions >= 4.0.0}
|
||||||
BuildRequires: libxml2-tools
|
BuildRequires: libxml2-tools
|
||||||
@@ -135,17 +133,17 @@ BuildRequires: libxml2-tools
|
|||||||
# SECTION [test]
|
# SECTION [test]
|
||||||
# We need the compiled package for testing
|
# We need the compiled package for testing
|
||||||
BuildRequires: %{python_module astropy = %{version}}
|
BuildRequires: %{python_module astropy = %{version}}
|
||||||
BuildRequires: %{python_module ipython >= 4.2 if %python-base >= 3.10}
|
BuildRequires: %{python_module ipython >= 8}
|
||||||
BuildRequires: %{python_module objgraph}
|
BuildRequires: %{python_module objgraph}
|
||||||
|
BuildRequires: %{python_module pytest >= 7.3}
|
||||||
BuildRequires: %{python_module pytest-astropy >= 0.10}
|
BuildRequires: %{python_module pytest-astropy >= 0.10}
|
||||||
BuildRequires: %{python_module pytest-astropy-header >= 0.2.1}
|
BuildRequires: %{python_module pytest-astropy-header >= 0.2.1}
|
||||||
BuildRequires: %{python_module pytest-doctestplus >= 0.12}
|
BuildRequires: %{python_module pytest-doctestplus >= 0.12}
|
||||||
BuildRequires: %{python_module pytest-mpl}
|
BuildRequires: %{python_module pytest-mpl}
|
||||||
BuildRequires: %{python_module pytest-xdist}
|
BuildRequires: %{python_module pytest-xdist >= 2.5}
|
||||||
BuildRequires: %{python_module pytest}
|
|
||||||
BuildRequires: %{python_module sgp4 >= 2.3}
|
BuildRequires: %{python_module sgp4 >= 2.3}
|
||||||
BuildRequires: %{python_module skyfield}
|
BuildRequires: %{python_module skyfield}
|
||||||
BuildRequires: %{python_module threadpoolctl}
|
BuildRequires: %{python_module threadpoolctl >= 3}
|
||||||
# /SECTION
|
# /SECTION
|
||||||
%endif
|
%endif
|
||||||
%python_subpackages
|
%python_subpackages
|
||||||
@@ -178,7 +176,10 @@ import hypothesis
|
|||||||
hypothesis.settings.register_profile(
|
hypothesis.settings.register_profile(
|
||||||
'obs',
|
'obs',
|
||||||
deadline=5000,
|
deadline=5000,
|
||||||
suppress_health_check=[hypothesis.HealthCheck.too_slow]
|
suppress_health_check=[
|
||||||
|
hypothesis.HealthCheck.too_slow,
|
||||||
|
hypothesis.HealthCheck.filter_too_much,
|
||||||
|
]
|
||||||
)
|
)
|
||||||
" >> astropy/conftest.py
|
" >> astropy/conftest.py
|
||||||
sed -i '/"--color=yes",/d' pyproject.toml
|
sed -i '/"--color=yes",/d' pyproject.toml
|
||||||
|
Reference in New Issue
Block a user