Skip to content

Commit b81cb61

Browse files
committed
lmao
1 parent d3e8976 commit b81cb61

13 files changed

+137
-144
lines changed

.ruff.toml

-1
Original file line numberDiff line numberDiff line change
@@ -14,7 +14,6 @@ select = [
1414
"W",
1515
"UP",
1616
"PT",
17-
"N",
1817
"BLE",
1918
"A",
2019
"C4",

docs/conf.py

+2-2
Original file line numberDiff line numberDiff line change
@@ -53,7 +53,7 @@
5353
automodapi_toctreedirnm = "generated/api"
5454

5555
# Add any paths that contain templates here, relative to this directory.
56-
# templates_path = ["_templates"] # NOQA: ERA001
56+
# templates_path = ["_templates"]
5757

5858
# List of patterns, relative to source directory, that match files and
5959
# directories to ignore when looking for source files.
@@ -103,7 +103,7 @@
103103
# Add any paths that contain custom static files (such as style sheets) here,
104104
# relative to this directory. They are copied after the builtin static files,
105105
# so a file named "default.css" will overwrite the builtin "default.css".
106-
# html_static_path = ["_static"] # NOQA: ERA001
106+
# html_static_path = ["_static"]
107107

108108
# By default, when rendering docstrings for classes, sphinx.ext.autodoc will
109109
# make docs with the class-level docstring and the class-method docstrings,

pytest.ini

+1
Original file line numberDiff line numberDiff line change
@@ -48,3 +48,4 @@ filterwarnings =
4848
ignore: invalid value encountered in true_divide
4949
# https://github.com/pytest-dev/pytest-cov/issues/557
5050
ignore:The --rsyncdir command line argument and rsyncdirs config variable are deprecated.:DeprecationWarning
51+
ignore:Please use astropy.wcs.wcsapi.high_level_api.values_to_high_level_objects:DeprecationWarning

sunraster/extern/meta.py

+48-49
Original file line numberDiff line numberDiff line change
@@ -78,7 +78,7 @@ def __init__(self, header=None, comments=None, axes=None, data_shape=None):
7878
axes = dict(axes)
7979
if not set(axes.keys()).issubset(set(header_keys)):
8080
raise ValueError("All axes must correspond to a value in header under the same key.")
81-
self._axes = dict([(key, self._sanitize_axis_value(axis, header[key], key)) for key, axis in axes.items()])
81+
self._axes = {key: self._sanitize_axis_value(axis, header[key], key) for key, axis in axes.items()}
8282

8383
def _sanitize_axis_value(self, axis, value, key):
8484
if axis is None:
@@ -100,7 +100,7 @@ def _sanitize_axis_value(self, axis, value, key):
100100
shape_error_msg = f"{key} must have shape {tuple(self.shape[axis])} as it is associated with axes {axis}"
101101
if len(axis) == 1 and not hasattr(value, "__len__") or len(axis) != 1 and not hasattr(value, "shape"):
102102
raise TypeError(shape_error_msg)
103-
elif len(axis) == 1:
103+
if len(axis) == 1:
104104
meta_shape = (len(value),)
105105
else:
106106
meta_shape = value.shape
@@ -189,51 +189,50 @@ def __getitem__(self, item):
189189
# If item is single string, slicing is simple.
190190
if isinstance(item, str):
191191
return super().__getitem__(item)
192-
elif self.shape is None:
192+
if self.shape is None:
193193
raise TypeError("Meta object does not have a shape and so cannot be sliced.")
194-
else:
195-
new_meta = copy.deepcopy(self)
196-
# Convert item to array of ints and slices for consistent behaviour.
197-
if isinstance(item, (numbers.Integral, slice)):
198-
item = [item]
199-
item = np.array(list(item) + [slice(None)] * (len(self.shape) - len(item)), dtype=object)
200-
201-
# Edit data shape and calculate which axis will be dropped.
202-
dropped_axes = np.zeros(len(self.shape), dtype=bool)
203-
new_shape = new_meta.shape
204-
for i, axis_item in enumerate(item):
205-
if isinstance(axis_item, numbers.Integral):
206-
dropped_axes[i] = True
207-
elif isinstance(axis_item, slice):
208-
start = axis_item.start
209-
if start is None:
210-
start = 0
211-
if start < 0:
212-
start = self.shape[i] - start
213-
stop = axis_item.stop
214-
if stop is None:
215-
stop = self.shape[i]
216-
if stop < 0:
217-
stop = self.shape[i] - stop
218-
new_shape[i] = stop - start
219-
else:
220-
raise TypeError("Unrecognized slice type. " "Must be an int, slice and tuple of the same.")
221-
new_meta._data_shape = new_shape[np.invert(dropped_axes)]
222-
223-
# Calculate the cumulative number of dropped axes.
224-
cumul_dropped_axes = np.cumsum(dropped_axes)
225-
226-
# Slice all metadata associated with axes.
227-
for key, value in self.items():
228-
axis = self.axes.get(key, None)
229-
if axis is not None:
230-
new_item = tuple(item[axis])
231-
new_value = value[new_item[0]] if len(new_item) == 1 else value[new_item]
232-
new_axis = np.array([-1 if isinstance(i, numbers.Integral) else a for i, a in zip(new_item, axis)])
233-
new_axis -= cumul_dropped_axes[axis]
234-
new_axis = new_axis[new_axis >= 0]
235-
if len(new_axis) == 0:
236-
new_axis = None
237-
new_meta.add(key, new_value, self.comments.get(key, None), new_axis, overwrite=True)
238-
239-
return new_meta
194+
new_meta = copy.deepcopy(self)
195+
# Convert item to array of ints and slices for consistent behaviour.
196+
if isinstance(item, (numbers.Integral, slice)):
197+
item = [item]
198+
item = np.array(list(item) + [slice(None)] * (len(self.shape) - len(item)), dtype=object)
199+
200+
# Edit data shape and calculate which axis will be dropped.
201+
dropped_axes = np.zeros(len(self.shape), dtype=bool)
202+
new_shape = new_meta.shape
203+
for i, axis_item in enumerate(item):
204+
if isinstance(axis_item, numbers.Integral):
205+
dropped_axes[i] = True
206+
elif isinstance(axis_item, slice):
207+
start = axis_item.start
208+
if start is None:
209+
start = 0
210+
if start < 0:
211+
start = self.shape[i] - start
212+
stop = axis_item.stop
213+
if stop is None:
214+
stop = self.shape[i]
215+
if stop < 0:
216+
stop = self.shape[i] - stop
217+
new_shape[i] = stop - start
218+
else:
219+
raise TypeError("Unrecognized slice type. " "Must be an int, slice and tuple of the same.")
220+
new_meta._data_shape = new_shape[np.invert(dropped_axes)]
221+
222+
# Calculate the cumulative number of dropped axes.
223+
cumul_dropped_axes = np.cumsum(dropped_axes)
224+
225+
# Slice all metadata associated with axes.
226+
for key, value in self.items():
227+
axis = self.axes.get(key, None)
228+
if axis is not None:
229+
new_item = tuple(item[axis])
230+
new_value = value[new_item[0]] if len(new_item) == 1 else value[new_item]
231+
new_axis = np.array([-1 if isinstance(i, numbers.Integral) else a for i, a in zip(new_item, axis)])
232+
new_axis -= cumul_dropped_axes[axis]
233+
new_axis = new_axis[new_axis >= 0]
234+
if len(new_axis) == 0:
235+
new_axis = None
236+
new_meta.add(key, new_value, self.comments.get(key, None), new_axis, overwrite=True)
237+
238+
return new_meta

sunraster/extern/tests/test_meta.py

+3-6
Original file line numberDiff line numberDiff line change
@@ -26,7 +26,7 @@ def assert_metas_equal(test_input, expected_output):
2626
for test_value, expected_value in zip(test_input.values(), expected_output.values()):
2727
try:
2828
assert test_value == expected_value
29-
except ValueError as err:
29+
except ValueError as err: # NOQA: PERF203
3030
if multi_element_msg in err.args[0]:
3131
assert np.allclose(test_value, expected_value)
3232
# Check axes are the same.
@@ -109,18 +109,15 @@ def test_slice_away_independent_axis(basic_meta):
109109
axes["c"] -= 1
110110
axes["d"] -= 1
111111
shape = meta.shape[1:]
112-
print(values, comments, axes, shape)
113112
expected = Meta(values, comments, axes, shape)
114113
# Compare output and expected.
115114
assert_metas_equal(output, expected)
116115

117116

118117
def test_slice_dependent_axes(basic_meta):
119118
meta = basic_meta
120-
print(meta["a"])
121119
# Get output
122120
output = meta[:, 1:3, 1]
123-
print(meta["a"])
124121
# Build expected result.
125122
values = dict(list(meta.items()))
126123
values["c"] = values["c"][1:3, 1]
@@ -175,13 +172,13 @@ def test_add_overwrite(basic_meta):
175172

176173
def test_add_overwrite_error(basic_meta):
177174
meta = basic_meta
178-
with pytest.raises(KeyError):
175+
with pytest.raises(KeyError, match="A"):
179176
meta.add("a", "world", None, None)
180177

181178

182179
def test_add_axis_without_shape(no_shape_meta):
183180
meta = no_shape_meta
184-
with pytest.raises(TypeError):
181+
with pytest.raises(TypeError, match="A"):
185182
meta.add("z", [100], axis=0)
186183

187184

sunraster/instr/spice.py

+3-3
Original file line numberDiff line numberDiff line change
@@ -62,7 +62,7 @@ def read_spice_l2_fits(filenames, windows=None, memmap=True, read_dumbbells=Fals
6262
if len(filenames) > 1:
6363
# Wrap windows from first file in lists
6464
# so windows from other files can be appended.
65-
cube_lists = dict([(key, [value]) for key, value in first_cubes.items()])
65+
cube_lists = {key: [value] for key, value in first_cubes.items()}
6666
# Get info from first file for consistency checks between files.
6767
first_meta = _get_meta_from_last_added(cube_lists)
6868
first_obs_id = _get_obsid(first_meta)
@@ -79,7 +79,7 @@ def read_spice_l2_fits(filenames, windows=None, memmap=True, read_dumbbells=Fals
7979
output=cube_lists,
8080
spice_id=first_obs_id,
8181
)
82-
except ValueError as err:
82+
except ValueError as err: # NOQA: PERF203
8383
err_message = err.args[0]
8484
if INCORRECT_OBSID_MESSAGE in err_message:
8585
this_obs_id = err_message.split()[-1]
@@ -291,7 +291,7 @@ def __str__(self):
291291
)
292292

293293
def __repr__(self):
294-
return f"{object.__repr__(self)}\n{str(self)}"
294+
return f"{object.__repr__(self)}\n{self!s}"
295295

296296
# ---------- Inherited ABC properties ----------
297297
@property

sunraster/instr/tests/test_spice.py

+47-47
Original file line numberDiff line numberDiff line change
@@ -1,5 +1,3 @@
1-
import os.path
2-
31
import numpy as np
42
import pytest
53

@@ -13,7 +11,7 @@
1311

1412
from sunraster import RasterSequence, SpectrogramCube, SpectrogramSequence
1513
from sunraster.instr.spice import SPICEMeta, read_spice_l2_fits
16-
from sunraster.tests import test_data_dir
14+
from sunraster.tests import TEST_DATA_PATH
1715

1816
READ_SPICE_L2_FITS_RETURN_TYPE = NDCollection
1917
SPECTRAL_WINDOW = ("WINDOW0_74.73", "Extension name")
@@ -53,35 +51,35 @@
5351
@pytest.fixture
5452
def spice_fits_header():
5553
hdr = fits.Header()
56-
hdr.append(tuple(["EXTNAME"] + list(SPECTRAL_WINDOW)))
57-
hdr.append(tuple(["DETECTOR"] + list(DETECTOR)))
58-
hdr.append(tuple(["INSTRUME"] + list(INSTRUMENT)))
59-
hdr.append(tuple(["OBSRVTRY"] + list(OBSERVATORY)))
60-
hdr.append(tuple(["LEVEL"] + list(PROCESSING_LEVEL)))
61-
hdr.append(tuple(["RSUN_REF"] + list(RSUN_METERS)))
62-
hdr.append(tuple(["RSUN_ARC"] + list(RSUN_ANGULAR)))
63-
hdr.append(tuple(["OBS_ID"] + list(OBSERVING_MODE_ID)))
64-
hdr.append(tuple(["OBS_VR"] + list(OBSERVATORY_RADIAL_VELOCITY)))
65-
hdr.append(tuple(["DSUN_OBS"] + list(DISTANCE_TO_SUN)))
66-
hdr.append(tuple(["DATE-OBS"] + list(DATE_REFERENCE)))
67-
hdr.append(tuple(["DATE-BEG"] + list(DATE_START)))
68-
hdr.append(tuple(["DATE-END"] + list(DATE_END)))
69-
hdr.append(tuple(["HGLN_OBS"] + list(HGLN_OBS)))
70-
hdr.append(tuple(["HGLT_OBS"] + list(HGLT_OBS)))
71-
hdr.append(tuple(["SPIOBSID"] + list(SPICE_OBSERVING_MODE_ID)))
72-
hdr.append(tuple(["DARKMAP"] + list(DARKMAP)))
73-
hdr.append(tuple(["BLACKLEV"] + list(BLACKLEV)))
74-
hdr.append(tuple(["WIN_TYPE"] + list(WINDOW_TYPE)))
75-
hdr.append(tuple(["WINTABID"] + list(WINDOW_TABLE_ID)))
76-
hdr.append(tuple(["SLIT_ID"] + list(SLIT_ID)))
77-
hdr.append(tuple(["SLIT_WID"] + list(SLIT_WIDTH)))
78-
hdr.append(tuple(["DUMBBELL"] + list(DUMBBELL)))
79-
hdr.append(tuple(["SOLAR_B0"] + list(SOLAR_B0)))
80-
hdr.append(tuple(["SOLAR_P0"] + list(SOLAR_P0)))
81-
hdr.append(tuple(["SOLAR_EP"] + list(SOLAR_EP)))
82-
hdr.append(tuple(["CAR_ROT"] + list(CARRINGTON_ROTATION_NUMBER)))
83-
hdr.append(tuple(["DATE_EAR"] + list(DATE_START_EARTH)))
84-
hdr.append(tuple(["DATE_SUN"] + list(DATE_START_SUN)))
54+
hdr.append(("EXTNAME", *list(SPECTRAL_WINDOW)))
55+
hdr.append(("DETECTOR", *list(DETECTOR)))
56+
hdr.append(("INSTRUME", *list(INSTRUMENT)))
57+
hdr.append(("OBSRVTRY", *list(OBSERVATORY)))
58+
hdr.append(("LEVEL", *list(PROCESSING_LEVEL)))
59+
hdr.append(("RSUN_REF", *list(RSUN_METERS)))
60+
hdr.append(("RSUN_ARC", *list(RSUN_ANGULAR)))
61+
hdr.append(("OBS_ID", *list(OBSERVING_MODE_ID)))
62+
hdr.append(("OBS_VR", *list(OBSERVATORY_RADIAL_VELOCITY)))
63+
hdr.append(("DSUN_OBS", *list(DISTANCE_TO_SUN)))
64+
hdr.append(("DATE-OBS", *list(DATE_REFERENCE)))
65+
hdr.append(("DATE-BEG", *list(DATE_START)))
66+
hdr.append(("DATE-END", *list(DATE_END)))
67+
hdr.append(("HGLN_OBS", *list(HGLN_OBS)))
68+
hdr.append(("HGLT_OBS", *list(HGLT_OBS)))
69+
hdr.append(("SPIOBSID", *list(SPICE_OBSERVING_MODE_ID)))
70+
hdr.append(("DARKMAP", *list(DARKMAP)))
71+
hdr.append(("BLACKLEV", *list(BLACKLEV)))
72+
hdr.append(("WIN_TYPE", *list(WINDOW_TYPE)))
73+
hdr.append(("WINTABID", *list(WINDOW_TABLE_ID)))
74+
hdr.append(("SLIT_ID", *list(SLIT_ID)))
75+
hdr.append(("SLIT_WID", *list(SLIT_WIDTH)))
76+
hdr.append(("DUMBBELL", *list(DUMBBELL)))
77+
hdr.append(("SOLAR_B0", *list(SOLAR_B0)))
78+
hdr.append(("SOLAR_P0", *list(SOLAR_P0)))
79+
hdr.append(("SOLAR_EP", *list(SOLAR_EP)))
80+
hdr.append(("CAR_ROT", *list(CARRINGTON_ROTATION_NUMBER)))
81+
hdr.append(("DATE_EAR", *list(DATE_START_EARTH)))
82+
hdr.append(("DATE_SUN", *list(DATE_START_SUN)))
8583
return hdr
8684

8785

@@ -101,20 +99,21 @@ def spice_rasdb_filename(tmp_path):
10199
102100
A new FITS file is saved in a tmp file path.
103101
"""
102+
rng_gen = np.random.default_rng()
104103
filename = "solo_L2_spice-n-ras-db_20200602T081733_V01_12583760-000.fits"
105-
with fits.open(os.path.join(test_data_dir, filename)) as hdulist:
104+
with fits.open(TEST_DATA_PATH / filename) as hdulist:
106105
new_hdulist = fits.HDUList()
107-
new_hdulist.append(fits.PrimaryHDU(np.random.rand(1, 48, 832, 30), header=hdulist[0].header))
108-
new_hdulist.append(fits.ImageHDU(np.random.rand(1, 48, 832, 30), header=hdulist[1].header))
109-
new_hdulist.append(fits.ImageHDU(np.random.rand(1, 56, 64, 30), header=hdulist[2].header))
110-
new_hdulist.append(fits.ImageHDU(np.random.rand(1, 56, 64, 30), header=hdulist[3].header))
106+
new_hdulist.append(fits.PrimaryHDU(rng_gen.random((1, 48, 832, 30)), header=hdulist[0].header))
107+
new_hdulist.append(fits.ImageHDU(rng_gen.random((1, 48, 832, 30)), header=hdulist[1].header))
108+
new_hdulist.append(fits.ImageHDU(rng_gen.random((1, 56, 64, 30)), header=hdulist[2].header))
109+
new_hdulist.append(fits.ImageHDU(rng_gen.random((1, 56, 64, 30)), header=hdulist[3].header))
111110
new_hdulist.append(hdulist[-1])
112111
tmp_spice_path = tmp_path / "spice"
113-
if not os.path.exists(tmp_spice_path):
112+
if not tmp_spice_path.exists():
114113
tmp_spice_path.mkdir()
115-
new_filename = os.path.join(tmp_spice_path, filename)
114+
new_filename = tmp_spice_path / filename
116115
new_hdulist.writeto(new_filename, overwrite=True)
117-
return new_filename
116+
return str(new_filename)
118117

119118

120119
@pytest.fixture
@@ -124,16 +123,17 @@ def spice_sns_filename(tmp_path):
124123
125124
A new FITS file is saved in a tmp file path.
126125
"""
126+
rng_gen = np.random.default_rng()
127127
filename = "solo_L2_spice-n-sit_20200620T235901_V01_16777431-000.fits"
128-
with fits.open(os.path.join(test_data_dir, filename)) as hdulist:
128+
with fits.open(TEST_DATA_PATH / filename) as hdulist:
129129
new_hdulist = fits.HDUList()
130-
new_hdulist.append(fits.PrimaryHDU(np.random.rand(32, 48, 1024, 1), header=hdulist[0].header))
131-
new_hdulist.append(fits.ImageHDU(np.random.rand(32, 48, 1024, 1), header=hdulist[1].header))
130+
new_hdulist.append(fits.PrimaryHDU(rng_gen.random((32, 48, 1024, 1)), header=hdulist[0].header))
131+
new_hdulist.append(fits.ImageHDU(rng_gen.random((32, 48, 1024, 1)), header=hdulist[1].header))
132132
new_hdulist.append(hdulist[-1])
133133
tmp_spice_path = tmp_path / "spice"
134-
if not os.path.exists(tmp_spice_path):
134+
if not tmp_spice_path.exists():
135135
tmp_spice_path.mkdir()
136-
new_filename = os.path.join(tmp_spice_path, filename)
136+
new_filename = tmp_spice_path / filename
137137
new_hdulist.writeto(new_filename, output_verify="fix+ignore", overwrite=True)
138138
return new_filename
139139

@@ -345,6 +345,6 @@ def test_read_spice_l2_fits_multiple_files_dumbbells(spice_rasdb_filename):
345345

346346

347347
def test_read_spice_l2_fits_incompatible_files(spice_rasdb_filename, spice_sns_filename):
348-
with pytest.raises(ValueError):
349-
filenames = [spice_rasdb_filename, spice_sns_filename]
348+
filenames = [spice_rasdb_filename, spice_sns_filename]
349+
with pytest.raises(ValueError, match="A"):
350350
read_spice_l2_fits(filenames)

0 commit comments

Comments
 (0)