Index index by Group index by Distribution index by Vendor index by creation date index by Name Mirrors Help Search

python313-astropy-7.1.0-2.1 RPM for aarch64

From OpenSuSE Ports Tumbleweed for aarch64

Name: python313-astropy Distribution: openSUSE Tumbleweed
Version: 7.1.0 Vendor: openSUSE
Release: 2.1 Build date: Fri Oct 3 13:29:10 2025
Group: Unspecified Build host: reproducible
Size: 48635709 Source RPM: python-astropy-7.1.0-2.1.src.rpm
Packager: http://bugs.opensuse.org
Url: https://astropy.org
Summary: Community-developed python astronomy tools
Astropy is a package intended to contain core functionality and some
common tools needed for performing astronomy and astrophysics research with
Python. It also provides an index for other astronomy packages and tools for
managing them.

Provides

Requires

License

BSD-3-Clause

Changelog

* Fri Oct 03 2025 Ben Greiner <code@bnavigator.de>
  - Add astropy-pr18335-jplephem.patch gh#astropy/astropy#18335
* Wed Jul 23 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 06 2025 Ben Greiner <code@bnavigator.de>
  - Suppress another hypothesis health check for the test suite
* Sun Feb 09 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 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 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 08 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 2024 Ben Greiner <code@bnavigator.de>
  - Update to 6.1.3
    [#]# Bug Fixes
    [#]## astropy.io.fits
    * Fix reading zero-width columns such as 0A fields. [#16894]
    * Ensure that QTable, like Table, can read zero-length string
      columns, and not convert them to length 1 strings. In the
      process, avoid a needless copy of all the data for QTable.
      [#16898]
    [#]## astropy.io.votable
    * Fix KeyError when parsing certain VOTables. [#16830]
    [#]## astropy.modeling
    * Fixed the fit_deriv calculations in the Lorentz1D model.
      [#16794]
    [#]## astropy.table
    * Pretty-printing of Tables now also works in the presence of
      zero-length string columns (which sometimes are present in FITS
      tables). [#16898]
    [#]## astropy.utils
    * Fix the return type for np.broadcast_arrays on a single Masked
      instance: it now correctly returns a 1-element sequence instead
      of a single array, just like would be the case with a regular
      array. [#16842]
    [#]## astropy.wcs
    * Fix a bug where wcs_info_str’s results would look different in
      numpy 2 VS numpy 1. [#16586]
    [#]# Other Changes and Additions
    * The minimum required version of PyArrow is now v7.0.0. [#16785]
* Fri Aug 16 2024 Benjamin Greiner <code@bnavigator.de>
  - Don't require numpy 2.
* Fri Aug 09 2024 Dirk Müller <dmueller@suse.com>
  - update to 6.1.2:
    * When reading CDS and MRT files, only interpret a line as a
      section delimiter if it contains exclusively dashes or equal
      signs. This enables rows starting with dashes.
    * Fix a spurious exception when reading integer compressed
      images with blanks.
    * Fixed a crash that occurred for files opened via
      fits.open(..., mode='update'), on Windows, and with numpy 2.0
      installed. A warning is now emitted in cases most likely to
      escalate into undefined behavior (e.g., segfaults), i.e.,
      when a closed memory map object is still referenced by
      external code. Please report any regression found.
    * Fixed a bug that caused models returned by non-linear fitters
      to have sync_constraints set to False, which caused
      constraints accessed through, e.g., Model.fixed to not be in
      sync with the fixed attribute of the parameters.
    * Fixed a bug that caused CompoundModel.without_units_for_data
      to return an incorrectly constructed model when the compound
      model contained a * or / operation, and which also caused
      fitting to not work correctly with compound models that
      contained * or / operations.
    * The OGIP parser is now less restrictive with strings that
      represent a unit that includes the sqrt function. For
      example, u.Unit("sqrt(m)**3", format="ogip") no longer causes
      a ValueError.
    * Fixed an edge-case bug in overlap_slices where the function
      could return an empty slice for non-overlapping slices.
    * Fixed a WCSAxes bug when overlaying a frame with default
      units that are not degrees.
* Thu Jul 11 2024 Ben Greiner <code@bnavigator.de>
  - Revert numpy restriction.
* Thu Jul 11 2024 Steve Kowalik <steven.kowalik@suse.com>
  - Restrict numpy to < 2.
* Tue Jun 25 2024 Steve Kowalik <steven.kowalik@suse.com>
  - Update to 6.1.1:
    * Let fitsdiff compare files with lower case HIERARCH keywords
    * Fix writing a ``HDUList`` to file when numpy 2 is installed and at least
      some of the data is represented as dask arrays.
    * Fix display of diff reports with numpy 2.
    * Ensure that also zero-length tables preserve whether integer data are
      signed or unsigned.
    * Fix YAML table serialization compatibility with numpy 2.
    * Fix bugs in io.votable related to numpy 2's representation of scalars.
    * Ensure that return types from ``sigma_clip`` ``cenfunc`` and ``stdfunc``
      are np.float64 for scalar values.
    * Ensure structured ``MaskedColumn`` are serialized correctly, including
      the mask.
    * Fix problems converting Pandas Series to ``Table`` with numpy >=2.0.
    * Ensure Time in ymdhms format can also be serialized to files as part of a
      table if it is masked.
    * Ensure Masked versions of ``np.recarray`` will show the correct class
      name of ``MaskedRecarray`` in their ``repr``, and that they will be
      serialized correctly if part of a table.
    * Fix bugs with how masked structured arrays were represented with numpy 2.
    * ``MaskedQuantity`` now works properly with ``np.block``.
    * Fix a bug where ``WCSAxes`` could be missing negative signs on axis
      labels when using matplotlib's ``usetex`` mode.
    * Fix compilation with gcc 14, avoid implicit pointer conversions.
  - Drop patch 16450.patch, included upstream.
  - Remove upper bound on pytest, no longer required.
* Mon May 27 2024 John Paul Adrian Glaubitz <adrian.glaubitz@suse.com>
  - Cherry-pick upstream patch to fix build with GCC 14
    * https://github.com/astropy/astropy/pull/16450.patch
* Sun May 05 2024 Ben Greiner <code@bnavigator.de>
  - Update to 6.1.0
    [#]# Highlights
    * Updated minimum Python version to 3.10
    * Order-dependent angular separations now come with warnings
    * io.ascii uses 64-integers by default for integer columns
    * Changes to semantics of copy= keyword arguments
    * Cosmology is now a dataclass()
    [#]# New Features
    [#]## astropy.coordinates
    * BaseCoordinateFrame now has a position_angle() method, which is
      the same as the position_angle method of SkyCoord instances.
      [#15737]
    * By default the SkyCoord and BaseCoordinateFrame separation()
      methods now emit a warning if they have to perform a coordinate
      transformation that is not a pure rotation to inform the user
      that the angular separation can depend on the direction of the
      transformation. It is possible to modify this behaviour with
      the new optional keyword-only origin_mismatch argument.
      Specifying origin_mismatch="ignore" allows any transformation
      to succeed without warning, which has been the behaviour so
      far. origin_mismatch="error" forbids all transformations that
      are not pure rotations. [#16246]
    [#]## astropy.io.ascii
    * Clearer error message in reading ASCII tables when there is a
      mismatch between converter type and column type. [#15991]
    [#]## astropy.io.registry
    * The module astropy.io.typing has been added to provide type
      annotations for I/O-related functionality. [#15916]
    [#]## astropy.samp
    * SAMP web profile CORS HTTP server implements Private Network
      Access proposal. [#16193]
    [#]## astropy.table
    * Table now has a setdefault() method, analogous to
      dict.setdefault(). [#16188]
    [#]## astropy.units
    * Added a new module astropy.units.typing that provides support
      for type annotations related to astropy.units. [#15860]
    * Added a new CGS unit Oersted. [#15962]
    * Added “surface brightness”, “surface brightness wav”, “photon
      surface brightness”, and “photon surface brightness wav” to
      recognized physical types. [#16032]
    * Added magnetic helicity as a physical type. [#16101]
    [#]## astropy.utils
    * For gufuncs on Masked instances, add support for the axes
      argument. [#16121]
    * Masked instances now support the various numpy array set
      operations, such as np.unique and np.isin. [#16224]
    [#]## astropy.wcs
    * Added support for slicing WCS objects containing cpdis or
      det2im distortions, which previously were ignored. [#16163]
    [#]# API Changes
    [#]## astropy.coordinates
    * The astropy.coordinates.transformations module has been
      refactored into a module. There should be no user-visible
      changes, but if you notice any, please open an Issue. [#15895]
    * Changed the default value of the copy argument in
      astropy.coordinates.representation.CylindricalDifferential.__init__
      from False to True, which is the intended behaviour for all
      subclasses of
      astropy.coordinates.representation.BaseDifferential. [#16198]
    [#]## astropy.cosmology
    * Cosmology and its subclasses are now frozen dataclass objects.
      [#15484]
    * The argument verbose in the function z_at_value is now
      keyword-only. [#15855]
    [#]## astropy.io.ascii
    * The io.ascii Python and C table readers were updated to use a
      64-bit integer field by default when reading a column of
      integer numeric data. This changes the default behavior on
      Windows and potentially 32-bit architectures. Previously on
      those platforms, table columns with any long integers which
      overflowed the 32-bit integer would be returned as string
      columns. The new default behavior is consistent with numpy v2
      and pandas. [#16005]
    * The parallel fast-reader parser for reading ASCII files has
      been removed. Since astropy v4.0.4 requesting this option has
      issued a warning that this option is broken and that the serial
      parser will be used. The parallel key in the fast_reader
      argument for reading ASCII tables is no longer available.
      [#16103]
    [#]## astropy.table
    * show_in_notebook is deprecated and it is recommended to use
      dedicated tools in the Jupyter ecosystem to create interactive
      plots in notebooks. [#15905]
    * A warning is now emitted when Quantity values are inserted into
      empty Column objects via Table.insert_row or Table.add_row.
      [#16038]
    * show_in_browser is deprecated (pending feedback from the
      community). Please use astropy/astropy#16067 if you are
      actively using the function. [#16068]
    * TableColumns.setdefault() and TableColumns.update() methods
      (which would typically be called as Table.columns.setdefault()
      and Table.columns.update()) have been deprecated because they
      can easily corrupt the Table instance the TableColumns instance
      is attached to. The Table.setdefault() and Table.update()
      methods are safe. [#16154]
    [#]## astropy.time
    * TIME_FORMATS and TIME_DELTA_FORMATS in astropy.time.formats are
      changed from OrderedDict to Python dict. [#15491]
    * A FutureWarning is now emitted when mutating Time.location
      post-initialization. [#16063]
    * Following the removal of np.ndarray.ptp in Numpy v2, Time.ptp
      is now deprecated in favor of np.ptp. [#16212]
    [#]## astropy.units
    * If any iterable such as a list of tuple was input to Quantity,
      a check was done to see if they contained only quantities, and,
      if so, the quantities were concatenated. This makes sense for
      list and tuple, but is not necessarily logical for all
      iterables and indeed was broken for those that do not have a
      length (such as array_api array instances). Hence, the check
      will now be done only for values where it makes sense, i.e.,
      instances of list and tuple. [#15752]
    * Units now exposes get_converter which returns a function that
      will convert a scalar or array from one unit to another. This
      can be useful to speed up code that converts many quantities
      with the same unit to another one, especially if the quantity
      has not many elements, so that the overhead of creating a
      conversion function is relatively large. [#16139]
    [#]## astropy.utils
    * Deprecate importing ErfaError and ErfaWarning from
      astropy.utils.exceptions. They should be imported directly from
      erfa instead. [#15777]
    * introspection.isinstancemethod() and
      introspection.find_mod_objs() are deprecated. [#15934]
    * astropy.utils.console.terminal_size is now deprecated in favour
      of shutil.get_terminal_size from the standard library. [#16045]
    * indent() is deprecated. Use textwrap.indent() from Python
      standard library instead. [#16223]
    * Unmasked Masked scalar instances are now considered hashable,
      to match the implicit behaviour of regular arrays, where if an
      operation leads to a scalar, a hashable array scalar is
      returned. [#16224]
    [#]## astropy.visualization
    * Renamed the min_cut and max_cut keywords in simple_norm and
      fits2bitmap to vmin and vmax. The old names are deprecated.
      [#15621]
    * If vmin == vmax, the ImageNormalize class now maps the input
      data to 0. If vmin > vmax, the ImageNormalize class now raises
      a ValueError. [#15622]
    [#]# Bug Fixes
    [#]## astropy.convolution
    * Avoid a segfault when calling astropy.convolution.convolve on
      an empty array. An exception is now raised instead. [#15840]
    [#]## astropy.coordinates
    * Previously passing a SkyCoord instance to the
      BaseCoordinateFrame separation() or separation_3d() methods
      could produce wrong results, depending on what additional frame
      attributes were defined on the SkyCoord, but now SkyCoord input
      can be used safely. [#15659]
    * Distance now accepts as parallax any angle-like value. This
      includes types like Column which have a unit but are not
      Quantity subclasses. [#15712]
    * The new default for the class method SkyCoord.from_name() is to
      look for coordinates first in SIMBAD, then in NED, and then in
      VizieR, instead of having no specific order. [#16046]
    * Fix Angle.to_string() for angles in degrees represented in
      ‘hms’ and angles in hours represented in ‘dms’. [#16085]
    * Fix a bug where SkyCoord.spherical_offsets_by would crash when
      a wrap was needed. [#16241]
    * search_around_3d() now always raises a UnitConversionError if
      the units of the distances in coord1 and coord2 and the unit of
      distlimit do not agree. Previously the error was not raised if
      at least one of the coordinates was empty. [#16280]
    [#]## astropy.cosmology
    * Fixed a bug where the attribute ParametersAttribute.attr_name
      could be None instead of a string. [#15882]
    [#]## astropy.io.ascii
    * Reading of CDS header files with multi-line descriptions where
      the continued line started with a number was broken. This is
      now fixed. [#15617]
    * Ensure that the names of mixin columns are properly propagated
      as labels for the MRT format. [#15848]
    * Fixed reading IPAC tables for long column type on some
      platforms, e.g., Windows. [#16005]
    [#]## astropy.io.fits
    * Avoid WinError 1455 in opening some large files with memory
      mapping on windows. [#15388]
    * Fix TDISP parsing for floating numbers. [#16007]
    * Fix a crash when calling FITS writeto methods with stdout as
      the output stream. [#16008]
    * Fix TDISP parsing for floating numbers in formats ES / EN.
      [#16015]
    * Fix conversion of Table to BinTableHDU with
      character_as_bytes=True. [#16358]
    * Improved error message when instantiating a fits table with an
      ill-formed array. [#16363]
    [#]## astropy.io.misc
    * Reading an empty table stored in parquet format now creates an
      empty table instead of raising an unexpected error. [#16237]
    [#]## astropy.io.votable
    * When reading a VOTable, if some user-requested columns were not
      present then the resulting error message previously listed all
      the requested column names. Now only columns that are actually
      missing are shown. [#15956]
    [#]## astropy.stats
    * Fix a spurious warning when calling sigma_clipped_stats on a
      MaskedColumn. [#15844]
    [#]## astropy.table
    * Fix a Table bug when setting items (via slice or index list) in
      a bytes type MaskedColumn would cause the column mask to be set
      to all False. A common way to trigger this bug was reading a
      FITS file with masked string data and then sorting the table.
      [#15669]
    * Fix slicing logic for Row. Previously, slicing a
      astropy.table.row.Row object would incorrectly return a column,
      now it correctly returns a list of values from that row.
      [#15733]
    * Fix a ValueError raised by table.join when fed with large
      tables. This would typically happen in situations when the
      result joined table would be too large to fit in memory. In
      those situations, the error message is now much more clearly
      about the necessary memory size. [#15734]
    * Fix an unintended exception being raised when attempting to
      compare two unequal Table instances. [#15845]
    * Ensure that if a Column is initialized with a Quantity it will
      use by default a possible name defined on the quantity’s .info.
      [#15848]
    * Fix a bug where columns with dtype=object wouldn’t be properly
      deep-copied using copy.deepcopy. [#15871]
    * Fix hasattr(Table, "iloc") raising an exception, preventing use
      of tables e.g. with scikit-learn. [#15913]
    * Calling Table.group_by on an empty table no longer raises an
      exception. [#16093]
    * The unit conversion convert_unit_to with MaskedColumn was
      broken as it was storing the old unit in a dictionary attached
      to underlying np.ma.MaskedArray. This fixes it by overwriting
      the old unit after unit conversion. [#16118]
    * astropy.table.vstack will no longer modify the input list even
      when it contains non-Table objects like astropy.table.Row.
      [#16130]
    * Update old dataTables.js version. This should not affect the
      end user. [#16315]
    [#]## astropy.time
    * Fix comparing NaN Quantity with TimeDelta object. [#15830]
    * Scalar Time instances are now hashable if they are not masked,
      also if one uses Masked internally, matching the behaviour
      prior to astropy 6.0 (and the current behaviour when masking
      using np.ma.MaskedArray). [#16224]
    [#]## astropy.units
    * Fix rare signature incompatibilities between helper and helped
      array functions. Most involve cases where the corresponding
      numpy function has had its arguments renamed between numpy
      versions. Since all those generally changed the first
      arguments, which are typically passed as positional arguments,
      this should not affect user code. Affected functions: -
      numpy.array_str - numpy.choose - numpy.convolve -
      numpy.correlate - numpy.histogram - numpy.histogramdd -
      numpy.histogram2d - numpy.isin - numpy.inner - numpy.nanmedian
    - numpy.unique - numpy.matrix_rank - numpy.unwrap - numpy.vdot
    - numpy.lib.recfunctions.unstructured_to_structured [#15710]
    * Fix an issue with unicode string representations of units shown
      as superscripts (like degree) when raised to some power. Like
      for LaTeX representations, now the superscript unicode
      character is replaced by the literal short name before adding
      the power. [#15755]
    * Fix a missing Sun unit in the list of VOUnits simple_units.
      [#15832]
    * Fix an unhelpful TypeError when attempting truediv, lshift (<<)
      or mul (*) or truediv (/) with a Unit for right operand and a
      numpy array with non-numerical dtype for left operand. [#15883]
    * Fix write/read roundtrips with empty Table dumped to ECSV.
      [#15885]
    * Fix a bug where LaTeX formatter would return empty strings for
      unity (1) input. [#15923]
    * Fix extraneous space in LaTeX repr for Quantity objects with
      superscript units (e.g. angles or temperatures in degree
      Celsius). [#16043]
    * Ensure powers of units are consistently as simple as possible.
      So, an integer if possible, otherwise a float, or a fraction if
      the float is really close to that. This also ensures the hash
      of a unit is unique for any given unit (previously, the same
      power could be represented as float, int or fraction, which
      made the hash different). [#16058]
    * Ensure that find_equivalent_units only returns actual units,
      not units that raised to some power match the requested one.
      With this fix, (u.m**-3).find_equivalent_units() properly finds
      nothing, rather than all units of length. [#16127]
    * Using a dimensionless Quantity as an exponent works anew. In
      astropy 6.0.1 an exception was erroneously raised. [#16261]
    [#]## astropy.utils
    * Fix rare signature incompatibilities between helper and helped
      array functions. These typically cover corner cases and should
      not affect user code. Some arguments weren’t being re-exposed
      correctly or at all, depending on numpy’s version. Affected
      functions: - numpy.broadcast_arrays - numpy.median -
      numpy.quantile - numpy.empty_like - numpy.ones_like -
      numpy.zeros_like - numpy.full_like [#16025]
    * Fix a bug where astropy.utils.console.Spinner would leak
      newlines for messages longer than terminal width. [#16040]
    * Update report_diff_values so the diff no longer depends on the
      console terminal size. [#16065]
    * Fix support in Masked for generalized ufuncs with more than a
      single core dimension (such as erfa.rxp). [#16120]
    * Masked array instances now deal more properly with structured
      dtypes, combining field masks to get element masks for
      generalized ufuncs, and allowing .view() any time the mask can
      be viewed as well. This allows a larger number of erfa routines
      to work with masked data. [#16125]
    [#]## astropy.visualization
    * WCSAxes will correctly set certain defaults when
      wcs.world_axis_physical_types contains custom: prefixes.
      [#15626]
    * Fix an edge case where quantity_support would produce duplicate
      tick labels for small data ranges. [#15841]
    * Fix a bug where AngleFormatterLocator and
      ScalarFormatterLocator wouldn’t respect matplotlib.rc’s
      axes.unicode_minus parameter. [#15902]
    * Fixed a bug in CoordinateHelper.grid method to properly handle
      draw_grid=False and draw_grid=None, ensuring grid lines are
      controlled correctly even when not explicitly called. [#15985]
    [#]## astropy.wcs
    * Updated bundled WCSLIB version to 8.2.2. This update fixes
      character buffer overflows in the comment string for the
      longitude and latitude axes triggered by some projections in
      wcshdo(), and also the formatting for generic coordinate
      systems. For a full list of changes - see
      http://www.atnf.csiro.au/people/mcalabre/WCS/CHANGES or
      astropy/cextern/wcslib/CHANGES [#15795]
    * Fixed a bug in fit_wcs_from_points that does not set the
      default value of the cdelt of the returned WCS object. [#16027]
    * Fixed a bug in DistortionLookupTable (which implements cpdis
      and det2im projection corrections to a WCS) in which image
      pixels received an incorrect distortion value, from a location
      in the lookup table incorrectly offset by about 1 table pixel.
      [#16163]
    [#]# Other Changes and Additions
    * Update minimum supported Python version to 3.10 [#15603]
    * The minimum required NumPy version is now 1.23 and the minimum
      required SciPy version is 1.8. [#15706]
    * Fix loading parser tabs on pyc-only installations.
    * Fix a bug in the wrappers for the lex and yacc wrappers that
      are used for parsing Astropy units so that they work on
      pyc-only installations.
    * According to the Python module loading flow chart, when
      evaluating import foo and foo.py is not found, Python then
      reads foo.pyc.
    * One can take advantage of this fact to strip source files and
      leave only Python bytecode files for deployment
      inspace-constrained execution environments such as AWS Lambda.
      Astropy is now compatible with pyc-only deployments. [#16159]
    * Change the default value of copy arguments in public APIs from
      False to None if Numpy 2.0 or newer is installed. For details,
      see the “Copy semantics” section on the What’s New page for
      Astropy 6.1 . [#16181]
* Fri Mar 29 2024 Ben Greiner <code@bnavigator.de>
  - Update to 6.0.1
    [#]# Bug Fixes
    [#]## astropy.coordinates
    * Previously passing a SkyCoord instance to the
      BaseCoordinateFrame separation() or separation_3d() methods
      could produce wrong results, depending on what additional frame
      attributes were defined on the SkyCoord, but now SkyCoord input
      can be used safely. [#15659]
    * Distance now accepts as parallax any angle-like value. This
      includes types like Column which have a unit but are not
      Quantity subclasses. [#15712]
    * The new default for the class method SkyCoord.from_name() is to
      look for coordinates first in SIMBAD, then in NED, and then in
      VizieR, instead of having no specific order. [#16046]
    [#]## astropy.io.ascii
    * Reading of CDS header files with multi-line descriptions where
      the continued line started with a number was broken. This is
      now fixed. [#15617]
    * Ensure that the names of mixin columns are properly propagated
      as labels for the MRT format. [#15848]
    * Fixed reading IPAC tables for long column type on some
      platforms, e.g., Windows. [#15992]
    [#]## astropy.io.fits
    * Fix TDISP parsing for floating numbers. [#16007]
    * Fix a crash when calling FITS writeto methods with stdout as
      the output stream. [#16008]
    * Fix TDISP parsing for floating numbers in formats ES / EN.
      [#16015]
    [#]## astropy.stats
    * Fix a spurious warning when calling sigma_clipped_stats on a
      MaskedColumn. [#15844]
    [#]## astropy.table
    * Fix a Table bug when setting items (via slice or index list) in
      a bytes type MaskedColumn would cause the column mask to be set
      to all False. A common way to trigger this bug was reading a
      FITS file with masked string data and then sorting the table.
      [#15669]
    * Fix slicing logic for Row. Previously, slicing a
      astropy.table.row.Row object would incorrectly return a column,
      now it correctly returns a list of values from that row.
      [#15733]
    * Fix a ValueError raised by table.join when fed with large
      tables. This would typically happen in situations when the
      result joined table would be too large to fit in memory. In
      those situations, the error message is now much more clearly
      about the necessary memory size. [#15734]
    * Fix an unintended exception being raised when attempting to
      compare two unequal Table instances. [#15845]
    * Ensure that if a Column is initialized with a Quantity it will
      use by default a possible name defined on the quantity’s .info.
      [#15848]
    * The unit conversion convert_unit_to with MaskedColumn was
      broken as it was storing the old unit in a dictionary attached
      to underlying np.ma.MaskedArray. This fixes it by overwriting
      the old unit after unit conversion. [#16118]
    * astropy.table.vstack will no longer modify the input list even
      when it contains non-Table objects like astropy.table.Row.
      [#16130]
    [#]## astropy.units
    * Fix an issue with unicode string representations of units shown
      as superscripts (like degree) when raised to some power. Like
      for LaTeX representations, now the superscript unicode
      character is replaced by the literal short name before adding
      the power. [#15755]
    * Fix a missing Sun unit in the list of VOUnits simple_units.
      [#15832]
    * Fix write/read roundtrips with empty Table dumped to ECSV.
      [#15885]
    * Fix a bug where LaTeX formatter would return empty strings for
      unity (1) input. [#15923]
    * Ensure powers of units are consistently as simple as possible.
      So, an integer if possible, otherwise a float, or a fraction if
      the float is really close to that. This also ensures the hash
      of a unit is unique for any given unit (previously, the same
      power could be represented as float, int or fraction, which
      made the hash different). [#16058]
    * Ensure that find_equivalent_units only returns actual units,
      not units that raised to some power match the requested one.
      With this fix, (u.m**-3).find_equivalent_units() properly finds
      nothing, rather than all units of length. [#16127]
    [#]## astropy.utils
    * Fix a bug where astropy.utils.console.Spinner would leak
      newlines for messages longer than terminal width. [#16040]
    * Update report_diff_values so the diff no longer depends on the
      console terminal size. [#16065]
    * Fix support in Masked for generalized ufuncs with more than a
      single core dimension (such as erfa.rxp). [#16120]
    [#]## astropy.visualization
    * Fix an edge case where quantity_support would produce duplicate
      tick labels for small data ranges. [#15841]
    [#]## astropy.wcs
    * Updated bundled WCSLIB version to 8.2.2. This update fixes
      character buffer overflows in the comment string for the
      longitude and latitude axes triggered by some projections in
      wcshdo(), and also the formatting for generic coordinate
      systems. For a full list of changes - see
      http://www.atnf.csiro.au/people/mcalabre/WCS/CHANGES or
      astropy/cextern/wcslib/CHANGES [#15795]
    * Fixed a bug in fit_wcs_from_points that does not set the
      default value of the cdelt of the returned WCS object. [#16027]
    [#]# Other Changes and Additions
    * Given the potential breaking changes with the upcoming Numpy
      2.0 release, this release pins Numpy<2.0 and support for Numpy
      2.0 will be added in the v6.1.0 release.
* Tue Mar 19 2024 Ben Greiner <code@bnavigator.de>
  - Enable SLE15 python module for python311
    * Old version <=5.3.2 would be vulnerable boo#1221661
      CVE-2023-41334
* Thu Mar 07 2024 Ben Greiner <code@bnavigator.de>
  - Don't test with python39-ipython: not available anymore
* Sat Dec 09 2023 Ben Greiner <code@bnavigator.de>
  - Update to 6.0.0
    [#]# New Features
    [#]## astropy.config
    * The new ConfigNamespace.help() method provides a convenient way
      to get information about configuration items. [#13499]
    [#]## astropy.coordinates
    * Support has been added to create geodetic representations not
      just for existing ellipsoids from ERFA, but also with
      explicitly provided values, by defining a subclass of
      BaseGeodeticRepresentation with the equatorial radius and
      flattening assigned to _equatorial_radius and _flattening
      attributes. [#14763]
    * Add BaseBodycentricRepresentation, a new spheroidal
      representation for bodycentric latitudes and longitudes.
      [#14851]
    * Support Numpy broadcasting over frame data and attributes.
      [#15121]
    [#]## astropy.cosmology
    * Registered a latex writer for exporting a Cosmology object to a
      LaTex table. [#14701]
    * Added argument rename to Cosmology’s I/O, allowing for input
      and output symbols to be renamed. [#14780]
    * All non-abstract Cosmology subclasses are now automatically
      registered to work with Astropy’s YAML serialization. [#14979]
    * Cosmology I/O now auto-identifies the ‘.tex’ suffix with the
      ‘ascii.latex’ format. [#15088]
    * The Cosmology class now has a new property to access the
      parameters of the cosmology: .parameters. This property return
      a read-only dictionary of all the non-derived parameter values
      on the cosmology object. When accessed from the class (not an
      instance) the dictionary contains Parameter instances, not the
      values. [#15168]
    * The field default has been added to Parameter. This can be used
      to introspect the default value of a parameter on a cosmology
      class e.g. LambdaCDM.H0.default. [#15400]
    [#]## astropy.io.fits
    * Add new option decompress_in_memory to fits.open, to decompress
      the whole file in memory at once, instead of decompressing the
      file progressively as data is needed. Default behavior is
      better for memory usage but sometimes slow, especially for
      files with many small HDUs. [#15501]
    [#]## astropy.io.votable
    * Add support for Parquet serialization of VOTables. Writing of
      this serialization is available with using the new
      'votable.parquet' format. [#15281]
    * Added MIVOT feature through the MivotBlock class that allows
      model annotations reading and writing in VOTable. [#15390]
    [#]## astropy.modeling
    * Added a GeneralSersic2D model that can have “boxy” or “disky”
      isophotes. [#15545]
    [#]## astropy.nddata
    * A more flexible and/or compact string representation is now
      available for NDData objects which visually indicates masked
      entries, and provides for better for dask array support.
      [#14438]
    [#]## astropy.table
    * The new Row.get() method, analogous to dict.get(), returns the
      value of the specified column from the row if the column
      present, otherwise it returns a fallback value, which by
      default is None. [#14878]
    [#]## astropy.time
    * Masked Time instances now use astropy’s own Masked class
      internally. This means that Masked input is now properly
      recognized, and that masks get propagated also to Quantity
      output (such as from a TimeDelta converted to a unit of time),
      creating MaskedQuantity instances. [#15231]
    * Added a TimeDelta format quantity_str that represents the time
      delta as a string with one or more Quantity components. This
      format provides a human-readable multi-scale string
      representation of a time delta. The default output sub-format
      is not considered stable in this release, please see
      astropy/astropy#15485 for more information. [#15264]
    [#]## astropy.uncertainty
    * Uncertainty Distribution now support structured data types, and
      as a result it now works also with EarthLocation. [#15304]
    * Uncertainty Distribution can now be used inside
      representations, which also allows basic support in SkyCoord.
      While most calculations work, there are remaining issues. For
      instance, the repr does not show that the coordinates are
      distributions. [#15395]
    [#]## astropy.units
    * Add support for gc2gde and gd2gce erfa functions to allow
      geodetic representations using equatorial radius and
      flattening. [#14729]
    [#]## astropy.utils
    * The astropy.utils.metadata.MetaData default dictionary can now
      be set with the default_factory keyword argument. [#15265]
    * astropy.utils.decorators.deprecated now adds the __deprecated__
      attribute to the objects it wraps, following the practice in
      https://peps.python.org/pep-0702/. [#15310]
    [#]## astropy.visualization
    * Add WCSAxes.text_coord method to print text using SkyCoord
      objects parallel to plotting data points with
      WCSAxes.plot_coord. [#14661]
    [#]## astropy.wcs
    * Support WCS descriptions of basic planetary coordinate frames.
      [#14820]
    * Updated bundled WCSLIB version to 8.1. This update adds support
      planetary keywords A_RADIUS, B_RADIUS, C_RADIUS, BLON_OBS,
      BLAT_OBS, and BDIS_OBS in auxprm and adds wcsprm::time to the
      wcsprm struct to record the TIME axis. This update also
      includes several bug fixes. For a full list of changes - see
      http://www.atnf.csiro.au/people/mcalabre/WCS/CHANGES [#15035]
    [#]# API Changes
    [#]## astropy.config
    * Removed deprecated ConfigurationMissingWarning class and
      update_default_config function; There are no replacements as
      they should no be used anymore. [#15466]
    [#]## astropy.convolution
    * Invalid kernel arithmetic operations now raise a
      KernelArithmeticError instead of a bare Exception. [#14728]
    * Added base KernelError error class and removed
      DiscretizationError error class (a ValueError will be raised
      instead). [#14732]
    * discretize_model will now raise a ValueError if
      mode='oversample' and factor does not have an integer value.
      [#14794]
    [#]## astropy.coordinates
    * Removed deprecated angle parsing and formatting utilities from
      angle_utilities. Use the functions from angle_formats instead.
      [#14675]
    * The deprecated functionality of initializing Angle or Longitude
      from a tuple is no longer supported. [#15205]
    * Angle-related classes and functions have been moved within
      astropy.coordinates. There is no change to public API as
      everything moved should still be imported from
      astropy.coordinates, not a sub-module. If you are using private
      API, try importing from astropy.coordinates instead. If you
      need something that has been moved and is not available in
      astropy.coordinates, please open an issue on the Astropy issue
      tracker. [#15220]
    * It is no longer possible to pass frame classes to the
      transform_to() method of a low-level coordinate-frame class. It
      is still possible to pass frame instances. The transform_to()
      method of the high-level SkyCoord class is unaffected. [#15500]
    [#]## astropy.cosmology
    * Removed support of importing private constants and functions
      from astropy.cosmology.flrw. [#14672]
    * Removed deprecated Cosmology Parameter argument fmt. [#14673]
    * Removed deprecated vectorize_if_needed and inf_like from
      cosmology.utils. [#14677]
    * Removed deprecated import paths from astropy.cosmology.core.
      [#14782]
    * Cosmology Parameter is now a dataclass, and can work with all
      of Python’s dataclasses machinery, like field introspection and
      type conversion. [#14874]
    * A new property – scale_factor0 – has been added to Cosmology
      objects. This is the scale factor at redshift 0, and is defined
      to be 1.0. [#14931]
    * Added registration label ascii.latex to Cosmology IO. [#14938]
    * The private module astropy.cosmology.utils has been deprecated.
      [#14980]
    * Removed deprecated get_cosmology_from_string class method in
      default_cosmology; use get instead. [#15467]
    [#]## astropy.io.ascii
    * Several arguments in functions within astropy.io.ascii have
      been deprecated and are either renamed or scheduled to be
      removed.
    * read(): - Reader will be removed. Instead supply the equivalent
      format argument. - Inputter has been renamed to inputter_cls. -
      Outputter has been renamed to outputter_cls.
    * get_reader(): - Reader has been renamed to reader_cls. -
      Inputter has been renamed to inputter_cls. - Outputter has been
      renamed to outputter_cls.
    * write(): - Writer will be removed. Instead supply the
      equivalent format argument.
    * get_writer(): - Writer has been renamed to writer_cls. [#14914]
    * Removed deprecated astropy.io.ascii.tests.common.raises test
      helper; use pytest.raises instead. [#15470]
    [#]## astropy.io.fits
    * Deprecate _ExtensionHDU and _NonstandardExtHDU (use
      ExtensionHDU or NonstandardExtHDU instead). [#15396]
    * Remove special handling of TCTYP TCUNI TCRPX TCRVL TCDLT TRPOS
      (#7157). [#15396]
    * Rename and deprecate TableHDU.update to TableHDU.update_header,
      for consistency with ImageHDU. [#15396]
    [#]## astropy.io.misc
    * Removed deprecated astropy.io.misc.asdf subpackage. Use
      asdf-astropy package instead. [#14668]
    * fnunpickle and fnpickle are deprecated because they are not
      used anywhere within astropy. If you must, use the module from
      Python standard library but be advised that pickle is insecure
      so you should only unpickle data that you trust. [#15418]
    [#]## astropy.io.votable
    * Removed deprecated pedantic option from the
      astropy.io.votable.table.parse() function and the corresponding
      configuration setting. Use the verify option instead. [#14669]
    * Class astropy.io.votable.tree.Table has been renamed to
      TableElement to avoid sharing the name with
      astropy.table.Table. [#15372]
    * Fully removed support for version = ‘1.0’ on
      VOTableFile__init__() and changed its tests to check correctly.
      It was raising a DeprecationWarning and now is raising a
      ValueError. [#15490]
    [#]## astropy.modeling
    * Removed the AliasDict class from modeling.utils. [#12943]
    * Creating a model instance with parameters that have
      incompatible shapes will now raise a ValueError rather than an
      IncompatibleShapeError. [#15209]
    * Removal of deprecated code _model_to_fit_params and
      _fitter_to_model_params from fitting.py. [#15461]
    [#]## astropy.stats
    * The BoxLeastSquares, BoxLeastSquaresResults and LombScargle
      classes are not available from astropy.stats anymore, they are
      now available only from astropy.timeseries. [#15530]
    [#]## astropy.tests
    * Removed deprecated deprecation, warning, and exception handling
      functionality provided by astropy.tests.helper. [#14670]
    * astropy.tests.command.FixRemoteDataOption and
      astropy.tests.command.AstropyTest are deprecated. They are no
      longer necessary after sunsetting astropy-helpers. [#15204]
    [#]## astropy.time
    * Time has switched to use Masked arrays internally, instead of
      indicating masked values using NaN in the internal jd2
      attribute. As a result, any output from instances, such as one
      gets with, say, the .isot format, will also use Masked by
      default.
    * For backwards compatibility, a new configuration item,
      astropy.time.conf.masked_array_type is introduced which is set
      to “astropy” by default (which indicates one wants to use
      Masked), but can also be set to “numpy”, in which case
      numpy.ma.MaskedArray will be used where possible (essentially,
      for all but Quantity). [#15231]
    * Changed the TimeDelta init signature to be consistent with that
      of Time. Previously the argument order was val, val2, format,
      scale, copy. Now the order is val, val2, format, scale, *,
      precision, in_subfmt, out_subfmt, copy, where the arguments
      after the * must be specified by keyword. [#15264]
    [#]## astropy.timeseries
    * Removed deprecated midpoint_epoch in fold function; use
      epoch_time instead. [#15462]
    [#]## astropy.uncertainty
    * The .dtype attribute exposed by Distribution is now that of the
      samples, rather than one that has a “samples” entry. This makes
      quantities with structured data types and units easier to
      support, and generally makes the Distribution appear more
      similar to regular arrays. It should have little effect on
      code. For instance, distribution["samples"] still will return
      the actual distribution.
    * As a consequence of this refactoring, most arrays that are not
      C-contiguous can now be viewed and will thus not be copied on
      input any more. The only exceptions are arrays for which the
      strides are negative.
    * Note that the true data type is considered an implementation
      detail. But for reference, it now is a structured data type
      with a single field, “samples”, which itself is an array of
      “sample” fields, which contain the actual data. [#15304]
    [#]## astropy.units
    * Like np.ndarray, under numpy 2.0 Quantity and all its
      subclasses (Angle, Masked, etc.) will no longer support the
      .ptp() method. Use np.ptp(...) instead.
    * Similarly, support for the much less frequently used
      .newbyteorder() and .itemset() methods has been removed.
      [#15378]
    * The following deprecated functionality has been removed:
    - littleh unit and with_H0 equivalency. They are still
      available from cosmology.units.
    - brightness_temperature equivalency no longer automatically
      swaps the order of its arguments if it does not match the
      expectation.
    - PhysicalType no longer supports str methods and attributes.
      [#15514]
    [#]## astropy.utils
    * Removed deprecated OrderedDescriptor,
      OrderedDescriptorContainer, and set_locale in
      astropy.utils.misc. [#14679]
    * is_path_hidden() and walk_skip_hidden() are deprecated.
      [#14759]
    * The structure of utils.metadata has been refactored, but all
      the available functions and classes are still present and
      should be imported as before. [#15166]
    * The astropy.utils.metadata.MetaData class, which is used
      throughout astropy to carry metadata on tables, columns, etc.,
      can now also be used on dataclasses.
    * When accessing the meta attribute on a class
      astropy.utils.metadata.MetaData now returns None instead of
      itself. [#15237]
    * The astropy.utils.metadata.MetaData class, which is used
      throughout astropy to carry metadata on tables, columns, etc.,
      can now also be used on frozen dataclasses. [#15404]
    * Removed deprecated version_path in minversion function; it is
      no longer used. [#15468]
    [#]## astropy.visualization
    * The bboxes, ticklabels_bbox, and tick_out_size arguments to
      astropy.visualization.wcaxes.ticklabels.TickLabels.draw() now
      have no effect and are deprecated. This is to allow rasterized
      ticks to be drawn correctly on WCSAxes. [#14760]
    * It is now not possible to pass any keyword arguments to
      astropy.visualization.wcsaxes.WCSAxes.draw(). Previously
      passing any keyword arguments would have errored anyway, as
      matplotlib.axes.Axes.draw() does not accept keyword arguments.
      [#14772]
    * Deprecated the exp attribute in the LogStretch,
      InvertedLogStretch, PowerDistStretch, and
      InvertedPowerDistStretch stretch classes, and the power
      attribute in the PowerStretch. Instead, use the a attribute,
      which matches the input keyword. [#15538]
    * Removed the maximum value of the a parameter in the
      AsinhStretch and SinhStretch stretch classes. [#15539]
    [#]## astropy.wcs
    * Removed deprecated accuracy from all_world2pix method in WCS;
      use tolerance instead. [#15464]
    * NoConvergence no longer accepts arbitrary keyword arguments.
      [#15504]
    [#]# Bug Fixes
    [#]## astropy.coordinates
    * Fixed minor bug when getting solar system positions of objects
      from Type 3 SPICE kernel files. [#15612]
    [#]## astropy.cosmology
    * The exponent in w0wzCDM.de_density_scale has been corrected to
      3, from -3. This correction has also been made to the scalar
      inv_efunc cpython functions. [#14991]
    * pandas.Series are now uniformly converted to their underlying
      data type when given as an argument to a Cosmology method.
      [#15600]
    [#]## astropy.io.fits
    * Reading a table from FITS now respects the TNULL property of a
      column, passing it into the column’s fill_value. [#14723]
    * Fix crash when a PrimaryHDU has a GROUPS keyword with a
      non-boolean value (i.e. not a random-groups HDU). [#14998]
    * Fixed a bug that caused Cutout2D to not work correctly with
      CompImageHDU.section [#14999]
    * Fixed a bug that caused compressed images with TFORM missing
      the optional ‘1’ prefix to not be readable. [#15001]
    * Ensure that tables written to FITS with both masked and
      unmasked columns roundtrip properly (previously, all integer
      columns would become masked if any column was masked). [#15473]
    * Fix segfault with error report in tile decompression. [#15489]
    [#]## astropy.io.votable
    * Output of repr for VOTable instance now clearly shows it is a
      VOTable and not generic astropy Table. [#14702]
    [#]## astropy.modeling
    * All models can be pickled now. [#14902]
    [#]## astropy.nddata
    * Restore bitmask propagation behavior in NDData.mask, plus a fix
      for arithmetic between masked and unmasked NDData objects.
      [#14995]
    [#]## astropy.table
    * Table.as_array now respects the fill_value property of masked
      columns. [#14723]
    * Fix a bug where table indexes were not using a stable sort
      order. This was causing the order of rows within groups to not
      match the original table order when an indexed table was
      grouped. [#14907]
    * Fixed issue #14964 that when grouping a Table on a mixin column
      such as Quantity or Time, the grouped table keys did not
      reflect the original column values. For Quantity this meant
      that the key values were pure float values without the unit,
      while for Time the key values were the pair of jd1 and jd2
      float values. [#14966]
    [#]## astropy.time
    * Ensure that the Time caches of formats and scales do not get
      out of sync with the actual data, even if another instance,
      holding a view of the data is written to. E.g., if one does t01
      = t[:2], and sets t[0] after, it is now guaranteed that
      t01.value will correctly reflect that change in value. [#15453]
    [#]## astropy.units
    * In VOunits, “pix”, “au”, “a”, and “ct” are removed from the
      list of deprecated units. [#14885]
    [#]## astropy.utils
    * Ufuncs with more than 2 operands (such as erfa.dtf2d) now work
      also if all inputs are scalars and more than two inputs have
      masks. [#15450]
    * Ensured that str(masked_array) looks like str(unmasked_array)
      also for array scalars. Thus, like regular array scalars, the
      precision is ignored for float, and strings do not include
      extra quoting. [#15451]
    [#]## astropy.visualization
    * The location of ticklabels on a WCSAxes is now correctly
      calculated when the figure is rasterized. [#14760]
    * Fixed a bug where a ValueError would be raised in the
      AsinhStretch and SinhStretch classes for valid a parameter
      values. [#15539]
    [#]## astropy.wcs
    * wcs.validate(filename) now properly closes the file handler.
      [#15054]
    * Fix a regression in custom WCS mapping due to the recent
      introduction of Solar System frames. [#15630]
    [#]# Other Changes and Additions
    * The minimum supported version of NumPy is now 1.22. [#15006]
    * Moved International Earth Rotation and Reference Systems (IERS)
      and Leap Second files out into standalone astropy-iers-data
      package, maintaining full backward-compatibility in the
      astropy.utils.iers API. Deprecation warnings may be issued when
      certain files are accessed directly. [#14819]
    * Switch from using setup.cfg for project configuration to using
      pyproject.toml. [#15247]
    * Update bundled expat to 2.5.0. [#15585]
  - Drop astropy-pr15479-pvstar.patch
* Wed Nov 08 2023 Ben Greiner <code@bnavigator.de>
  - Add astropy-pr15479-pvstar.patch
    * PR gh#astropy/astropy#15479 backports gh#astropy/astropy#15476
    * Issue at gh#astropy/astropy#15537
* Fri Oct 06 2023 Ben Greiner <code@bnavigator.de>
  - Update to 5.3.4
    [#]# Bug Fixes
    [#]## astropy.io.misc
    * Updated ``astropy.io.misc.yaml`` so ``dump()` with a numpy
      object array or ``load()`` with YAML representing a Numpy
      object array both raise ``TypeError``. This prevents problems
      like a segmentation fault. [#15373]
    [#]## astropy.io.votable
    * Fixed a bug in ``convert_to_writable_filelike`` where
      ``GzipFile`` was not closed properly. [#15359]
    [#]## astropy.units
    * In VOUnit, the spaces around the slash were removed in the
      formatting of fractions, and fractional powers now also use the
      "**" operator. [#15282]
    * We now ensure that the unit ``u.cgs.cm`` is just an alias of
      ``u.si.cm``, instead of a redefinition.  This ensures that
      ``u.Unit("cm") / u.cm`` will reliably cancel to dimensionless
      (instead of some "cm / cm"). [#15368]
    [#]## astropy.utils
    * For ``Masked``, ``np.ptp`` and the ``.ptp()`` method now
      properly account for the mask, ensuring the result is identical
      to subtracting the maximum and minimum (with the same
      arguments). [#15380]
    [#]# Other Changes and Additions
    * Compatibility with Python 3.12. [#14784]
    * Replaced the URL of ``IETF_LEAP_SECOND_URL`` because the
      original is now defunct and IETF now defers to IANA for such
      look-up. [#15421]
* Thu Sep 14 2023 Ben Greiner <code@bnavigator.de>
  - Update to 5.3.3
    [#]# Bug Fixes
    [#]## astropy.coordinates
    * TransformGraph.to_dot_graph() now throws an exception for
      invalid savelayout.
    [#]## astropy.cosmology
    * The exponent of w0wzCDM functions in inv_efunc has been
      corrected to 3, from -3. [#15224]
    [#]## astropy.modeling
    * Astropy modeling can filter non-finite data values using the
      filter_non_finite keyword argument in a fitter call. Now when
      filter_non_finite is True, non-finite weights will also be
      filtered to prevent crashes in LevMarLSQFitter. [#15215]
    [#]## astropy.units
    * Fixed astropy.units.Quantity’s implementation of
      numpy.nanmedian(), where for Numpy >= 1.25 an exception was
      raised for some array shapes and axis combinations. [#15228]
    [#]# Other Changes and Additions
    * v5.3.x will not support NumPy 2.0 or later. [#15234]
  - Restrain to Cython < 3 -- gh#astropy/astropy#15315
* Tue Aug 22 2023 Ben Greiner <code@bnavigator.de>
  - Update to 5.3.2
    [#]## astropy.coordinates
    * Fixed import when called with Python -OO flag. [#15037]
    [#]## astropy.nddata
    * Fix for collapse operations on NDData without masks or units.
      [#15082]
    [#]##  astropy.units
    * Modified the implementation of np.power() for instances of
      Quantity to allow any array as the second operand if all its
      elements have the same value. [#15101]
* Sun Jul 16 2023 Dirk Müller <dmueller@suse.com>
  - update to 5.3.1:
    * The exponent in ``wowzCDM.de_density_scale`` has been
      corrected to 3, from -3.
    * Fix crash when a PrimaryHDU has a GROUPS keyword with a non-
      boolean value (i.e. not a random-groups HDU).
    * Fixed a bug that caused ``Cutout2D`` to not work correctly
      with ``CompImageHDU.section``
    * Fixed a bug that caused compressed images with TFORM missing
      the optional '1' prefix to not be readable. [#15001]
    * Restore bitmask propagation behavior in ``NDData.mask``, plus
      a fix for arithmetic between masked and unmasked ``NDData``
      objects.
    * Fix a bug where table indexes were not using a stable sort
      order. This was causing the order of rows within groups to
      not match the original table order when an indexed table
      was grouped. [#14907]
    * In VOunits, "pix", "au", "a", and "ct" are removed from the
      list of deprecated units. [#14885]
* Sat Jul 01 2023 Ben Greiner <code@bnavigator.de>
  - Update to 5.3
    * New flat astropy.cosmology classes
    * New union operators for Table
    * Efficient data access for compressed FITS files
    * Added support for NOCOMPRESS for compressed FITS files
    * New fraction option for representing units as strings
    * Change in order in unit string representations
    * Support for collapse operations on arbitrary axes in nddata
    * Refresh cached observatory site registry for EarthLocation
      methods
    * Support for collapse operations on arbitrary axes in nddata
    * New LombScargleMultiband class for multiband datasets
  - Remove unbundling of cfitsio -- gh#astropy/astropy#14311
* Wed Apr 26 2023 Ben Greiner <code@bnavigator.de>
  - Update to 5.2.2
    [#]# Bug Fixes
    [#]## astropy.io.ascii
    * CDS and MRT tables with units that contain with multiple
      divisions, such as km/s/Mpc now parse correctly as being equal
      to km/(s.Mpc). [#14369]
    [#]## astropy.io.fits
    * Fix FITSDiff when table contains a VLA column with the Q type.
      [#14539]
    [#]## astropy.table
    * Fix a bug when creating a QTable when a Quantity input column
      is present and the units argument modifies the unit of that
      column. This now works as expected where previously this caused
      an exception. [#14357]
    [#]## astropy.units
    * CDS units with multiple divisions, such as km/s/Mpc now parse
      correctly as being equal to km/(s.Mpc). [#14369]
    [#]## astropy.wcs
    * Fixed a bug that caused subclasses of BaseHighLevelWCS and
      HighLevelWCSMixin to not work correctly under certain
      conditions if they did not have world_n_dim and pixel_n_dim
      defined on them. [#14495]
* Sun Feb 19 2023 Ben Greiner <code@bnavigator.de>
  - Don't test with skyfield on python311: gh#brandon-rhodes/assay#15
* Fri Jan 13 2023 Ben Greiner <code@bnavigator.de>
  - Update to 5.2.1
    [#]# Bug Fixes
    [#]## astropy.coordinates
    * Fix to ITRS frame earth_location attribute to give the correct
      result for a topocentric frame. [#14180]
    [#]## astropy.cosmology
    * Bounds are no longer passed to the scipy minimizer for methods
      Brent and Golden. The scipy minimizer never used the bounds but
      silently accepted them. In scipy v1.11.0.dev0+ an error is
      raised, so we now pass None as the bounds to the minimizer.
      Users should not be affected by this change. [#14232]
    [#]## astropy.io.fits
    * Tables with multidimensional variable length array can now be
      properly read and written. [#13417]
    [#]## astropy.units
    * Modified the behavior of numpy.histogram(),
      numpy.histogram_bin_edges(), numpy.histogram2d(), and
      numpy.histogramdd() so that the range argument must a
      compatible instance of astropy.units.Quantity if the other
      arguments are instances of astropy.units.Quantity. [#14213]
    [#]## astropy.visualization
    * Improved the performance of drawing WCSAxes grids by skipping
      some unnecessary computations. [#14164]
    * Fixed WCSAxes sometimes triggering a NumPy RuntimeWarning when
      determining the coordinate range of the axes. [#14211]
    [#]# Other Changes and Additions
    * Fix compatibility with Numpy 1.24. [#14193]
  - Drop astropy-pr14194-numpy1.24.patch
* Wed Dec 21 2022 Ben Greiner <code@bnavigator.de>
  - Update to 5.2
    * Astropy 5.2 is a major release that adds significant new
      functionality since the 5.1 release.
    * In particular, this release includes:
    * Quantity data types
    * Updates to astropy.cosmology
    * Topocentric ITRS Frame
    * Enhanced Fixed Width ASCII Tables
    * Accessing cloud-hosted FITS files
    * Drawing the instrument beam and a physical scale bar on
      celestial images
    * Interior ticks and tick labels
    * Support for tilde-prefixed paths
    * CCDData PSF Image representation
    * In addition to these major changes, Astropy 5.2 includes a
      large number of smaller improvements and bug fixes.
  - Move to PEP517 build
  - Revert rpmlintrc: the whitelist error category has been removed
    from rpmlint
  - Add astropy-pr14194-numpy1.24.patch gh#astropy/astropy#14194
* Mon Nov 21 2022 Ben Greiner <code@bnavigator.de>
  - Whitelist stupid rpmlint error
    * https://docs.astropy.org/en/latest/development/testguide.html#astropy-test
    * gh#rpm-software-management/rpmlint#965
* Sun Oct 23 2022 Ben Greiner <code@bnavigator.de>
  - Update to 5.1.1
    [#] API Changes
    [#]# astropy.wcs
    * The pixel argument to
      astropy.visualization.wcsaxes.ticklabels.TickLabels.add no
      longer does anything, is deprecated, and will be removed in a
      future astropy version. It has been replaced by a new required
      data argument, which should be used to specify the data
      coordinates of the tick label being added.
    * This changes has been made because it is (in general) not
      possible to correctly calculate pixel coordinates before
      Matplotlib is drawing a figure. [#12630]
    [#] Bug Fixes
    [#]# astropy.coordinates
    * Fixed a bug that prevented SkyOffsetFrame instances to be
      pickled by adding a custom __reduce__ method to the class (see
      issue #9249). [#13305]
    * Fixed the check for invalid Latitude values for float32 values.
      Latitude now accepts the float32 value of pi/2, which was
      rejected before because a comparison was made using the
      slightly smaller float64 representation. See issue #13708.
      [#13745]
    [#]# astropy.io.ascii
    * Fixed confusing chained exception messages of read() function
      when it fails. [#13170]
    * When writing out a :class:`~astropy.table.Table` to HTML
      format, the formats keyword argument to the
      :meth:`~astropy.table.Table.write` method will now be applied.
      [#13453]
    [#]# astropy.io.fits
    * heapsize is now checked for VLA tables. An error is thrown
      whether P format is used but the heap size is bigger than what
      can be indexed with a 32 bit signed int. [#13429]
    * Fix parsing of ascii TFORM when precision is missing. [#13520]
    * A compressed image HDU created from the header of a PRIMARY
      HDU, now correctly updates 'XTENSION' and 'SIMPLE' keywords.
      [#13557]
    * Empty variable-length arrays are now properly handled when
      pathological combinations of heapoffset and heapsize are
      encountered. [#13621]
    * PCOUNT and GCOUNT keywords are now removed from an uncompressed
      Primary header, for compliancy with fitsverify behavior.
      [#13753]
    [#]# astropy.modeling
    * Bugfix for using MagUnit units on model parameters. [#13158]
    * Fix bug in using non-linear fitters to fit 0-degree polynomials
      using weights. [#13628]
    [#]# astropy.table
    * Fix a problem where accessing one field of a structured column
      returned a Column with the same info as the original column.
      This resulted in unintuitive behavior in general and an
      exception if the format for the column was set. [#13269]
    * Tables with columns with structured data can now be properly
      stacked and joined. [#13306]
    * Update jQuery to 3.6.0, to pick up security fixes. [#13438]
    * Fix a Python 3.11 compatibility issue. Ensure that when
      removing a table column that the pprint_include_names or
      pprint_exclude_names attributes get updated correctly. [#13639]
    * When using add_columns with same indexes in indexes option or
      without specifying the option, the order of the new columns
      will now be kept. [#13783]
    * Fix a bug when printing or getting the representation of a
      multidimensional table column that has a zero dimension.
      [#13838]
    * Ensure that mixin columns and their info are not shared between
      tables even when their underlying data is shared with
      copy=False. [#13842]
    [#]# astropy.time
    * Fix Time.insert() on times which have their out_subfmt set.
      [#12732]
    * Prevent Time() from being initialized with an invalid precision
      leading to incorrect results when representing the time as a
      string. [#13068]
    * Fix a bug in Time where a date string like "2022-08-01.123" was
      being parsed as an ISO-format time "2022-08-01 00:00:00.123".
      The fractional part at the end of the string was being taken as
      seconds. Now this raises an exception because the string is not
      in ISO format. [#13731]
    [#]# astropy.units
    * Significantly improved the performance of parsing composite
      units with the FITS format, by ensuring the detailed_exception
      argument is properly passed on and thus used. [#12699]
    * Ensure that np.concatenate on quantities can take a dtype
      argument (added in numpy 1.20). [#13323]
    * Ensure that the units of any initial argument to reductions
      such as np.add.reduce (which underlies np.sum) are properly
      taken into account. [#13340]
    [#]# astropy.utils
    * Ensure that np.concatenate on masked data can take a dtype
      argument (added in numpy 1.20). [#13323]
    * Fix error when suppressing download progress bar while using
      non-default sys.stdout stream. [#13352]
    * Ensure str and repr work properly for Masked versions of
      structured subarrays. [#13404]
    * If an attribute is created using deprecated_attribute() with
      the alternative argument then getting or setting the value of
      the deprecated attribute now accesses its replacement. [#13824]
    [#]# astropy.visualization
    * Fixed calling .tight_layout() on a WCSAxes. [#12418]
    [#]# astropy.wcs
    * WCS.pixel_to_world now creates an EarthLocation object using
      MJD-AVG if present before falling back to the old behaviour of
      using MJD-OBS. [#12598]
    * The locations of WCSAxes ticks and tick-labels are now
      correctly calculated when the DPI of a figure changes between a
      WCSAxes being created and the figure being drawn, or when a
      rasterized artist is added to the WCSAxes. [#12630]
    * Fix a bug where SlicedLowLevelWCS.world_to_pixel_values would
      break when the result of the transform is dependent on the
      coordinate of a sliced out pixel. [#13579]
    * Updated bundled WCSLIB version to 7.12. This update includes
      bug fixes to wcssub() in how it handles temporal axes with -TAB
      and fixes handling of status returns from linp2x() and linx2p()
      relating to distortion functions, in particular affecting TPV
      distortions - see #13509. For a full 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
      for multi-extension FITS file. [#13668]
* Mon Jun 20 2022 Ben Greiner <code@bnavigator.de>
  - Skip two tests because of hypothesis -- gh#astropy/astropy#13275
* Tue May 31 2022 Ben Greiner <code@bnavigator.de>
  - Skip two test categories segfaulting: gh#astropy/astropy#13286
* Thu May 26 2022 Ben Greiner <code@bnavigator.de>
  - Update to 5.1
    * Astropy 5.1 is a major release that adds significant new
      functionality since the 5.0 LTS release.
    * In particular, this release includes:
    - Updates to cosmology
    - doppler_redshift() equivalency
    - Specifying data types when reading ASCII tables
    - Structured Columns
    - New model fitters have been added
    - Allow time conversions without predictive Earth rotation data
      (IERS-A)
    - Uncertainty classes can be transformed into each other
    - Schechter1D Model
    * In addition to these major changes, Astropy v5.1 includes a
      large number of smaller improvements and bug fixes, which are
      described in the Full Changelog.
* Sat Apr 23 2022 Ben Greiner <code@bnavigator.de>
  - Enable tests requiring Pytest 7
* Fri Apr 01 2022 Ben Greiner <code@bnavigator.de>
  - Update to 5.0.4
    [#] Bug Fixes
    [#]# astropy.modeling
    * Fixed the Gaussian2D bounding_box when theta is an angular
      Quantity. [#13021]
    [#]# astropy.utils
    * Reverted astropy.utils.iers.iers.IERS_A_URL to
      maia.usno.navy.mil domain instead of NASA FTP to work around
      server issues. [#13004]
    [#] Other Changes and Additions
    * Updated bundled WCSLIB to version 7.9 with several bugfixes and
      added support for time coordinate axes in wcsset() and
      wcssub(). The four-digit type code for the time axis will have
      the first digit set to 4, i.e., four digit code will be 4xxx
      where x is a digit 0-9. For a full list of bug fixes see
      https://www.atnf.csiro.au/people/mcalabre/WCS/CHANGES [#12994]
      (when building --without system_wcslib)
  - Release 5.0.3
    [#] Bug Fixes
    [#]# astropy.convolution
    * Bugfix in astropy.convolution.utils.discretize_model which
      allows the function to handle a CompoundModel. Before this fix,
      discretize_model was confusing CompoundModel with a callable
      function. [#12959]
    [#]# astropy.io.fits
    * Fix write and read FITS tables with multidimensional items,
      using from_columns without previousely defined ColDefs
      structure. [#12863]
    [#]# astropy.io.votable
    * Fix VOTable linting to avoid use of shell option. [#12985]
    astropy.utils
    * Fix XML linting to avoid use of shell option. [#12985]
    [#] Other Changes and Additions
    * Updated the bundled CFITSIO library to 4.1.0. [#12967]
      (when building --without system_cfitsio)
* Sun Mar 13 2022 Ben Greiner <code@bnavigator.de>
  - Update to 5.0.2
    astropy.io.ascii
    * Bugfix to add backwards compatibility for reading ECSV version
      0.9 files with non-standard column datatypes (such as `object`,
      `str`, `datetime64`, etc.), which would raise a ValueError in
      ECSV version 1.0. [#12880]
    * astropy.io.misc
    * Bugfix for `units_mapping` schema's property name conflicts.
      Changes:
    - `inputs` to `unit_inputs`
    - `outputs` to `unit_outputs` [#12800]
    astropy.io.votable
    * Fixed a bug where `astropy.io.votable.validate` was printing
      output to `sys.stdout` when the `output` paramter was set to
      `None`. `validate` now returns a string when `output` is set to
      `None`, as documented. [#12604]
    astropy.modeling
    * Fix handling of units on `scale` parameter in BlackBody model.
      [#12318]
    * Indexing on models can now be used with all types of integers
      (like `numpy.int64`) instead of just `int`. [#12561]
    * Fix computation of the separability of a `CompoundModel` where
      another `CompoundModel` is on the right hand side of the `&`
      operator. [#12907]
    * Provide a hook (`Model._calculate_separability_matrix`) to
      allow subclasses of `Model` to define how to compute their
      separability matrix. [#12900]
    astropy.stats
    * Fixed a bug in which running
      `kuiper_false_positive_probability(D,N)` on distributions with
      many data points could produce NaN values for the false
      positive probability of the Kuiper statistic. [#12896]
    astropy.wcs
    * Fixed a bug due to which `naxis`, `pixel_shape`, and
      `pixel_bounds` attributes of `astropy.wcs.WCS` were not
      restored when an `astropy.wcs.WCS` object was unpickled. This
      fix also eliminates `FITSFixedWarning` warning issued during
      unpiclikng of the WCS objects related to the number of axes.
      This fix also eliminates errors when unpickling WCS objects
      originally created using non-default values for `key`,
      `colsel`, and `keysel` parameters. [#12844]
* Fri Jan 28 2022 Ben Greiner <code@bnavigator.de>
  - Update to 5.0.1
    astropy.coordinates
    * Trying to create an instance of astropy.coordinates.Distance by
      providing both z and parallax now raises the expected
      ValueError. [#12531]
    * Fixed a bug where changing the wrap angle of the longitude
      component of a representation could raise a warning or error in
      certain situations. [#12556]
    * astropy.coordinates.Distance constructor no longer ignores the
      unit keyword when parallax is provided. [#12569]
    astropy.cosmology
    * astropy.cosmology.utils.aszarr can now convert Column objects.
      [#12525]
    * Reading a cosmology from an ECSV will load redshift and Hubble
      parameter units from the cosmology units module. [#12636]
    astropy.io.fits
    * Fix formatting issue in _dump_coldefs and add tests for
      tabledump and tableload convenience functions. [#12526]
    astropy.io.misc
    * YAML can now also represent quantities and arrays with
      structured dtype, as well as structured scalars based on
      np.void. [#12509]
    astropy.modeling
    * Fixes error when fitting multiplication or division based
      compound models where the sub-models have different output
      units. [#12475]
    * Bugfix for incorrectly initialized and filled parameters data
      for Spline1D model. [#12523]
    * Bugfix for keyerror thrown by Model.input_units_equivalencies
      when used on fix_inputs models which have no set unit
      equivalencies. [#12597]
    astropy.table
    * astropy.table.Table.keep_columns() and
      astropy.table.Table.remove_columns() now work with generators
      of column names. [#12529]
    * Avoid duplicate storage of info in serialized columns if the
    column used to serialize already can hold that information.
    [#12607] astropy.timeseries
    * Fixed edge case bugs which emerged when using
      aggregate_downsample with custom bins. [#12527]
    astropy.units
    * Structured units can be serialized to/from yaml. [#12492]
    * Fix bad typing problems by removing interaction with
      NDArray.__class_getitem__. [#12511]
    * Ensure that Quantity.to_string(format='latex') properly
      typesets exponents also when
      u.quantity.conf.latex_array_threshold = -1 (i.e., when the
      threshold is taken from numpy). [#12573]
    * Structured units can now be copied with copy.copy and
      copy.deepcopy and also pickled and unpicked also for protocol
      >= 2. This does not work for big-endian architecture with older
      numpy<1.21.1. [#12583]
    astropy.utils
    * Ensure that a Masked instance can be used to initialize (or
      viewed as) a numpy.ma.Maskedarray. [#12482]
    * Ensure Masked also works with numpy >=1.22, which has a keyword
      argument name change for np.quantile. [#12511]
    * astropy.utils.iers.LeapSeconds.auto_open() no longer emits
      unnecessary warnings when astropy.utils.iers.conf.auto_max_age
      is set to None. [#12713]

Files

/etc/alternatives/fits2bitmap
/etc/alternatives/fitscheck
/etc/alternatives/fitsdiff
/etc/alternatives/fitsheader
/etc/alternatives/fitsinfo
/etc/alternatives/samp_hub
/etc/alternatives/showtable
/etc/alternatives/showtable-astropy
/etc/alternatives/volint
/etc/alternatives/wcslint
/usr/bin/fits2bitmap
/usr/bin/fits2bitmap-3.13
/usr/bin/fitscheck
/usr/bin/fitscheck-3.13
/usr/bin/fitsdiff
/usr/bin/fitsdiff-3.13
/usr/bin/fitsheader
/usr/bin/fitsheader-3.13
/usr/bin/fitsinfo
/usr/bin/fitsinfo-3.13
/usr/bin/samp_hub
/usr/bin/samp_hub-3.13
/usr/bin/showtable
/usr/bin/showtable-3.13
/usr/bin/showtable-astropy
/usr/bin/showtable-astropy-3.13
/usr/bin/volint
/usr/bin/volint-3.13
/usr/bin/wcslint
/usr/bin/wcslint-3.13
/usr/lib64/python3.13/site-packages/astropy
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/INSTALLER
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/METADATA
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/RECORD
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/REQUESTED
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/WHEEL
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/entry_points.txt
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/licenses
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/licenses/LICENSE.rst
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/licenses/licenses
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/licenses/licenses/AURA_LICENSE.rst
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/licenses/licenses/CONFIGOBJ_LICENSE.rst
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/licenses/licenses/DATATABLES_LICENSE.rst
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/licenses/licenses/ERFA.rst
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/licenses/licenses/GATSPY_LICENSE.rst
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/licenses/licenses/JQUERY_LICENSE.rst
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/licenses/licenses/NUMPY_LICENSE.rst
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/licenses/licenses/PLY_LICENSE.rst
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/licenses/licenses/POSITIONAL_DEFAULTS.rst
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/licenses/licenses/PYFITS.rst
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/licenses/licenses/PYTHON.rst
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/licenses/licenses/README.rst
/usr/lib64/python3.13/site-packages/astropy-7.1.0.dist-info/top_level.txt
/usr/lib64/python3.13/site-packages/astropy/CITATION
/usr/lib64/python3.13/site-packages/astropy/__init__.py
/usr/lib64/python3.13/site-packages/astropy/__pycache__
/usr/lib64/python3.13/site-packages/astropy/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/__pycache__/_version.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/__pycache__/_version.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/__pycache__/conftest.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/__pycache__/conftest.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/__pycache__/logger.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/__pycache__/logger.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/__pycache__/version.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/__pycache__/version.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/_compiler.c
/usr/lib64/python3.13/site-packages/astropy/_version.py
/usr/lib64/python3.13/site-packages/astropy/compiler_version.cpython-313-aarch64-linux-gnu.so
/usr/lib64/python3.13/site-packages/astropy/config
/usr/lib64/python3.13/site-packages/astropy/config/__init__.py
/usr/lib64/python3.13/site-packages/astropy/config/__pycache__
/usr/lib64/python3.13/site-packages/astropy/config/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/config/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/config/__pycache__/configuration.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/config/__pycache__/configuration.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/config/__pycache__/paths.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/config/__pycache__/paths.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/config/configuration.py
/usr/lib64/python3.13/site-packages/astropy/config/paths.py
/usr/lib64/python3.13/site-packages/astropy/config/tests
/usr/lib64/python3.13/site-packages/astropy/config/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/config/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/config/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/config/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/config/tests/__pycache__/test_configs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/config/tests/__pycache__/test_configs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/config/tests/data
/usr/lib64/python3.13/site-packages/astropy/config/tests/data/alias.cfg
/usr/lib64/python3.13/site-packages/astropy/config/tests/data/deprecated.cfg
/usr/lib64/python3.13/site-packages/astropy/config/tests/data/empty.cfg
/usr/lib64/python3.13/site-packages/astropy/config/tests/data/not_empty.cfg
/usr/lib64/python3.13/site-packages/astropy/config/tests/test_configs.py
/usr/lib64/python3.13/site-packages/astropy/conftest.py
/usr/lib64/python3.13/site-packages/astropy/constants
/usr/lib64/python3.13/site-packages/astropy/constants/__init__.py
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/astropyconst13.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/astropyconst13.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/astropyconst20.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/astropyconst20.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/astropyconst40.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/astropyconst40.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/cgs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/cgs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/codata2010.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/codata2010.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/codata2014.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/codata2014.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/codata2018.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/codata2018.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/config.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/config.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/constant.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/constant.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/iau2012.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/iau2012.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/iau2015.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/iau2015.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/si.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/si.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/astropyconst13.py
/usr/lib64/python3.13/site-packages/astropy/constants/astropyconst20.py
/usr/lib64/python3.13/site-packages/astropy/constants/astropyconst40.py
/usr/lib64/python3.13/site-packages/astropy/constants/cgs.py
/usr/lib64/python3.13/site-packages/astropy/constants/codata2010.py
/usr/lib64/python3.13/site-packages/astropy/constants/codata2014.py
/usr/lib64/python3.13/site-packages/astropy/constants/codata2018.py
/usr/lib64/python3.13/site-packages/astropy/constants/config.py
/usr/lib64/python3.13/site-packages/astropy/constants/constant.py
/usr/lib64/python3.13/site-packages/astropy/constants/iau2012.py
/usr/lib64/python3.13/site-packages/astropy/constants/iau2015.py
/usr/lib64/python3.13/site-packages/astropy/constants/si.py
/usr/lib64/python3.13/site-packages/astropy/constants/tests
/usr/lib64/python3.13/site-packages/astropy/constants/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/constants/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/constants/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/tests/__pycache__/test_constant.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/tests/__pycache__/test_constant.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/tests/__pycache__/test_pickle.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/tests/__pycache__/test_pickle.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/tests/__pycache__/test_prior_version.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/tests/__pycache__/test_prior_version.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/tests/__pycache__/test_sciencestate.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/tests/__pycache__/test_sciencestate.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/constants/tests/test_constant.py
/usr/lib64/python3.13/site-packages/astropy/constants/tests/test_pickle.py
/usr/lib64/python3.13/site-packages/astropy/constants/tests/test_prior_version.py
/usr/lib64/python3.13/site-packages/astropy/constants/tests/test_sciencestate.py
/usr/lib64/python3.13/site-packages/astropy/constants/utils.py
/usr/lib64/python3.13/site-packages/astropy/convolution
/usr/lib64/python3.13/site-packages/astropy/convolution/__init__.py
/usr/lib64/python3.13/site-packages/astropy/convolution/__pycache__
/usr/lib64/python3.13/site-packages/astropy/convolution/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/__pycache__/convolve.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/__pycache__/convolve.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/__pycache__/kernels.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/__pycache__/kernels.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/__pycache__/setup_package.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/__pycache__/setup_package.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/_convolve.cpython-313-aarch64-linux-gnu.so
/usr/lib64/python3.13/site-packages/astropy/convolution/_convolve.pyx
/usr/lib64/python3.13/site-packages/astropy/convolution/convolve.py
/usr/lib64/python3.13/site-packages/astropy/convolution/core.py
/usr/lib64/python3.13/site-packages/astropy/convolution/kernels.py
/usr/lib64/python3.13/site-packages/astropy/convolution/setup_package.py
/usr/lib64/python3.13/site-packages/astropy/convolution/src
/usr/lib64/python3.13/site-packages/astropy/convolution/src/convolve.c
/usr/lib64/python3.13/site-packages/astropy/convolution/src/convolve.h
/usr/lib64/python3.13/site-packages/astropy/convolution/tests
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__/test_convolve.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__/test_convolve.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__/test_convolve_fft.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__/test_convolve_fft.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__/test_convolve_kernels.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__/test_convolve_kernels.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__/test_convolve_models.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__/test_convolve_models.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__/test_convolve_nddata.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__/test_convolve_nddata.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__/test_discretize.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__/test_discretize.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__/test_kernel_class.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__/test_kernel_class.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__/test_pickle.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/__pycache__/test_pickle.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/test_convolve.py
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/test_convolve_fft.py
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/test_convolve_kernels.py
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/test_convolve_models.py
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/test_convolve_nddata.py
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/test_discretize.py
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/test_kernel_class.py
/usr/lib64/python3.13/site-packages/astropy/convolution/tests/test_pickle.py
/usr/lib64/python3.13/site-packages/astropy/convolution/utils.py
/usr/lib64/python3.13/site-packages/astropy/coordinates
/usr/lib64/python3.13/site-packages/astropy/coordinates/__init__.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/attributes.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/attributes.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/baseframe.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/baseframe.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/calculation.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/calculation.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/distances.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/distances.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/earth.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/earth.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/earth_orientation.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/earth_orientation.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/erfa_astrom.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/erfa_astrom.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/errors.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/errors.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/funcs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/funcs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/jparser.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/jparser.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/matching.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/matching.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/matrix_utilities.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/matrix_utilities.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/name_resolve.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/name_resolve.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/polarization.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/polarization.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/sites.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/sites.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/sky_coordinate.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/sky_coordinate.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/sky_coordinate_parsers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/sky_coordinate_parsers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/solar_system.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/solar_system.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/spectral_coordinate.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/spectral_coordinate.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/spectral_quantity.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/__pycache__/spectral_quantity.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/__init__.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/__pycache__
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/__pycache__/angle_lextab.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/__pycache__/angle_lextab.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/__pycache__/angle_parsetab.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/__pycache__/angle_parsetab.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/__pycache__/errors.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/__pycache__/errors.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/__pycache__/formats.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/__pycache__/formats.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/angle_lextab.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/angle_parsetab.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/core.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/errors.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/formats.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/angles/utils.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/attributes.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/baseframe.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__init__.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/altaz.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/altaz.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/baseradec.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/baseradec.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/cirs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/cirs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/cirs_observed_transforms.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/cirs_observed_transforms.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/ecliptic.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/ecliptic.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/ecliptic_transforms.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/ecliptic_transforms.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/equatorial.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/equatorial.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/fk4.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/fk4.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/fk4_fk5_transforms.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/fk4_fk5_transforms.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/fk5.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/fk5.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/galactic.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/galactic.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/galactic_transforms.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/galactic_transforms.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/galactocentric.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/galactocentric.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/gcrs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/gcrs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/hadec.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/hadec.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/hcrs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/hcrs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/icrs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/icrs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/icrs_cirs_transforms.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/icrs_cirs_transforms.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/icrs_fk5_transforms.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/icrs_fk5_transforms.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/icrs_observed_transforms.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/icrs_observed_transforms.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/intermediate_rotation_transforms.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/intermediate_rotation_transforms.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/itrs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/itrs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/itrs_observed_transforms.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/itrs_observed_transforms.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/lsr.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/lsr.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/skyoffset.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/skyoffset.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/supergalactic.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/supergalactic.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/supergalactic_transforms.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/supergalactic_transforms.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/altaz.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/baseradec.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/cirs.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/cirs_observed_transforms.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/ecliptic.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/ecliptic_transforms.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/equatorial.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/fk4.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/fk4_fk5_transforms.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/fk5.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/galactic.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/galactic_transforms.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/galactocentric.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/gcrs.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/hadec.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/hcrs.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/icrs.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/icrs_cirs_transforms.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/icrs_fk5_transforms.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/icrs_observed_transforms.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/intermediate_rotation_transforms.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/itrs.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/itrs_observed_transforms.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/lsr.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/skyoffset.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/supergalactic.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/supergalactic_transforms.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/builtin_frames/utils.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/calculation.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/data
/usr/lib64/python3.13/site-packages/astropy/coordinates/data/constellation_data_roman87.dat
/usr/lib64/python3.13/site-packages/astropy/coordinates/data/constellation_names.dat
/usr/lib64/python3.13/site-packages/astropy/coordinates/data/sites.json
/usr/lib64/python3.13/site-packages/astropy/coordinates/distances.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/earth.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/earth_orientation.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/erfa_astrom.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/errors.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/funcs.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/jparser.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/matching.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/matrix_utilities.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/name_resolve.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/polarization.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/__init__.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/__pycache__
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/__pycache__/base.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/__pycache__/base.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/__pycache__/cartesian.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/__pycache__/cartesian.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/__pycache__/cylindrical.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/__pycache__/cylindrical.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/__pycache__/geodetic.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/__pycache__/geodetic.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/__pycache__/spherical.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/__pycache__/spherical.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/base.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/cartesian.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/cylindrical.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/geodetic.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/representation/spherical.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/sites.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/sky_coordinate.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/sky_coordinate_parsers.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/solar_system.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/spectral_coordinate.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/spectral_quantity.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/helper.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/helper.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_angle_generators.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_angle_generators.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_angles.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_angles.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_angular_separation.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_angular_separation.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_api_ape5.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_api_ape5.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_arrays.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_arrays.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_atc_replacements.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_atc_replacements.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_celestial_transformations.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_celestial_transformations.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_distance.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_distance.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_earth.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_earth.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_earth_orientation.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_earth_orientation.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_erfa_astrom.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_erfa_astrom.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_exceptions.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_exceptions.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_finite_difference_velocities.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_finite_difference_velocities.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_formatting.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_formatting.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_frames.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_frames.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_frames_with_velocity.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_frames_with_velocity.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_funcs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_funcs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_geodetic_representations.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_geodetic_representations.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_iau_fullstack.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_iau_fullstack.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_icrs_observed_transformations.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_icrs_observed_transformations.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_intermediate_transformations.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_intermediate_transformations.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_masked.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_masked.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_matching.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_matching.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_matrix_utilities.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_matrix_utilities.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_name_resolve.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_name_resolve.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_pickle.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_pickle.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_polarization.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_polarization.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_regression.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_regression.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_representation.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_representation.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_representation_arithmetic.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_representation_arithmetic.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_representation_methods.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_representation_methods.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_separation.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_separation.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_shape_manipulation.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_shape_manipulation.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_sites.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_sites.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_sky_coord.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_sky_coord.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_sky_coord_velocities.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_sky_coord_velocities.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_skyoffset_transformations.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_skyoffset_transformations.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_solar_system.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_solar_system.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_spectral_coordinate.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_spectral_coordinate.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_spectral_quantity.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_spectral_quantity.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_transformations.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_transformations.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_unit_representation.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_unit_representation.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_velocity_corrs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/__pycache__/test_velocity_corrs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__init__.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__/generate_ref_ast.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__/generate_ref_ast.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__/generate_spectralcoord_ref.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__/generate_spectralcoord_ref.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__/test_altaz_icrs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__/test_altaz_icrs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__/test_ecliptic.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__/test_ecliptic.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__/test_fk4_no_e_fk4.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__/test_fk4_no_e_fk4.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__/test_fk4_no_e_fk5.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__/test_fk4_no_e_fk5.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__/test_galactic_fk4.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__/test_galactic_fk4.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__/test_icrs_fk5.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/__pycache__/test_icrs_fk5.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/data
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/data/fk4_no_e_fk4.csv
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/data/fk4_no_e_fk5.csv
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/data/galactic_fk4.csv
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/data/icrs_fk5.csv
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/data/rv.ecsv
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/generate_ref_ast.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/generate_spectralcoord_ref.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/test_altaz_icrs.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/test_ecliptic.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/test_fk4_no_e_fk4.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/test_fk4_no_e_fk5.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/test_galactic_fk4.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/accuracy/test_icrs_fk5.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/data
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/data/barycorr_bvcs.dat
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/data/barycorr_bvcs_withvels.dat
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/data/jpl_moon.dat
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/helper.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_angle_generators.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_angles.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_angular_separation.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_api_ape5.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_arrays.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_atc_replacements.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_celestial_transformations.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_distance.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_earth.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_earth_orientation.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_erfa_astrom.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_exceptions.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_finite_difference_velocities.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_formatting.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_frames.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_frames_with_velocity.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_funcs.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_geodetic_representations.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_iau_fullstack.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_icrs_observed_transformations.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_intermediate_transformations.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_masked.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_matching.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_matrix_utilities.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_name_resolve.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_pickle.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_polarization.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_regression.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_representation.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_representation_arithmetic.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_representation_methods.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_separation.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_shape_manipulation.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_sites.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_sky_coord.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_sky_coord_velocities.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_skyoffset_transformations.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_solar_system.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_spectral_coordinate.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_spectral_quantity.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_transformations.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_unit_representation.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_utils.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/tests/test_velocity_corrs.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/__init__.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/__pycache__
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/__pycache__/affine.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/__pycache__/affine.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/__pycache__/base.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/__pycache__/base.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/__pycache__/composite.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/__pycache__/composite.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/__pycache__/function.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/__pycache__/function.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/__pycache__/graph.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/__pycache__/graph.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/affine.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/base.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/composite.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/function.py
/usr/lib64/python3.13/site-packages/astropy/coordinates/transformations/graph.py
/usr/lib64/python3.13/site-packages/astropy/cosmology
/usr/lib64/python3.13/site-packages/astropy/cosmology/__init__.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/connect.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/connect.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/flrw.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/flrw.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/funcs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/funcs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/io.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/io.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/parameter.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/parameter.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/parameters.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/parameters.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/realizations.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/realizations.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/traits.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/traits.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/units.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/__pycache__/units.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/__init__.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/__pycache__
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/__pycache__/default.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/__pycache__/default.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/__pycache__/setup_package.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/__pycache__/setup_package.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/__pycache__/typing.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/__pycache__/typing.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/__pycache__/units.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/__pycache__/units.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/__pycache__/units_equivalencies.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/__pycache__/units_equivalencies.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/core.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/default.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/__init__.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/__pycache__
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/__pycache__/base.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/__pycache__/base.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/__pycache__/lambdacdm.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/__pycache__/lambdacdm.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/__pycache__/w0cdm.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/__pycache__/w0cdm.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/__pycache__/w0wacdm.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/__pycache__/w0wacdm.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/__pycache__/w0wzcdm.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/__pycache__/w0wzcdm.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/__pycache__/wpwazpcdm.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/__pycache__/wpwazpcdm.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/base.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/lambdacdm.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/scalar_inv_efuncs.cpython-313-aarch64-linux-gnu.so
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/scalar_inv_efuncs.pyx
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/w0cdm.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/w0wacdm.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/w0wzcdm.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/flrw/wpwazpcdm.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/funcs
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/funcs/__init__.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/funcs/__pycache__
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/funcs/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/funcs/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/funcs/__pycache__/comparison.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/funcs/__pycache__/comparison.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/funcs/__pycache__/optimize.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/funcs/__pycache__/optimize.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/funcs/comparison.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/funcs/optimize.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/__init__.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/__pycache__
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/__pycache__/connect.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/__pycache__/connect.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__init__.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/cosmology.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/cosmology.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/ecsv.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/ecsv.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/html.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/html.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/latex.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/latex.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/mapping.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/mapping.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/model.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/model.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/row.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/row.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/table.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/table.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/yaml.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/__pycache__/yaml.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/cosmology.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/ecsv.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/html.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/latex.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/mapping.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/model.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/row.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/table.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/utils.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/builtin/yaml.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/io/connect.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/parameter
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/parameter/__init__.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/parameter/__pycache__
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/parameter/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/parameter/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/parameter/__pycache__/converter.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/parameter/__pycache__/converter.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/parameter/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/parameter/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/parameter/__pycache__/dataclass_utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/parameter/__pycache__/dataclass_utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/parameter/__pycache__/descriptors.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/parameter/__pycache__/descriptors.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/parameter/converter.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/parameter/core.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/parameter/dataclass_utils.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/parameter/descriptors.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/setup_package.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/signature_deprecations.c
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/signature_deprecations.cpython-313-aarch64-linux-gnu.so
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__/conftest.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__/conftest.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__/helper.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__/helper.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__/test_core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__/test_core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__/test_deprecated_modules.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__/test_deprecated_modules.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__/test_parameters.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__/test_parameters.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__/test_realizations.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__/test_realizations.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__/test_units.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__/test_units.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__/test_utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/__pycache__/test_utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/conftest.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__init__.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/conftest.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/conftest.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/test_base.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/test_base.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/test_flrw.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/test_flrw.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/test_lambdacdm.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/test_lambdacdm.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/test_parameters.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/test_parameters.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/test_w.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/test_w.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/test_w0cdm.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/test_w0cdm.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/test_w0wacdm.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/test_w0wacdm.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/test_w0wzcdm.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/test_w0wzcdm.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/test_wpwazpcdm.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/__pycache__/test_wpwazpcdm.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/conftest.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/data
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/data/cosmo_closed.ecsv
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/data/cosmo_flat.ecsv
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/data/cosmo_open.ecsv
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/test_base.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/test_flrw.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/test_lambdacdm.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/test_parameters.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/test_w.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/test_w0cdm.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/test_w0wacdm.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/test_w0wzcdm.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/flrw/test_wpwazpcdm.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/funcs
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/funcs/__init__.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/funcs/__pycache__
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/funcs/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/funcs/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/funcs/__pycache__/test_comparison.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/funcs/__pycache__/test_comparison.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/funcs/__pycache__/test_funcs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/funcs/__pycache__/test_funcs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/funcs/test_comparison.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/funcs/test_funcs.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/helper.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__init__.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/base.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/base.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_connect.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_connect.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_cosmology.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_cosmology.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_ecsv.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_ecsv.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_html.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_html.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_json.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_json.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_latex.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_latex.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_mapping.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_mapping.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_model.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_model.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_row.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_row.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_table.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_table.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_yaml.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/__pycache__/test_yaml.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/base.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/test_.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/test_connect.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/test_cosmology.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/test_ecsv.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/test_html.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/test_json.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/test_latex.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/test_mapping.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/test_model.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/test_row.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/test_table.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/io/test_yaml.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/parameter
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/parameter/__init__.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/parameter/__pycache__
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/parameter/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/parameter/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/parameter/__pycache__/conftest.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/parameter/__pycache__/conftest.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/parameter/__pycache__/test_descriptors.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/parameter/__pycache__/test_descriptors.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/parameter/__pycache__/test_parameter.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/parameter/__pycache__/test_parameter.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/parameter/conftest.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/parameter/test_descriptors.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/parameter/test_parameter.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/test_core.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/test_deprecated_modules.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/test_parameters.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/test_realizations.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/test_units.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/tests/test_utils.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/traits
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/traits/__init__.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/traits/__pycache__
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/traits/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/traits/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/traits/__pycache__/baryons.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/traits/__pycache__/baryons.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/traits/__pycache__/rhocrit.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/traits/__pycache__/rhocrit.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/traits/__pycache__/scale_factor.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/traits/__pycache__/scale_factor.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/traits/__pycache__/tcmb.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/traits/__pycache__/tcmb.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/traits/baryons.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/traits/rhocrit.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/traits/scale_factor.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/traits/tcmb.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/typing.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/units.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/units_equivalencies.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/_src/utils.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/connect.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/core.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/data
/usr/lib64/python3.13/site-packages/astropy/cosmology/data/Planck13.ecsv
/usr/lib64/python3.13/site-packages/astropy/cosmology/data/Planck15.ecsv
/usr/lib64/python3.13/site-packages/astropy/cosmology/data/Planck18.ecsv
/usr/lib64/python3.13/site-packages/astropy/cosmology/data/WMAP1.ecsv
/usr/lib64/python3.13/site-packages/astropy/cosmology/data/WMAP3.ecsv
/usr/lib64/python3.13/site-packages/astropy/cosmology/data/WMAP5.ecsv
/usr/lib64/python3.13/site-packages/astropy/cosmology/data/WMAP7.ecsv
/usr/lib64/python3.13/site-packages/astropy/cosmology/data/WMAP9.ecsv
/usr/lib64/python3.13/site-packages/astropy/cosmology/flrw.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/funcs.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/io.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/parameter.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/parameters.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/realizations.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/traits.py
/usr/lib64/python3.13/site-packages/astropy/cosmology/units.py
/usr/lib64/python3.13/site-packages/astropy/extern
/usr/lib64/python3.13/site-packages/astropy/extern/README.rst
/usr/lib64/python3.13/site-packages/astropy/extern/__init__.py
/usr/lib64/python3.13/site-packages/astropy/extern/__pycache__
/usr/lib64/python3.13/site-packages/astropy/extern/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/__pycache__/_strptime.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/__pycache__/_strptime.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/_strptime.py
/usr/lib64/python3.13/site-packages/astropy/extern/configobj
/usr/lib64/python3.13/site-packages/astropy/extern/configobj/__init__.py
/usr/lib64/python3.13/site-packages/astropy/extern/configobj/__pycache__
/usr/lib64/python3.13/site-packages/astropy/extern/configobj/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/configobj/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/configobj/__pycache__/configobj.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/configobj/__pycache__/configobj.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/configobj/__pycache__/validate.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/configobj/__pycache__/validate.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/configobj/configobj.py
/usr/lib64/python3.13/site-packages/astropy/extern/configobj/validate.py
/usr/lib64/python3.13/site-packages/astropy/extern/ply
/usr/lib64/python3.13/site-packages/astropy/extern/ply/__init__.py
/usr/lib64/python3.13/site-packages/astropy/extern/ply/__pycache__
/usr/lib64/python3.13/site-packages/astropy/extern/ply/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/ply/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/ply/__pycache__/cpp.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/ply/__pycache__/cpp.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/ply/__pycache__/ctokens.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/ply/__pycache__/ctokens.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/ply/__pycache__/lex.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/ply/__pycache__/lex.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/ply/__pycache__/yacc.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/ply/__pycache__/yacc.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/ply/__pycache__/ygen.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/ply/__pycache__/ygen.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/extern/ply/cpp.py
/usr/lib64/python3.13/site-packages/astropy/extern/ply/ctokens.py
/usr/lib64/python3.13/site-packages/astropy/extern/ply/lex.py
/usr/lib64/python3.13/site-packages/astropy/extern/ply/yacc.py
/usr/lib64/python3.13/site-packages/astropy/extern/ply/ygen.py
/usr/lib64/python3.13/site-packages/astropy/io
/usr/lib64/python3.13/site-packages/astropy/io/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/__pycache__/typing.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/__pycache__/typing.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/basic.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/basic.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/cds.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/cds.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/connect.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/connect.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/daophot.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/daophot.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/docs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/docs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/ecsv.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/ecsv.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/fastbasic.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/fastbasic.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/fixedwidth.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/fixedwidth.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/html.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/html.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/ipac.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/ipac.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/latex.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/latex.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/misc.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/misc.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/mrt.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/mrt.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/qdp.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/qdp.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/rst.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/rst.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/setup_package.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/setup_package.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/sextractor.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/sextractor.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/tdat.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/tdat.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/ui.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/__pycache__/ui.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/basic.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/cds.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/connect.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/core.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/cparser.cpython-313-aarch64-linux-gnu.so
/usr/lib64/python3.13/site-packages/astropy/io/ascii/cparser.pyx
/usr/lib64/python3.13/site-packages/astropy/io/ascii/daophot.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/docs.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/ecsv.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/fastbasic.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/fixedwidth.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/html.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/ipac.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/latex.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/misc.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/mrt.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/qdp.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/rst.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/setup_package.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/sextractor.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/src
/usr/lib64/python3.13/site-packages/astropy/io/ascii/src/tokenizer.c
/usr/lib64/python3.13/site-packages/astropy/io/ascii/src/tokenizer.h
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tdat.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/common.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/common.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_c_reader.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_c_reader.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_cds.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_cds.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_cds_header_from_readme.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_cds_header_from_readme.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_compressed.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_compressed.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_connect.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_connect.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_ecsv.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_ecsv.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_fixedwidth.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_fixedwidth.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_html.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_html.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_ipac_definitions.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_ipac_definitions.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_qdp.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_qdp.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_read.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_read.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_rst.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_rst.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_tdat.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_tdat.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_types.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_types.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_write.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/__pycache__/test_write.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/common.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/apostrophe.rdb
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/apostrophe.tab
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/bad.txt
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/bars_at_ends.txt
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds/description
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds/description/ReadMe
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds/description/table.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds/glob
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds/glob/ReadMe
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds/glob/lmxbrefs.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds/multi
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds/multi/ReadMe
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds/multi/lhs2065.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds/multi/lp944-20.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds/null
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds/null/ReadMe
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds/null/ReadMe1
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds/null/table.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds/null/table1.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds2.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cdsFunctional.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cdsFunctional2.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds_malformed.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/cds_mrt_dashes.txt
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/commented_header.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/commented_header2.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/conf_py.txt
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/continuation.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/daophot.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/daophot.dat.gz
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/daophot2.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/daophot3.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/daophot4.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/fill_values.txt
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/fixed_width_2_line.txt
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/html.html
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/html2.html
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/ipac.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/ipac.dat.Z
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/ipac.dat.bz2
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/ipac.dat.xz
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/latex1.tex
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/latex1.tex.gz
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/latex2.tex
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/latex3.tex
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/nls1_stackinfo.dbout
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/no_data_cds.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/no_data_daophot.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/no_data_ipac.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/no_data_sextractor.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/no_data_with_header.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/no_data_without_header.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/sextractor.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/sextractor2.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/sextractor3.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/short.rdb
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/short.rdb.Z
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/short.rdb.bz2
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/short.rdb.gz
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/short.rdb.xz
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/short.tab
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/simple.txt
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/simple2.txt
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/simple3.txt
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/simple4.txt
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/simple5.txt
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/simple_csv.csv
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/simple_csv_missing.csv
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/space_delim_blank_lines.txt
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/space_delim_no_header.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/space_delim_no_names.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/subtypes.ecsv
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/test4.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/test5.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/vizier
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/vizier/ReadMe
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/vizier/table1.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/vizier/table5.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/vots_spec.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/data/whitespace.dat
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/test_c_reader.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/test_cds.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/test_cds_header_from_readme.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/test_compressed.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/test_connect.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/test_ecsv.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/test_fixedwidth.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/test_html.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/test_ipac_definitions.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/test_qdp.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/test_read.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/test_rst.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/test_tdat.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/test_types.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/tests/test_write.py
/usr/lib64/python3.13/site-packages/astropy/io/ascii/ui.py
/usr/lib64/python3.13/site-packages/astropy/io/fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/card.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/card.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/column.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/column.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/connect.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/connect.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/convenience.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/convenience.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/diff.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/diff.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/file.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/file.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/fitsrec.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/fitsrec.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/fitstime.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/fitstime.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/header.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/header.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/util.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/util.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/verify.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/__pycache__/verify.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/_utils.cpython-313-aarch64-linux-gnu.so
/usr/lib64/python3.13/site-packages/astropy/io/fits/_utils.pyx
/usr/lib64/python3.13/site-packages/astropy/io/fits/card.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/column.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/connect.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/convenience.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/diff.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/file.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/fitsrec.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/fitstime.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/__pycache__/base.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/__pycache__/base.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/__pycache__/groups.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/__pycache__/groups.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/__pycache__/hdulist.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/__pycache__/hdulist.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/__pycache__/image.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/__pycache__/image.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/__pycache__/nonstandard.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/__pycache__/nonstandard.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/__pycache__/streaming.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/__pycache__/streaming.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/__pycache__/table.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/__pycache__/table.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/base.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/_codecs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/_codecs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/_quantization.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/_quantization.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/_tiled_compression.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/_tiled_compression.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/compbintable.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/compbintable.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/compressed.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/compressed.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/header.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/header.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/section.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/section.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/settings.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/settings.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/setup_package.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/setup_package.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/_codecs.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/_compression.cpython-313-aarch64-linux-gnu.so
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/_quantization.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/_tiled_compression.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/compbintable.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/compressed.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/header.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/section.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/settings.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/setup_package.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/src
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/src/compression.c
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/src/fits_hcompress.h
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/src/fits_hdecompress.h
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/src/pliocomp.h
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/src/quantize.h
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/src/ricecomp.h
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/src/unquantize.c
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/src/unquantize.h
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/__pycache__/conftest.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/__pycache__/conftest.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/__pycache__/test_checksum.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/__pycache__/test_checksum.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/__pycache__/test_compressed.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/__pycache__/test_compressed.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/__pycache__/test_compression_failures.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/__pycache__/test_compression_failures.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/__pycache__/test_fitsio.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/__pycache__/test_fitsio.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/__pycache__/test_tiled_compression.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/__pycache__/test_tiled_compression.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/conftest.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/data
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/data/compressed_with_nan.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/data/m13.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/data/m13_gzip.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/data/m13_hcomp.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/data/m13_plio.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/data/m13_rice.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/test_checksum.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/test_compressed.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/test_compression_failures.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/test_fitsio.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/tests/test_tiled_compression.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/compressed/utils.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/groups.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/hdulist.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/image.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/nonstandard.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/streaming.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/hdu/table.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/header.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/scripts
/usr/lib64/python3.13/site-packages/astropy/io/fits/scripts/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/scripts/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/fits/scripts/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/scripts/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/scripts/__pycache__/fitscheck.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/scripts/__pycache__/fitscheck.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/scripts/__pycache__/fitsdiff.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/scripts/__pycache__/fitsdiff.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/scripts/__pycache__/fitsheader.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/scripts/__pycache__/fitsheader.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/scripts/__pycache__/fitsinfo.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/scripts/__pycache__/fitsinfo.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/scripts/fitscheck.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/scripts/fitsdiff.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/scripts/fitsheader.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/scripts/fitsinfo.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/conftest.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/conftest.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_checksum.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_checksum.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_connect.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_connect.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_convenience.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_convenience.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_diff.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_diff.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_division.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_division.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_fitscheck.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_fitscheck.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_fitsdiff.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_fitsdiff.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_fitsheader.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_fitsheader.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_fitsinfo.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_fitsinfo.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_fitstime.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_fitstime.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_fsspec.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_fsspec.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_groups.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_groups.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_hdulist.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_hdulist.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_header.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_header.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_image.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_image.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_image_dask.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_image_dask.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_nonstandard.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_nonstandard.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_structured.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_structured.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_table.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_table.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_tilde_path.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_tilde_path.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_uint.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_uint.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_util.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/__pycache__/test_util.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/cfitsio_verify.c
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/conftest.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/arange.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/ascii.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/ascii_i4-i20.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/blank.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/btable.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/chandra_time.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/checksum.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/checksum_false.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/comp.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/compressed_float_bzero.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/compressed_image.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/double_ext.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/fixed-1890.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/group.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/history_header.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/invalid
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/invalid/group_invalid.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/lzw.fits.Z
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/memtest.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/o4sp040b0_raw.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/random_groups.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/scale.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/stddata.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/table.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/tb.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/tdim.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/test0.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/test1.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/theap-gap.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/variable_length_table.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/verify.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/data/zerowidth.fits
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_checksum.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_connect.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_convenience.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_core.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_diff.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_division.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_fitscheck.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_fitsdiff.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_fitsheader.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_fitsinfo.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_fitstime.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_fsspec.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_groups.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_hdulist.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_header.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_image.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_image_dask.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_nonstandard.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_structured.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_table.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_tilde_path.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_uint.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/tests/test_util.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/util.py
/usr/lib64/python3.13/site-packages/astropy/io/fits/verify.py
/usr/lib64/python3.13/site-packages/astropy/io/misc
/usr/lib64/python3.13/site-packages/astropy/io/misc/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/misc/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/misc/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/__pycache__/connect.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/__pycache__/connect.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/__pycache__/hdf5.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/__pycache__/hdf5.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/__pycache__/parquet.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/__pycache__/parquet.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/__pycache__/pickle_helpers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/__pycache__/pickle_helpers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/__pycache__/yaml.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/__pycache__/yaml.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/connect.py
/usr/lib64/python3.13/site-packages/astropy/io/misc/hdf5.py
/usr/lib64/python3.13/site-packages/astropy/io/misc/pandas
/usr/lib64/python3.13/site-packages/astropy/io/misc/pandas/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/misc/pandas/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/misc/pandas/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/pandas/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/pandas/__pycache__/connect.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/pandas/__pycache__/connect.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/pandas/connect.py
/usr/lib64/python3.13/site-packages/astropy/io/misc/parquet.py
/usr/lib64/python3.13/site-packages/astropy/io/misc/pickle_helpers.py
/usr/lib64/python3.13/site-packages/astropy/io/misc/pyarrow
/usr/lib64/python3.13/site-packages/astropy/io/misc/pyarrow/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/misc/pyarrow/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/misc/pyarrow/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/pyarrow/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/pyarrow/__pycache__/csv.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/pyarrow/__pycache__/csv.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/pyarrow/csv.py
/usr/lib64/python3.13/site-packages/astropy/io/misc/pyarrow/tests
/usr/lib64/python3.13/site-packages/astropy/io/misc/pyarrow/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/misc/pyarrow/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/misc/pyarrow/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/pyarrow/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/pyarrow/tests/__pycache__/test_csv.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/pyarrow/tests/__pycache__/test_csv.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/pyarrow/tests/test_csv.py
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/__pycache__/test_hdf5.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/__pycache__/test_hdf5.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/__pycache__/test_pandas.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/__pycache__/test_pandas.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/__pycache__/test_parquet.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/__pycache__/test_parquet.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/__pycache__/test_parquet_votable.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/__pycache__/test_parquet_votable.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/__pycache__/test_pickle_helpers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/__pycache__/test_pickle_helpers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/__pycache__/test_yaml.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/__pycache__/test_yaml.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/data
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/data/gaia_source_dr3_select_1_result.vot
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/data/old_meta_example.hdf5
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/test_hdf5.py
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/test_pandas.py
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/test_parquet.py
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/test_parquet_votable.py
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/test_pickle_helpers.py
/usr/lib64/python3.13/site-packages/astropy/io/misc/tests/test_yaml.py
/usr/lib64/python3.13/site-packages/astropy/io/misc/yaml.py
/usr/lib64/python3.13/site-packages/astropy/io/registry
/usr/lib64/python3.13/site-packages/astropy/io/registry/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/registry/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/registry/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/registry/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/registry/__pycache__/base.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/registry/__pycache__/base.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/registry/__pycache__/compat.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/registry/__pycache__/compat.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/registry/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/registry/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/registry/__pycache__/interface.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/registry/__pycache__/interface.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/registry/base.py
/usr/lib64/python3.13/site-packages/astropy/io/registry/compat.py
/usr/lib64/python3.13/site-packages/astropy/io/registry/core.py
/usr/lib64/python3.13/site-packages/astropy/io/registry/interface.py
/usr/lib64/python3.13/site-packages/astropy/io/registry/tests
/usr/lib64/python3.13/site-packages/astropy/io/registry/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/registry/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/registry/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/registry/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/registry/tests/__pycache__/test_registries.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/registry/tests/__pycache__/test_registries.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/registry/tests/__pycache__/test_registry_help.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/registry/tests/__pycache__/test_registry_help.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/registry/tests/test_registries.py
/usr/lib64/python3.13/site-packages/astropy/io/registry/tests/test_registry_help.py
/usr/lib64/python3.13/site-packages/astropy/io/tests
/usr/lib64/python3.13/site-packages/astropy/io/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/tests/__pycache__/mixin_columns.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/tests/__pycache__/mixin_columns.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/tests/__pycache__/safeio.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/tests/__pycache__/safeio.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/tests/mixin_columns.py
/usr/lib64/python3.13/site-packages/astropy/io/tests/safeio.py
/usr/lib64/python3.13/site-packages/astropy/io/typing.py
/usr/lib64/python3.13/site-packages/astropy/io/votable
/usr/lib64/python3.13/site-packages/astropy/io/votable/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/connect.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/connect.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/converters.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/converters.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/dataorigin.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/dataorigin.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/exceptions.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/exceptions.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/setup_package.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/setup_package.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/table.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/table.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/tree.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/tree.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/ucd.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/ucd.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/util.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/util.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/volint.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/volint.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/xmlutil.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/__pycache__/xmlutil.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/connect.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/converters.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/data
/usr/lib64/python3.13/site-packages/astropy/io/votable/data/VOTable.dtd
/usr/lib64/python3.13/site-packages/astropy/io/votable/data/VOTable.v1.1.xsd
/usr/lib64/python3.13/site-packages/astropy/io/votable/data/VOTable.v1.2.xsd
/usr/lib64/python3.13/site-packages/astropy/io/votable/data/VOTable.v1.3.xsd
/usr/lib64/python3.13/site-packages/astropy/io/votable/data/VOTable.v1.4.xsd
/usr/lib64/python3.13/site-packages/astropy/io/votable/data/VOTable.v1.5.xsd
/usr/lib64/python3.13/site-packages/astropy/io/votable/data/ivoa-vocalubary_refframe-v20220222.json
/usr/lib64/python3.13/site-packages/astropy/io/votable/data/ucd1p-words.txt
/usr/lib64/python3.13/site-packages/astropy/io/votable/dataorigin.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/exceptions.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/setup_package.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/src
/usr/lib64/python3.13/site-packages/astropy/io/votable/src/tablewriter.c
/usr/lib64/python3.13/site-packages/astropy/io/votable/table.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/tablewriter.cpython-313-aarch64-linux-gnu.so
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_converter.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_converter.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_coosys.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_coosys.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_dataorigin.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_dataorigin.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_exception.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_exception.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_resource.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_resource.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_schema_versions.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_schema_versions.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_table.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_table.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_tree.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_tree.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_ucd.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_ucd.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_util.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_util.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_vo.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/__pycache__/test_vo.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/binary2_masked_strings.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/coosys.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/custom_datatype.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/empty_table.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/gemini.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/irsa-nph-error.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/irsa-nph-m31.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/mivot_annotated_table.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/mivot_block_custom_datatype.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/names.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/no_field_not_empty_table.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/no_resource.txt
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/no_resource.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/nonstandard_units.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/parquet_binary.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/parquet_binary.xml.parquet
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/regression.bin.tabledata.truth.1.1.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/regression.bin.tabledata.truth.1.3.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/regression.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/resource_groups.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/tb.fits
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/test.order.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/timesys.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/timesys_errors.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/too_many_columns.xml.gz
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/valid_votable.xml
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/data/validation.txt
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/test_converter.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/test_coosys.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/test_dataorigin.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/test_exception.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/test_resource.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/test_schema_versions.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/test_table.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/test_tree.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/test_ucd.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/test_util.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/tests/test_vo.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/tree.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/ucd.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/util.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/__init__.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/__pycache__
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/__pycache__/html.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/__pycache__/html.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/__pycache__/main.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/__pycache__/main.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/__pycache__/result.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/__pycache__/result.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/data
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/data/urls
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/data/urls/cone.big.dat.gz
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/data/urls/cone.broken.dat.gz
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/data/urls/cone.good.dat.gz
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/data/urls/cone.incorrect.dat.gz
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/html.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/main.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/validator/result.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/volint.py
/usr/lib64/python3.13/site-packages/astropy/io/votable/xmlutil.py
/usr/lib64/python3.13/site-packages/astropy/logger.py
/usr/lib64/python3.13/site-packages/astropy/modeling
/usr/lib64/python3.13/site-packages/astropy/modeling/__init__.py
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/_fitting_parallel.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/_fitting_parallel.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/bounding_box.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/bounding_box.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/convolution.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/convolution.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/fitting.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/fitting.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/functional_models.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/functional_models.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/mappings.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/mappings.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/math_functions.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/math_functions.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/optimizers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/optimizers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/parameters.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/parameters.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/physical_models.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/physical_models.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/polynomial.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/polynomial.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/powerlaws.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/powerlaws.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/projections.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/projections.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/rotations.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/rotations.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/separable.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/separable.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/spline.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/spline.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/statistic.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/statistic.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/tabular.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/tabular.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/_fitting_parallel.py
/usr/lib64/python3.13/site-packages/astropy/modeling/bounding_box.py
/usr/lib64/python3.13/site-packages/astropy/modeling/convolution.py
/usr/lib64/python3.13/site-packages/astropy/modeling/core.py
/usr/lib64/python3.13/site-packages/astropy/modeling/fitting.py
/usr/lib64/python3.13/site-packages/astropy/modeling/functional_models.py
/usr/lib64/python3.13/site-packages/astropy/modeling/mappings.py
/usr/lib64/python3.13/site-packages/astropy/modeling/math_functions.py
/usr/lib64/python3.13/site-packages/astropy/modeling/models
/usr/lib64/python3.13/site-packages/astropy/modeling/models/__init__.py
/usr/lib64/python3.13/site-packages/astropy/modeling/models/__pycache__
/usr/lib64/python3.13/site-packages/astropy/modeling/models/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/models/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/optimizers.py
/usr/lib64/python3.13/site-packages/astropy/modeling/parameters.py
/usr/lib64/python3.13/site-packages/astropy/modeling/physical_models.py
/usr/lib64/python3.13/site-packages/astropy/modeling/polynomial.py
/usr/lib64/python3.13/site-packages/astropy/modeling/powerlaws.py
/usr/lib64/python3.13/site-packages/astropy/modeling/projections.py
/usr/lib64/python3.13/site-packages/astropy/modeling/rotations.py
/usr/lib64/python3.13/site-packages/astropy/modeling/separable.py
/usr/lib64/python3.13/site-packages/astropy/modeling/spline.py
/usr/lib64/python3.13/site-packages/astropy/modeling/statistic.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tabular.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/example_models.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/example_models.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/irafutil.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/irafutil.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_bounding_box.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_bounding_box.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_compound.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_compound.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_constraints.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_constraints.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_convolution.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_convolution.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_fitters.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_fitters.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_fitting_parallel.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_fitting_parallel.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_functional_models.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_functional_models.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_input.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_input.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_mappings.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_mappings.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_math_func.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_math_func.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_model_sets.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_model_sets.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_models.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_models.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_models_quantities.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_models_quantities.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_parameters.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_parameters.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_physical_models.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_physical_models.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_pickle.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_pickle.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_polynomial.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_polynomial.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_projections.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_projections.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_quantities_evaluation.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_quantities_evaluation.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_quantities_fitting.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_quantities_fitting.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_quantities_model.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_quantities_model.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_quantities_parameters.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_quantities_parameters.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_quantities_rotations.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_quantities_rotations.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_rotations.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_rotations.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_separable.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_separable.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_spline.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_spline.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_statistics.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_statistics.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_units_mapping.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_units_mapping.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/__pycache__/test_utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/data
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/data/1904-66_AZP.fits
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/data/__init__.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/data/__pycache__
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/data/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/data/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/data/hst_sip.hdr
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/data/idcompspec.fits
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/data/irac_sip.hdr
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/data/spec.txt
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/example_models.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/irafutil.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_bounding_box.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_compound.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_constraints.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_convolution.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_core.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_fitters.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_fitting_parallel.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_functional_models.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_input.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_mappings.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_math_func.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_model_sets.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_models.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_models_quantities.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_parameters.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_physical_models.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_pickle.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_polynomial.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_projections.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_quantities_evaluation.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_quantities_fitting.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_quantities_model.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_quantities_parameters.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_quantities_rotations.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_rotations.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_separable.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_spline.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_statistics.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_units_mapping.py
/usr/lib64/python3.13/site-packages/astropy/modeling/tests/test_utils.py
/usr/lib64/python3.13/site-packages/astropy/modeling/utils.py
/usr/lib64/python3.13/site-packages/astropy/nddata
/usr/lib64/python3.13/site-packages/astropy/nddata/__init__.py
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/_testing.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/_testing.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/bitmask.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/bitmask.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/blocks.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/blocks.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/ccddata.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/ccddata.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/compat.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/compat.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/covariance.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/covariance.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/decorators.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/decorators.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/flag_collection.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/flag_collection.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/nddata.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/nddata.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/nddata_base.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/nddata_base.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/nddata_withmixins.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/nddata_withmixins.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/nduncertainty.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/nduncertainty.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/_testing.py
/usr/lib64/python3.13/site-packages/astropy/nddata/bitmask.py
/usr/lib64/python3.13/site-packages/astropy/nddata/blocks.py
/usr/lib64/python3.13/site-packages/astropy/nddata/ccddata.py
/usr/lib64/python3.13/site-packages/astropy/nddata/compat.py
/usr/lib64/python3.13/site-packages/astropy/nddata/covariance.py
/usr/lib64/python3.13/site-packages/astropy/nddata/decorators.py
/usr/lib64/python3.13/site-packages/astropy/nddata/flag_collection.py
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/__init__.py
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/__pycache__
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/__pycache__/ndarithmetic.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/__pycache__/ndarithmetic.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/__pycache__/ndio.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/__pycache__/ndio.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/__pycache__/ndslicing.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/__pycache__/ndslicing.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/ndarithmetic.py
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/ndio.py
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/ndslicing.py
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/tests
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/tests/__pycache__/test_ndarithmetic.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/tests/__pycache__/test_ndarithmetic.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/tests/__pycache__/test_ndio.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/tests/__pycache__/test_ndio.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/tests/__pycache__/test_ndslicing.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/tests/__pycache__/test_ndslicing.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/tests/test_ndarithmetic.py
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/tests/test_ndio.py
/usr/lib64/python3.13/site-packages/astropy/nddata/mixins/tests/test_ndslicing.py
/usr/lib64/python3.13/site-packages/astropy/nddata/nddata.py
/usr/lib64/python3.13/site-packages/astropy/nddata/nddata_base.py
/usr/lib64/python3.13/site-packages/astropy/nddata/nddata_withmixins.py
/usr/lib64/python3.13/site-packages/astropy/nddata/nduncertainty.py
/usr/lib64/python3.13/site-packages/astropy/nddata/tests
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_bitmask.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_bitmask.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_blocks.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_blocks.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_ccddata.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_ccddata.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_compat.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_compat.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_covariance.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_covariance.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_decorators.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_decorators.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_flag_collection.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_flag_collection.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_nddata.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_nddata.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_nddata_base.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_nddata_base.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_nduncertainty.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_nduncertainty.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/__pycache__/test_utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/data
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/data/sip-wcs.fits
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/test_bitmask.py
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/test_blocks.py
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/test_ccddata.py
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/test_compat.py
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/test_covariance.py
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/test_decorators.py
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/test_flag_collection.py
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/test_nddata.py
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/test_nddata_base.py
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/test_nduncertainty.py
/usr/lib64/python3.13/site-packages/astropy/nddata/tests/test_utils.py
/usr/lib64/python3.13/site-packages/astropy/nddata/utils.py
/usr/lib64/python3.13/site-packages/astropy/samp
/usr/lib64/python3.13/site-packages/astropy/samp/__init__.py
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/client.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/client.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/constants.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/constants.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/errors.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/errors.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/hub.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/hub.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/hub_proxy.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/hub_proxy.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/hub_script.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/hub_script.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/integrated_client.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/integrated_client.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/lockfile_helpers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/lockfile_helpers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/setup_package.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/setup_package.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/standard_profile.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/standard_profile.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/web_profile.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/__pycache__/web_profile.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/client.py
/usr/lib64/python3.13/site-packages/astropy/samp/constants.py
/usr/lib64/python3.13/site-packages/astropy/samp/data
/usr/lib64/python3.13/site-packages/astropy/samp/data/astropy_icon.png
/usr/lib64/python3.13/site-packages/astropy/samp/data/clientaccesspolicy.xml
/usr/lib64/python3.13/site-packages/astropy/samp/data/crossdomain.xml
/usr/lib64/python3.13/site-packages/astropy/samp/errors.py
/usr/lib64/python3.13/site-packages/astropy/samp/hub.py
/usr/lib64/python3.13/site-packages/astropy/samp/hub_proxy.py
/usr/lib64/python3.13/site-packages/astropy/samp/hub_script.py
/usr/lib64/python3.13/site-packages/astropy/samp/integrated_client.py
/usr/lib64/python3.13/site-packages/astropy/samp/lockfile_helpers.py
/usr/lib64/python3.13/site-packages/astropy/samp/setup_package.py
/usr/lib64/python3.13/site-packages/astropy/samp/standard_profile.py
/usr/lib64/python3.13/site-packages/astropy/samp/tests
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/test_client.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/test_client.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/test_errors.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/test_errors.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/test_helpers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/test_helpers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/test_hub.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/test_hub.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/test_hub_proxy.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/test_hub_proxy.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/test_hub_script.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/test_hub_script.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/test_standard_profile.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/test_standard_profile.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/test_web_profile.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/test_web_profile.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/web_profile_test_helpers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/__pycache__/web_profile_test_helpers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/samp/tests/test_client.py
/usr/lib64/python3.13/site-packages/astropy/samp/tests/test_errors.py
/usr/lib64/python3.13/site-packages/astropy/samp/tests/test_helpers.py
/usr/lib64/python3.13/site-packages/astropy/samp/tests/test_hub.py
/usr/lib64/python3.13/site-packages/astropy/samp/tests/test_hub_proxy.py
/usr/lib64/python3.13/site-packages/astropy/samp/tests/test_hub_script.py
/usr/lib64/python3.13/site-packages/astropy/samp/tests/test_standard_profile.py
/usr/lib64/python3.13/site-packages/astropy/samp/tests/test_web_profile.py
/usr/lib64/python3.13/site-packages/astropy/samp/tests/web_profile_test_helpers.py
/usr/lib64/python3.13/site-packages/astropy/samp/utils.py
/usr/lib64/python3.13/site-packages/astropy/samp/web_profile.py
/usr/lib64/python3.13/site-packages/astropy/stats
/usr/lib64/python3.13/site-packages/astropy/stats/__init__.py
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/bayesian_blocks.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/bayesian_blocks.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/biweight.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/biweight.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/circstats.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/circstats.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/funcs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/funcs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/histogram.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/histogram.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/info_theory.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/info_theory.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/jackknife.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/jackknife.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/nanfunctions.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/nanfunctions.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/setup_package.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/setup_package.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/sigma_clipping.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/sigma_clipping.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/spatial.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/__pycache__/spatial.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/_fast_sigma_clip.cpython-313-aarch64-linux-gnu.so
/usr/lib64/python3.13/site-packages/astropy/stats/_stats.cpython-313-aarch64-linux-gnu.so
/usr/lib64/python3.13/site-packages/astropy/stats/_stats.pyx
/usr/lib64/python3.13/site-packages/astropy/stats/bayesian_blocks.py
/usr/lib64/python3.13/site-packages/astropy/stats/biweight.py
/usr/lib64/python3.13/site-packages/astropy/stats/circstats.py
/usr/lib64/python3.13/site-packages/astropy/stats/funcs.py
/usr/lib64/python3.13/site-packages/astropy/stats/histogram.py
/usr/lib64/python3.13/site-packages/astropy/stats/info_theory.py
/usr/lib64/python3.13/site-packages/astropy/stats/jackknife.py
/usr/lib64/python3.13/site-packages/astropy/stats/nanfunctions.py
/usr/lib64/python3.13/site-packages/astropy/stats/setup_package.py
/usr/lib64/python3.13/site-packages/astropy/stats/sigma_clipping.py
/usr/lib64/python3.13/site-packages/astropy/stats/spatial.py
/usr/lib64/python3.13/site-packages/astropy/stats/src
/usr/lib64/python3.13/site-packages/astropy/stats/src/compute_bounds.c
/usr/lib64/python3.13/site-packages/astropy/stats/src/compute_bounds.h
/usr/lib64/python3.13/site-packages/astropy/stats/src/fast_sigma_clip.c
/usr/lib64/python3.13/site-packages/astropy/stats/src/wirth_select.c
/usr/lib64/python3.13/site-packages/astropy/stats/src/wirth_select.h
/usr/lib64/python3.13/site-packages/astropy/stats/tests
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/test_bayesian_blocks.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/test_bayesian_blocks.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/test_biweight.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/test_biweight.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/test_circstats.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/test_circstats.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/test_funcs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/test_funcs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/test_histogram.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/test_histogram.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/test_info_theory.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/test_info_theory.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/test_jackknife.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/test_jackknife.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/test_sigma_clipping.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/test_sigma_clipping.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/test_spatial.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/__pycache__/test_spatial.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/stats/tests/test_bayesian_blocks.py
/usr/lib64/python3.13/site-packages/astropy/stats/tests/test_biweight.py
/usr/lib64/python3.13/site-packages/astropy/stats/tests/test_circstats.py
/usr/lib64/python3.13/site-packages/astropy/stats/tests/test_funcs.py
/usr/lib64/python3.13/site-packages/astropy/stats/tests/test_histogram.py
/usr/lib64/python3.13/site-packages/astropy/stats/tests/test_info_theory.py
/usr/lib64/python3.13/site-packages/astropy/stats/tests/test_jackknife.py
/usr/lib64/python3.13/site-packages/astropy/stats/tests/test_sigma_clipping.py
/usr/lib64/python3.13/site-packages/astropy/stats/tests/test_spatial.py
/usr/lib64/python3.13/site-packages/astropy/table
/usr/lib64/python3.13/site-packages/astropy/table/__init__.py
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/bst.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/bst.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/column.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/column.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/connect.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/connect.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/groups.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/groups.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/index.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/index.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/info.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/info.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/jsviewer.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/jsviewer.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/meta.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/meta.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/ndarray_mixin.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/ndarray_mixin.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/notebook_backends.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/notebook_backends.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/np_utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/np_utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/operations.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/operations.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/pandas.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/pandas.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/pprint.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/pprint.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/row.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/row.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/serialize.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/serialize.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/setup_package.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/setup_package.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/soco.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/soco.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/sorted_array.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/sorted_array.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/table.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/table.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/table_helpers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/__pycache__/table_helpers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/_column_mixins.cpython-313-aarch64-linux-gnu.so
/usr/lib64/python3.13/site-packages/astropy/table/_column_mixins.pyx
/usr/lib64/python3.13/site-packages/astropy/table/_np_utils.cpython-313-aarch64-linux-gnu.so
/usr/lib64/python3.13/site-packages/astropy/table/_np_utils.pyx
/usr/lib64/python3.13/site-packages/astropy/table/bst.py
/usr/lib64/python3.13/site-packages/astropy/table/column.py
/usr/lib64/python3.13/site-packages/astropy/table/connect.py
/usr/lib64/python3.13/site-packages/astropy/table/groups.py
/usr/lib64/python3.13/site-packages/astropy/table/index.py
/usr/lib64/python3.13/site-packages/astropy/table/info.py
/usr/lib64/python3.13/site-packages/astropy/table/jsviewer.py
/usr/lib64/python3.13/site-packages/astropy/table/meta.py
/usr/lib64/python3.13/site-packages/astropy/table/mixins
/usr/lib64/python3.13/site-packages/astropy/table/mixins/__init__.py
/usr/lib64/python3.13/site-packages/astropy/table/mixins/__pycache__
/usr/lib64/python3.13/site-packages/astropy/table/mixins/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/mixins/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/mixins/__pycache__/dask.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/mixins/__pycache__/dask.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/mixins/__pycache__/registry.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/mixins/__pycache__/registry.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/mixins/dask.py
/usr/lib64/python3.13/site-packages/astropy/table/mixins/registry.py
/usr/lib64/python3.13/site-packages/astropy/table/mixins/tests
/usr/lib64/python3.13/site-packages/astropy/table/mixins/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/table/mixins/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/table/mixins/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/mixins/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/mixins/tests/__pycache__/test_dask.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/mixins/tests/__pycache__/test_dask.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/mixins/tests/__pycache__/test_registry.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/mixins/tests/__pycache__/test_registry.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/mixins/tests/test_dask.py
/usr/lib64/python3.13/site-packages/astropy/table/mixins/tests/test_registry.py
/usr/lib64/python3.13/site-packages/astropy/table/ndarray_mixin.py
/usr/lib64/python3.13/site-packages/astropy/table/notebook_backends.py
/usr/lib64/python3.13/site-packages/astropy/table/np_utils.py
/usr/lib64/python3.13/site-packages/astropy/table/operations.py
/usr/lib64/python3.13/site-packages/astropy/table/pandas.py
/usr/lib64/python3.13/site-packages/astropy/table/pprint.py
/usr/lib64/python3.13/site-packages/astropy/table/row.py
/usr/lib64/python3.13/site-packages/astropy/table/scripts
/usr/lib64/python3.13/site-packages/astropy/table/scripts/__init__.py
/usr/lib64/python3.13/site-packages/astropy/table/scripts/__pycache__
/usr/lib64/python3.13/site-packages/astropy/table/scripts/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/scripts/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/scripts/__pycache__/showtable.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/scripts/__pycache__/showtable.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/scripts/showtable.py
/usr/lib64/python3.13/site-packages/astropy/table/serialize.py
/usr/lib64/python3.13/site-packages/astropy/table/setup_package.py
/usr/lib64/python3.13/site-packages/astropy/table/soco.py
/usr/lib64/python3.13/site-packages/astropy/table/sorted_array.py
/usr/lib64/python3.13/site-packages/astropy/table/table.py
/usr/lib64/python3.13/site-packages/astropy/table/table_helpers.py
/usr/lib64/python3.13/site-packages/astropy/table/tests
/usr/lib64/python3.13/site-packages/astropy/table/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/conftest.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/conftest.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_array.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_array.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_bst.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_bst.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_column.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_column.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_groups.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_groups.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_index.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_index.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_info.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_info.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_init_table.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_init_table.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_item_access.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_item_access.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_jsviewer.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_jsviewer.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_masked.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_masked.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_mixin.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_mixin.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_np_utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_np_utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_operations.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_operations.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_pickle.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_pickle.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_pprint.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_pprint.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_row.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_row.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_showtable.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_showtable.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_subclass.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_subclass.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_table.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/__pycache__/test_table.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/table/tests/conftest.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_array.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_bst.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_column.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_groups.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_index.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_info.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_init_table.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_item_access.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_jsviewer.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_masked.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_mixin.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_np_utils.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_operations.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_pickle.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_pprint.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_row.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_showtable.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_subclass.py
/usr/lib64/python3.13/site-packages/astropy/table/tests/test_table.py
/usr/lib64/python3.13/site-packages/astropy/tests
/usr/lib64/python3.13/site-packages/astropy/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/__pycache__/command.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/__pycache__/command.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/__pycache__/helper.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/__pycache__/helper.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/__pycache__/runner.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/__pycache__/runner.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/__pycache__/test_logger.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/__pycache__/test_logger.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/command.py
/usr/lib64/python3.13/site-packages/astropy/tests/figures
/usr/lib64/python3.13/site-packages/astropy/tests/figures/__init__.py
/usr/lib64/python3.13/site-packages/astropy/tests/figures/__pycache__
/usr/lib64/python3.13/site-packages/astropy/tests/figures/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/figures/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/figures/__pycache__/helpers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/figures/__pycache__/helpers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/figures/helpers.py
/usr/lib64/python3.13/site-packages/astropy/tests/figures/py311-test-image-mpl360-cov.json
/usr/lib64/python3.13/site-packages/astropy/tests/figures/py311-test-image-mpldev-cov.json
/usr/lib64/python3.13/site-packages/astropy/tests/helper.py
/usr/lib64/python3.13/site-packages/astropy/tests/runner.py
/usr/lib64/python3.13/site-packages/astropy/tests/test_logger.py
/usr/lib64/python3.13/site-packages/astropy/tests/tests
/usr/lib64/python3.13/site-packages/astropy/tests/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/tests/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/tests/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/tests/__pycache__/test_imports.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/tests/__pycache__/test_imports.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/tests/__pycache__/test_quantity_helpers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/tests/__pycache__/test_quantity_helpers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/tests/__pycache__/test_run_tests.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/tests/__pycache__/test_run_tests.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/tests/__pycache__/test_runner.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/tests/__pycache__/test_runner.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/tests/tests/test_imports.py
/usr/lib64/python3.13/site-packages/astropy/tests/tests/test_quantity_helpers.py
/usr/lib64/python3.13/site-packages/astropy/tests/tests/test_run_tests.py
/usr/lib64/python3.13/site-packages/astropy/tests/tests/test_runner.py
/usr/lib64/python3.13/site-packages/astropy/time
/usr/lib64/python3.13/site-packages/astropy/time/__init__.py
/usr/lib64/python3.13/site-packages/astropy/time/__pycache__
/usr/lib64/python3.13/site-packages/astropy/time/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/__pycache__/formats.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/__pycache__/formats.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/__pycache__/setup_package.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/__pycache__/setup_package.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/_parse_times.cpython-313-aarch64-linux-gnu.so
/usr/lib64/python3.13/site-packages/astropy/time/core.py
/usr/lib64/python3.13/site-packages/astropy/time/formats.py
/usr/lib64/python3.13/site-packages/astropy/time/setup_package.py
/usr/lib64/python3.13/site-packages/astropy/time/src
/usr/lib64/python3.13/site-packages/astropy/time/src/parse_times.c
/usr/lib64/python3.13/site-packages/astropy/time/tests
/usr/lib64/python3.13/site-packages/astropy/time/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_basic.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_basic.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_comparisons.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_comparisons.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_corrs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_corrs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_custom_formats.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_custom_formats.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_delta.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_delta.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_fast_parser.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_fast_parser.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_functions.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_functions.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_guess.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_guess.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_mask.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_mask.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_methods.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_methods.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_pickle.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_pickle.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_precision.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_precision.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_quantity_interaction.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_quantity_interaction.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_sidereal.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_sidereal.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_update_leap_seconds.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_update_leap_seconds.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_ut1.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/__pycache__/test_ut1.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/tests/test_basic.py
/usr/lib64/python3.13/site-packages/astropy/time/tests/test_comparisons.py
/usr/lib64/python3.13/site-packages/astropy/time/tests/test_corrs.py
/usr/lib64/python3.13/site-packages/astropy/time/tests/test_custom_formats.py
/usr/lib64/python3.13/site-packages/astropy/time/tests/test_delta.py
/usr/lib64/python3.13/site-packages/astropy/time/tests/test_fast_parser.py
/usr/lib64/python3.13/site-packages/astropy/time/tests/test_functions.py
/usr/lib64/python3.13/site-packages/astropy/time/tests/test_guess.py
/usr/lib64/python3.13/site-packages/astropy/time/tests/test_mask.py
/usr/lib64/python3.13/site-packages/astropy/time/tests/test_methods.py
/usr/lib64/python3.13/site-packages/astropy/time/tests/test_pickle.py
/usr/lib64/python3.13/site-packages/astropy/time/tests/test_precision.py
/usr/lib64/python3.13/site-packages/astropy/time/tests/test_quantity_interaction.py
/usr/lib64/python3.13/site-packages/astropy/time/tests/test_sidereal.py
/usr/lib64/python3.13/site-packages/astropy/time/tests/test_update_leap_seconds.py
/usr/lib64/python3.13/site-packages/astropy/time/tests/test_ut1.py
/usr/lib64/python3.13/site-packages/astropy/time/time_helper
/usr/lib64/python3.13/site-packages/astropy/time/time_helper/__init__.py
/usr/lib64/python3.13/site-packages/astropy/time/time_helper/__pycache__
/usr/lib64/python3.13/site-packages/astropy/time/time_helper/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/time_helper/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/time_helper/__pycache__/function_helpers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/time/time_helper/__pycache__/function_helpers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/time/time_helper/function_helpers.py
/usr/lib64/python3.13/site-packages/astropy/time/utils.py
/usr/lib64/python3.13/site-packages/astropy/timeseries
/usr/lib64/python3.13/site-packages/astropy/timeseries/__init__.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/__pycache__
/usr/lib64/python3.13/site-packages/astropy/timeseries/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/__pycache__/binned.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/__pycache__/binned.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/__pycache__/downsample.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/__pycache__/downsample.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/__pycache__/sampled.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/__pycache__/sampled.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/binned.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/core.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/downsample.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/io
/usr/lib64/python3.13/site-packages/astropy/timeseries/io/__init__.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/io/__pycache__
/usr/lib64/python3.13/site-packages/astropy/timeseries/io/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/io/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/io/__pycache__/kepler.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/io/__pycache__/kepler.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/io/kepler.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/io/tests
/usr/lib64/python3.13/site-packages/astropy/timeseries/io/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/io/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/timeseries/io/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/io/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/io/tests/__pycache__/test_kepler.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/io/tests/__pycache__/test_kepler.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/io/tests/test_kepler.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/__init__.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/__pycache__
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/__pycache__/base.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/__pycache__/base.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/base.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/__init__.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/__pycache__
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/__pycache__/methods.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/__pycache__/methods.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/__pycache__/setup_package.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/__pycache__/setup_package.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/_impl.cpython-313-aarch64-linux-gnu.so
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/_impl.pyx
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/bls.c
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/core.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/methods.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/setup_package.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/tests
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/tests/__pycache__/test_bls.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/tests/__pycache__/test_bls.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/bls/tests/test_bls.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/__init__.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/__pycache__
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/__pycache__/_statistics.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/__pycache__/_statistics.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/__pycache__/setup_package.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/__pycache__/setup_package.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/_statistics.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/core.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__init__.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__/chi2_impl.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__/chi2_impl.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__/fast_impl.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__/fast_impl.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__/fastchi2_impl.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__/fastchi2_impl.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__/main.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__/main.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__/mle.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__/mle.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__/scipy_impl.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__/scipy_impl.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__/slow_impl.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__/slow_impl.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/chi2_impl.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/cython_impl.cpython-313-aarch64-linux-gnu.so
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/cython_impl.pyx
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/fast_impl.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/fastchi2_impl.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/main.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/mle.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/scipy_impl.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/slow_impl.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/tests
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/tests/__pycache__/test_mle.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/tests/__pycache__/test_mle.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/tests/__pycache__/test_utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/tests/__pycache__/test_utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/tests/test_mle.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/tests/test_utils.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/implementations/utils.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/setup_package.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/tests
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/tests/__pycache__/test_lombscargle.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/tests/__pycache__/test_lombscargle.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/tests/__pycache__/test_statistics.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/tests/__pycache__/test_statistics.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/tests/__pycache__/test_utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/tests/__pycache__/test_utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/tests/test_lombscargle.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/tests/test_statistics.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/tests/test_utils.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle/utils.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/__init__.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/__pycache__
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/core.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/implementations
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/implementations/__init__.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/implementations/__pycache__
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/implementations/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/implementations/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/implementations/__pycache__/main.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/implementations/__pycache__/main.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/implementations/__pycache__/mbfast_impl.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/implementations/__pycache__/mbfast_impl.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/implementations/__pycache__/mbflex_impl.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/implementations/__pycache__/mbflex_impl.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/implementations/__pycache__/mle.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/implementations/__pycache__/mle.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/implementations/main.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/implementations/mbfast_impl.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/implementations/mbflex_impl.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/implementations/mle.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/tests
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/tests/__pycache__/test_lombscargle_multiband.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/tests/__pycache__/test_lombscargle_multiband.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/periodograms/lombscargle_multiband/tests/test_lombscargle_multiband.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/sampled.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/__pycache__/test_binned.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/__pycache__/test_binned.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/__pycache__/test_common.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/__pycache__/test_common.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/__pycache__/test_downsample.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/__pycache__/test_downsample.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/__pycache__/test_sampled.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/__pycache__/test_sampled.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/data
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/data/binned.csv
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/data/sampled.csv
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/test_binned.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/test_common.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/test_downsample.py
/usr/lib64/python3.13/site-packages/astropy/timeseries/tests/test_sampled.py
/usr/lib64/python3.13/site-packages/astropy/uncertainty
/usr/lib64/python3.13/site-packages/astropy/uncertainty/__init__.py
/usr/lib64/python3.13/site-packages/astropy/uncertainty/__pycache__
/usr/lib64/python3.13/site-packages/astropy/uncertainty/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/uncertainty/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/uncertainty/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/uncertainty/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/uncertainty/__pycache__/distributions.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/uncertainty/__pycache__/distributions.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/uncertainty/__pycache__/function_helpers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/uncertainty/__pycache__/function_helpers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/uncertainty/core.py
/usr/lib64/python3.13/site-packages/astropy/uncertainty/distributions.py
/usr/lib64/python3.13/site-packages/astropy/uncertainty/function_helpers.py
/usr/lib64/python3.13/site-packages/astropy/uncertainty/tests
/usr/lib64/python3.13/site-packages/astropy/uncertainty/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/uncertainty/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/uncertainty/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/uncertainty/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/uncertainty/tests/__pycache__/test_containers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/uncertainty/tests/__pycache__/test_containers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/uncertainty/tests/__pycache__/test_distribution.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/uncertainty/tests/__pycache__/test_distribution.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/uncertainty/tests/__pycache__/test_functions.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/uncertainty/tests/__pycache__/test_functions.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/uncertainty/tests/test_containers.py
/usr/lib64/python3.13/site-packages/astropy/uncertainty/tests/test_distribution.py
/usr/lib64/python3.13/site-packages/astropy/uncertainty/tests/test_functions.py
/usr/lib64/python3.13/site-packages/astropy/units
/usr/lib64/python3.13/site-packages/astropy/units/__init__.py
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/astrophys.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/astrophys.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/cds.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/cds.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/cgs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/cgs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/decorators.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/decorators.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/deprecated.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/deprecated.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/equivalencies.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/equivalencies.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/errors.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/errors.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/imperial.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/imperial.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/misc.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/misc.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/photometric.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/photometric.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/physical.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/physical.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/quantity.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/quantity.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/required_by_vounit.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/required_by_vounit.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/si.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/si.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/structured.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/structured.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/typing.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/typing.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/astrophys.py
/usr/lib64/python3.13/site-packages/astropy/units/cds.py
/usr/lib64/python3.13/site-packages/astropy/units/cgs.py
/usr/lib64/python3.13/site-packages/astropy/units/core.py
/usr/lib64/python3.13/site-packages/astropy/units/decorators.py
/usr/lib64/python3.13/site-packages/astropy/units/deprecated.py
/usr/lib64/python3.13/site-packages/astropy/units/equivalencies.py
/usr/lib64/python3.13/site-packages/astropy/units/errors.py
/usr/lib64/python3.13/site-packages/astropy/units/format
/usr/lib64/python3.13/site-packages/astropy/units/format/__init__.py
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/base.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/base.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/cds.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/cds.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/cds_lextab.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/cds_lextab.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/cds_parsetab.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/cds_parsetab.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/console.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/console.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/fits.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/fits.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/generic.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/generic.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/generic_lextab.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/generic_lextab.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/generic_parsetab.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/generic_parsetab.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/latex.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/latex.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/ogip.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/ogip.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/ogip_lextab.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/ogip_lextab.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/ogip_parsetab.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/ogip_parsetab.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/unicode_format.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/unicode_format.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/vounit.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/__pycache__/vounit.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/format/base.py
/usr/lib64/python3.13/site-packages/astropy/units/format/cds.py
/usr/lib64/python3.13/site-packages/astropy/units/format/cds_lextab.py
/usr/lib64/python3.13/site-packages/astropy/units/format/cds_parsetab.py
/usr/lib64/python3.13/site-packages/astropy/units/format/console.py
/usr/lib64/python3.13/site-packages/astropy/units/format/fits.py
/usr/lib64/python3.13/site-packages/astropy/units/format/generic.py
/usr/lib64/python3.13/site-packages/astropy/units/format/generic_lextab.py
/usr/lib64/python3.13/site-packages/astropy/units/format/generic_parsetab.py
/usr/lib64/python3.13/site-packages/astropy/units/format/latex.py
/usr/lib64/python3.13/site-packages/astropy/units/format/ogip.py
/usr/lib64/python3.13/site-packages/astropy/units/format/ogip_lextab.py
/usr/lib64/python3.13/site-packages/astropy/units/format/ogip_parsetab.py
/usr/lib64/python3.13/site-packages/astropy/units/format/unicode_format.py
/usr/lib64/python3.13/site-packages/astropy/units/format/utils.py
/usr/lib64/python3.13/site-packages/astropy/units/format/vounit.py
/usr/lib64/python3.13/site-packages/astropy/units/function
/usr/lib64/python3.13/site-packages/astropy/units/function/__init__.py
/usr/lib64/python3.13/site-packages/astropy/units/function/__pycache__
/usr/lib64/python3.13/site-packages/astropy/units/function/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/function/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/function/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/function/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/function/__pycache__/logarithmic.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/function/__pycache__/logarithmic.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/function/__pycache__/mixin.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/function/__pycache__/mixin.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/function/__pycache__/units.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/function/__pycache__/units.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/function/core.py
/usr/lib64/python3.13/site-packages/astropy/units/function/logarithmic.py
/usr/lib64/python3.13/site-packages/astropy/units/function/mixin.py
/usr/lib64/python3.13/site-packages/astropy/units/function/units.py
/usr/lib64/python3.13/site-packages/astropy/units/imperial.py
/usr/lib64/python3.13/site-packages/astropy/units/misc.py
/usr/lib64/python3.13/site-packages/astropy/units/photometric.py
/usr/lib64/python3.13/site-packages/astropy/units/physical.py
/usr/lib64/python3.13/site-packages/astropy/units/quantity.py
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/__init__.py
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/__pycache__
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/__pycache__/converters.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/__pycache__/converters.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/__pycache__/erfa.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/__pycache__/erfa.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/__pycache__/function_helpers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/__pycache__/function_helpers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/__pycache__/helpers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/__pycache__/helpers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/__pycache__/scipy_special.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/__pycache__/scipy_special.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/converters.py
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/erfa.py
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/function_helpers.py
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/helpers.py
/usr/lib64/python3.13/site-packages/astropy/units/quantity_helper/scipy_special.py
/usr/lib64/python3.13/site-packages/astropy/units/required_by_vounit.py
/usr/lib64/python3.13/site-packages/astropy/units/si.py
/usr/lib64/python3.13/site-packages/astropy/units/structured.py
/usr/lib64/python3.13/site-packages/astropy/units/tests
/usr/lib64/python3.13/site-packages/astropy/units/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_aliases.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_aliases.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_deprecated.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_deprecated.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_equivalencies.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_equivalencies.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_format.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_format.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_logarithmic.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_logarithmic.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_photometric.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_photometric.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_physical.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_physical.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity_annotations.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity_annotations.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity_array_methods.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity_array_methods.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity_decorator.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity_decorator.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity_erfa_ufuncs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity_erfa_ufuncs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity_helpers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity_helpers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity_info.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity_info.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity_non_ufuncs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity_non_ufuncs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity_typing.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity_typing.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity_ufuncs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_quantity_ufuncs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_structured.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_structured.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_units.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_units.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/__pycache__/test_utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_aliases.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_deprecated.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_equivalencies.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_format.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_logarithmic.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_photometric.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_physical.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_quantity.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_quantity_annotations.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_quantity_array_methods.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_quantity_decorator.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_quantity_erfa_ufuncs.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_quantity_helpers.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_quantity_info.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_quantity_non_ufuncs.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_quantity_typing.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_quantity_ufuncs.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_structured.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_units.py
/usr/lib64/python3.13/site-packages/astropy/units/tests/test_utils.py
/usr/lib64/python3.13/site-packages/astropy/units/typing.py
/usr/lib64/python3.13/site-packages/astropy/units/utils.py
/usr/lib64/python3.13/site-packages/astropy/utils
/usr/lib64/python3.13/site-packages/astropy/utils/__init__.py
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/codegen.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/codegen.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/collections.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/collections.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/console.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/console.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/data.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/data.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/data_info.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/data_info.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/decorators.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/decorators.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/diff.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/diff.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/exceptions.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/exceptions.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/introspection.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/introspection.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/misc.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/misc.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/parsing.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/parsing.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/setup_package.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/setup_package.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/shapes.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/shapes.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/state.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/state.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/system_info.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/__pycache__/system_info.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/_compiler.cpython-313-aarch64-linux-gnu.so
/usr/lib64/python3.13/site-packages/astropy/utils/codegen.py
/usr/lib64/python3.13/site-packages/astropy/utils/collections.py
/usr/lib64/python3.13/site-packages/astropy/utils/compat
/usr/lib64/python3.13/site-packages/astropy/utils/compat/__init__.py
/usr/lib64/python3.13/site-packages/astropy/utils/compat/__pycache__
/usr/lib64/python3.13/site-packages/astropy/utils/compat/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/compat/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/compat/__pycache__/numpycompat.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/compat/__pycache__/numpycompat.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/compat/__pycache__/optional_deps.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/compat/__pycache__/optional_deps.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/compat/numpycompat.py
/usr/lib64/python3.13/site-packages/astropy/utils/compat/optional_deps.py
/usr/lib64/python3.13/site-packages/astropy/utils/console.py
/usr/lib64/python3.13/site-packages/astropy/utils/data.py
/usr/lib64/python3.13/site-packages/astropy/utils/data_info.py
/usr/lib64/python3.13/site-packages/astropy/utils/decorators.py
/usr/lib64/python3.13/site-packages/astropy/utils/diff.py
/usr/lib64/python3.13/site-packages/astropy/utils/exceptions.py
/usr/lib64/python3.13/site-packages/astropy/utils/iers
/usr/lib64/python3.13/site-packages/astropy/utils/iers/__init__.py
/usr/lib64/python3.13/site-packages/astropy/utils/iers/__pycache__
/usr/lib64/python3.13/site-packages/astropy/utils/iers/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/iers/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/iers/__pycache__/iers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/iers/__pycache__/iers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/iers/data
/usr/lib64/python3.13/site-packages/astropy/utils/iers/data/ReadMe.eopc04_IAU2000
/usr/lib64/python3.13/site-packages/astropy/utils/iers/iers.py
/usr/lib64/python3.13/site-packages/astropy/utils/iers/tests
/usr/lib64/python3.13/site-packages/astropy/utils/iers/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/utils/iers/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/utils/iers/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/iers/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/iers/tests/__pycache__/test_iers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/iers/tests/__pycache__/test_iers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/iers/tests/__pycache__/test_leap_second.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/iers/tests/__pycache__/test_leap_second.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/iers/tests/data
/usr/lib64/python3.13/site-packages/astropy/utils/iers/tests/data/finals2000A-2016-02-30-test
/usr/lib64/python3.13/site-packages/astropy/utils/iers/tests/data/finals2000A-2016-04-30-test
/usr/lib64/python3.13/site-packages/astropy/utils/iers/tests/data/iers_a_excerpt
/usr/lib64/python3.13/site-packages/astropy/utils/iers/tests/data/iers_b_old_style_excerpt
/usr/lib64/python3.13/site-packages/astropy/utils/iers/tests/data/leap-seconds.list
/usr/lib64/python3.13/site-packages/astropy/utils/iers/tests/test_iers.py
/usr/lib64/python3.13/site-packages/astropy/utils/iers/tests/test_leap_second.py
/usr/lib64/python3.13/site-packages/astropy/utils/introspection.py
/usr/lib64/python3.13/site-packages/astropy/utils/masked
/usr/lib64/python3.13/site-packages/astropy/utils/masked/__init__.py
/usr/lib64/python3.13/site-packages/astropy/utils/masked/__pycache__
/usr/lib64/python3.13/site-packages/astropy/utils/masked/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/__pycache__/function_helpers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/__pycache__/function_helpers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/core.py
/usr/lib64/python3.13/site-packages/astropy/utils/masked/function_helpers.py
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/__pycache__/test_containers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/__pycache__/test_containers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/__pycache__/test_dynamic_subclasses.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/__pycache__/test_dynamic_subclasses.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/__pycache__/test_function_helpers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/__pycache__/test_function_helpers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/__pycache__/test_functions.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/__pycache__/test_functions.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/__pycache__/test_masked.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/__pycache__/test_masked.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/__pycache__/test_table.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/__pycache__/test_table.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/test_containers.py
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/test_dynamic_subclasses.py
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/test_function_helpers.py
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/test_functions.py
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/test_masked.py
/usr/lib64/python3.13/site-packages/astropy/utils/masked/tests/test_table.py
/usr/lib64/python3.13/site-packages/astropy/utils/metadata
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/__init__.py
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/__pycache__
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/__pycache__/exceptions.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/__pycache__/exceptions.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/__pycache__/merge.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/__pycache__/merge.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/core.py
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/exceptions.py
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/merge.py
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/tests
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/tests/__pycache__/test_metadata.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/tests/__pycache__/test_metadata.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/tests/test_metadata.py
/usr/lib64/python3.13/site-packages/astropy/utils/metadata/utils.py
/usr/lib64/python3.13/site-packages/astropy/utils/misc.py
/usr/lib64/python3.13/site-packages/astropy/utils/parsing.py
/usr/lib64/python3.13/site-packages/astropy/utils/setup_package.py
/usr/lib64/python3.13/site-packages/astropy/utils/shapes.py
/usr/lib64/python3.13/site-packages/astropy/utils/src
/usr/lib64/python3.13/site-packages/astropy/utils/src/compiler.c
/usr/lib64/python3.13/site-packages/astropy/utils/state.py
/usr/lib64/python3.13/site-packages/astropy/utils/system_info.py
/usr/lib64/python3.13/site-packages/astropy/utils/tests
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_codegen.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_codegen.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_collections.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_collections.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_console.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_console.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_data.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_data.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_data_info.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_data_info.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_decorators.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_decorators.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_diff.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_diff.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_introspection.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_introspection.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_misc.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_misc.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_parsing.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_parsing.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_progress_bar_func.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_progress_bar_func.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_shapes.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_shapes.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_state.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_state.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_xml.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/__pycache__/test_xml.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/.hidden_file.txt
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/alias.cfg
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/dataurl
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/dataurl/index.html
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/dataurl_mirror
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/dataurl_mirror/index.html
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/local.dat
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/local.dat.Z
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/local.dat.bz2
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/local.dat.gz
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/local.dat.xz
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/test_package
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/test_package/__init__.py
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/test_package/__pycache__
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/test_package/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/test_package/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/test_package/data
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/test_package/data/foo.txt
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/unicode.txt
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/unicode.txt.Z
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/unicode.txt.bz2
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/unicode.txt.gz
/usr/lib64/python3.13/site-packages/astropy/utils/tests/data/unicode.txt.xz
/usr/lib64/python3.13/site-packages/astropy/utils/tests/test_codegen.py
/usr/lib64/python3.13/site-packages/astropy/utils/tests/test_collections.py
/usr/lib64/python3.13/site-packages/astropy/utils/tests/test_console.py
/usr/lib64/python3.13/site-packages/astropy/utils/tests/test_data.py
/usr/lib64/python3.13/site-packages/astropy/utils/tests/test_data_info.py
/usr/lib64/python3.13/site-packages/astropy/utils/tests/test_decorators.py
/usr/lib64/python3.13/site-packages/astropy/utils/tests/test_diff.py
/usr/lib64/python3.13/site-packages/astropy/utils/tests/test_introspection.py
/usr/lib64/python3.13/site-packages/astropy/utils/tests/test_misc.py
/usr/lib64/python3.13/site-packages/astropy/utils/tests/test_parsing.py
/usr/lib64/python3.13/site-packages/astropy/utils/tests/test_progress_bar_func.py
/usr/lib64/python3.13/site-packages/astropy/utils/tests/test_shapes.py
/usr/lib64/python3.13/site-packages/astropy/utils/tests/test_state.py
/usr/lib64/python3.13/site-packages/astropy/utils/tests/test_xml.py
/usr/lib64/python3.13/site-packages/astropy/utils/xml
/usr/lib64/python3.13/site-packages/astropy/utils/xml/__init__.py
/usr/lib64/python3.13/site-packages/astropy/utils/xml/__pycache__
/usr/lib64/python3.13/site-packages/astropy/utils/xml/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/xml/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/xml/__pycache__/check.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/xml/__pycache__/check.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/xml/__pycache__/iterparser.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/xml/__pycache__/iterparser.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/xml/__pycache__/setup_package.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/xml/__pycache__/setup_package.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/xml/__pycache__/unescaper.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/xml/__pycache__/unescaper.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/xml/__pycache__/validate.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/xml/__pycache__/validate.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/xml/__pycache__/writer.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/xml/__pycache__/writer.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/xml/_iterparser.cpython-313-aarch64-linux-gnu.so
/usr/lib64/python3.13/site-packages/astropy/utils/xml/check.py
/usr/lib64/python3.13/site-packages/astropy/utils/xml/iterparser.py
/usr/lib64/python3.13/site-packages/astropy/utils/xml/setup_package.py
/usr/lib64/python3.13/site-packages/astropy/utils/xml/src
/usr/lib64/python3.13/site-packages/astropy/utils/xml/src/expat_config.h
/usr/lib64/python3.13/site-packages/astropy/utils/xml/src/iterparse.c
/usr/lib64/python3.13/site-packages/astropy/utils/xml/src/iterparse.map
/usr/lib64/python3.13/site-packages/astropy/utils/xml/tests
/usr/lib64/python3.13/site-packages/astropy/utils/xml/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/utils/xml/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/utils/xml/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/xml/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/xml/tests/__pycache__/test_iterparse.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/xml/tests/__pycache__/test_iterparse.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/utils/xml/tests/test_iterparse.py
/usr/lib64/python3.13/site-packages/astropy/utils/xml/unescaper.py
/usr/lib64/python3.13/site-packages/astropy/utils/xml/validate.py
/usr/lib64/python3.13/site-packages/astropy/utils/xml/writer.py
/usr/lib64/python3.13/site-packages/astropy/version.py
/usr/lib64/python3.13/site-packages/astropy/visualization
/usr/lib64/python3.13/site-packages/astropy/visualization/__init__.py
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/basic_rgb.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/basic_rgb.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/hist.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/hist.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/interval.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/interval.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/lupton_rgb.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/lupton_rgb.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/mpl_normalize.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/mpl_normalize.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/mpl_style.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/mpl_style.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/stretch.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/stretch.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/time.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/time.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/transform.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/transform.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/units.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/__pycache__/units.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/basic_rgb.py
/usr/lib64/python3.13/site-packages/astropy/visualization/hist.py
/usr/lib64/python3.13/site-packages/astropy/visualization/interval.py
/usr/lib64/python3.13/site-packages/astropy/visualization/lupton_rgb.py
/usr/lib64/python3.13/site-packages/astropy/visualization/mpl_normalize.py
/usr/lib64/python3.13/site-packages/astropy/visualization/mpl_style.py
/usr/lib64/python3.13/site-packages/astropy/visualization/scripts
/usr/lib64/python3.13/site-packages/astropy/visualization/scripts/__init__.py
/usr/lib64/python3.13/site-packages/astropy/visualization/scripts/__pycache__
/usr/lib64/python3.13/site-packages/astropy/visualization/scripts/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/scripts/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/scripts/__pycache__/fits2bitmap.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/scripts/__pycache__/fits2bitmap.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/scripts/fits2bitmap.py
/usr/lib64/python3.13/site-packages/astropy/visualization/scripts/tests
/usr/lib64/python3.13/site-packages/astropy/visualization/scripts/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/visualization/scripts/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/visualization/scripts/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/scripts/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/scripts/tests/__pycache__/test_fits2bitmap.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/scripts/tests/__pycache__/test_fits2bitmap.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/scripts/tests/test_fits2bitmap.py
/usr/lib64/python3.13/site-packages/astropy/visualization/stretch.py
/usr/lib64/python3.13/site-packages/astropy/visualization/tests
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__/test_basic_rgb.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__/test_basic_rgb.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__/test_histogram.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__/test_histogram.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__/test_interval.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__/test_interval.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__/test_lupton_rgb.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__/test_lupton_rgb.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__/test_norm.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__/test_norm.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__/test_stretch.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__/test_stretch.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__/test_time.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__/test_time.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__/test_units.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/__pycache__/test_units.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/test_basic_rgb.py
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/test_histogram.py
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/test_interval.py
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/test_lupton_rgb.py
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/test_norm.py
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/test_stretch.py
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/test_time.py
/usr/lib64/python3.13/site-packages/astropy/visualization/tests/test_units.py
/usr/lib64/python3.13/site-packages/astropy/visualization/time.py
/usr/lib64/python3.13/site-packages/astropy/visualization/transform.py
/usr/lib64/python3.13/site-packages/astropy/visualization/units.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__init__.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/_auto.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/_auto.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/axislabels.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/axislabels.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/coordinate_helpers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/coordinate_helpers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/coordinate_range.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/coordinate_range.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/coordinates_map.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/coordinates_map.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/core.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/core.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/formatter_locator.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/formatter_locator.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/frame.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/frame.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/grid_paths.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/grid_paths.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/helpers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/helpers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/patches.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/patches.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/ticklabels.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/ticklabels.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/ticks.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/ticks.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/transforms.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/transforms.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/wcsapi.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/__pycache__/wcsapi.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/_auto.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/axislabels.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/coordinate_helpers.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/coordinate_range.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/coordinates_map.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/core.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/formatter_locator.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/frame.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/grid_paths.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/helpers.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/patches.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_coordinate_helpers.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_coordinate_helpers.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_display_world_coordinates.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_display_world_coordinates.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_formatter_locator.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_formatter_locator.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_frame.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_frame.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_grid_paths.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_grid_paths.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_images.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_images.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_misc.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_misc.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_transform_coord_meta.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_transform_coord_meta.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_transforms.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_transforms.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_wcsapi.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/__pycache__/test_wcsapi.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/data
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/data/2MASS_k_header
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/data/cube_header
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/data/msx_header
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/data/rosat_header
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/data/slice_header
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/test_coordinate_helpers.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/test_display_world_coordinates.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/test_formatter_locator.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/test_frame.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/test_grid_paths.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/test_images.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/test_misc.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/test_transform_coord_meta.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/test_transforms.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/test_utils.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/tests/test_wcsapi.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/ticklabels.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/ticks.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/transforms.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/utils.py
/usr/lib64/python3.13/site-packages/astropy/visualization/wcsaxes/wcsapi.py
/usr/lib64/python3.13/site-packages/astropy/wcs
/usr/lib64/python3.13/site-packages/astropy/wcs/__init__.py
/usr/lib64/python3.13/site-packages/astropy/wcs/__pycache__
/usr/lib64/python3.13/site-packages/astropy/wcs/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/__pycache__/docstrings.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/__pycache__/docstrings.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/__pycache__/setup_package.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/__pycache__/setup_package.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/__pycache__/wcs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/__pycache__/wcs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/__pycache__/wcslint.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/__pycache__/wcslint.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/_wcs.cpython-313-aarch64-linux-gnu.so
/usr/lib64/python3.13/site-packages/astropy/wcs/docstrings.py
/usr/lib64/python3.13/site-packages/astropy/wcs/include
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/astropy_wcs.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/astropy_wcs_api.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/distortion.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/distortion_wrap.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/docstrings.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/isnan.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/pipeline.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/pyutil.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/sip.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/sip_wrap.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/str_list_proxy.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/unit_list_proxy.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/util.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/wcsconfig.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/wcslib_auxprm_wrap.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/wcslib_celprm_wrap.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/wcslib_prjprm_wrap.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/wcslib_tabprm_wrap.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/wcslib_units_wrap.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/wcslib_wrap.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs/wcslib_wtbarr_wrap.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/astropy_wcs_api.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/wcslib
/usr/lib64/python3.13/site-packages/astropy/wcs/include/wcslib/cel.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/wcslib/lin.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/wcslib/prj.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/wcslib/spc.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/wcslib/spx.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/wcslib/tab.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/wcslib/wcs.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/wcslib/wcserr.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/wcslib/wcsmath.h
/usr/lib64/python3.13/site-packages/astropy/wcs/include/wcslib/wcsprintf.h
/usr/lib64/python3.13/site-packages/astropy/wcs/setup_package.py
/usr/lib64/python3.13/site-packages/astropy/wcs/src
/usr/lib64/python3.13/site-packages/astropy/wcs/src/astropy_wcs.c
/usr/lib64/python3.13/site-packages/astropy/wcs/src/astropy_wcs_api.c
/usr/lib64/python3.13/site-packages/astropy/wcs/src/distortion.c
/usr/lib64/python3.13/site-packages/astropy/wcs/src/distortion_wrap.c
/usr/lib64/python3.13/site-packages/astropy/wcs/src/docstrings.c
/usr/lib64/python3.13/site-packages/astropy/wcs/src/pipeline.c
/usr/lib64/python3.13/site-packages/astropy/wcs/src/pyutil.c
/usr/lib64/python3.13/site-packages/astropy/wcs/src/sip.c
/usr/lib64/python3.13/site-packages/astropy/wcs/src/sip_wrap.c
/usr/lib64/python3.13/site-packages/astropy/wcs/src/str_list_proxy.c
/usr/lib64/python3.13/site-packages/astropy/wcs/src/unit_list_proxy.c
/usr/lib64/python3.13/site-packages/astropy/wcs/src/util.c
/usr/lib64/python3.13/site-packages/astropy/wcs/src/wcslib_auxprm_wrap.c
/usr/lib64/python3.13/site-packages/astropy/wcs/src/wcslib_celprm_wrap.c
/usr/lib64/python3.13/site-packages/astropy/wcs/src/wcslib_prjprm_wrap.c
/usr/lib64/python3.13/site-packages/astropy/wcs/src/wcslib_tabprm_wrap.c
/usr/lib64/python3.13/site-packages/astropy/wcs/src/wcslib_wrap.c
/usr/lib64/python3.13/site-packages/astropy/wcs/src/wcslib_wtbarr_wrap.c
/usr/lib64/python3.13/site-packages/astropy/wcs/tests
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/conftest.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/conftest.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/helper.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/helper.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_auxprm.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_auxprm.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_celprm.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_celprm.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_pickle.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_pickle.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_prjprm.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_prjprm.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_profiling.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_profiling.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_tab.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_tab.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_tabprm.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_tabprm.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_wcs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_wcs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_wcsprm.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_wcsprm.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_wtbarr.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/__pycache__/test_wtbarr.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/conftest.py
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/2wcses.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/3d_cd.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/chandra-pixlist-wcs.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/defunct_keywords.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/dist.fits
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/dist_lookup.fits.gz
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/dss.14.29.56-62.41.05.fits.gz
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/header_newlines.fits
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/header_with_time.fits
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/header_with_time_wcslib71.fits
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/ie6d07ujq_wcs.fits
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/invalid_header.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/irac_sip.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/j94f05bgq_flt.fits
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/locale.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_AIR.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_AIT.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_ARC.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_AZP.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_BON.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_CAR.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_CEA.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_COD.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_COE.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_COO.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_COP.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_CSC.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_CYP.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_HPX.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_MER.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_MOL.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_NCP.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_PAR.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_PCO.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_QSC.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_SFL.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_SIN.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_STG.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_SZP.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_TAN.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_TSC.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_ZEA.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/maps/1904-66_ZPN.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/nonstandard_units.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/outside_sky.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/sip-broken.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/sip.fits
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/sip2.fits
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/siponly.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/spectra
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/spectra/orion-freq-1.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/spectra/orion-freq-4.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/spectra/orion-velo-1.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/spectra/orion-velo-4.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/spectra/orion-wave-1.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/spectra/orion-wave-4.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/sub-segfault.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/tab-time-last-axis.fits
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/too_many_pv.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/tpvonly.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/unit.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/validate.5.0.txt
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/validate.5.13.txt
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/validate.6.txt
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/validate.7.4.txt
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/validate.7.6.txt
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/validate.fits
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/validate.txt
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/data/zpn-hole.hdr
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/helper.py
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/test_auxprm.py
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/test_celprm.py
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/test_pickle.py
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/test_prjprm.py
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/test_profiling.py
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/test_tab.py
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/test_tabprm.py
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/test_utils.py
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/test_wcs.py
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/test_wcsprm.py
/usr/lib64/python3.13/site-packages/astropy/wcs/tests/test_wtbarr.py
/usr/lib64/python3.13/site-packages/astropy/wcs/utils.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcs.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/__init__.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/__pycache__
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/__pycache__/conftest.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/__pycache__/conftest.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/__pycache__/fitswcs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/__pycache__/fitswcs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/__pycache__/high_level_api.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/__pycache__/high_level_api.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/__pycache__/high_level_wcs_wrapper.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/__pycache__/high_level_wcs_wrapper.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/__pycache__/low_level_api.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/__pycache__/low_level_api.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/__pycache__/utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/__pycache__/utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/conftest.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/data
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/data/ucds.txt
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/fitswcs.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/high_level_api.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/high_level_wcs_wrapper.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/low_level_api.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/__pycache__/test_fitswcs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/__pycache__/test_fitswcs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/__pycache__/test_high_level_api.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/__pycache__/test_high_level_api.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/__pycache__/test_high_level_wcs_wrapper.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/__pycache__/test_high_level_wcs_wrapper.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/__pycache__/test_low_level_api.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/__pycache__/test_low_level_api.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/__pycache__/test_utils.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/__pycache__/test_utils.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/data
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/data/example_4d_tab.fits
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/test_fitswcs.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/test_high_level_api.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/test_high_level_wcs_wrapper.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/test_low_level_api.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/tests/test_utils.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/utils.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers/__init__.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers/__pycache__
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers/__pycache__/base.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers/__pycache__/base.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers/__pycache__/sliced_wcs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers/__pycache__/sliced_wcs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers/base.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers/sliced_wcs.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers/tests
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers/tests/__init__.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers/tests/__pycache__
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers/tests/__pycache__/__init__.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers/tests/__pycache__/__init__.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers/tests/__pycache__/test_sliced_wcs.cpython-313.opt-1.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers/tests/__pycache__/test_sliced_wcs.cpython-313.pyc
/usr/lib64/python3.13/site-packages/astropy/wcs/wcsapi/wrappers/tests/test_sliced_wcs.py
/usr/lib64/python3.13/site-packages/astropy/wcs/wcslint.py
/usr/share/doc/packages/python313-astropy
/usr/share/doc/packages/python313-astropy/CHANGES.rst
/usr/share/doc/packages/python313-astropy/README.rst
/usr/share/licenses/python313-astropy
/usr/share/licenses/python313-astropy/AURA_LICENSE.rst
/usr/share/licenses/python313-astropy/CONFIGOBJ_LICENSE.rst
/usr/share/licenses/python313-astropy/DATATABLES_LICENSE.rst
/usr/share/licenses/python313-astropy/ERFA.rst
/usr/share/licenses/python313-astropy/GATSPY_LICENSE.rst
/usr/share/licenses/python313-astropy/JQUERY_LICENSE.rst
/usr/share/licenses/python313-astropy/LICENSE.rst
/usr/share/licenses/python313-astropy/NUMPY_LICENSE.rst
/usr/share/licenses/python313-astropy/PLY_LICENSE.rst
/usr/share/licenses/python313-astropy/POSITIONAL_DEFAULTS.rst
/usr/share/licenses/python313-astropy/PYFITS.rst
/usr/share/licenses/python313-astropy/PYTHON.rst
/usr/share/licenses/python313-astropy/README.rst


Generated by rpm2html 1.8.1

Fabrice Bellet, Thu Oct 23 23:06:42 2025