import os
os.environ['HDF5_USE_FILE_LOCKING'] = 'FALSE'
import h5py
import hdf5plugin
import matplotlib
import matplotlib.pyplot as plt
from matplotlib.ticker import FormatStrFormatter
import matplotlib.patches as mpatches
import matplotlib.gridspec as gridspec
import numpy as np
from pyuvdata import UVCal, UVData
import sys
import glob
import uvtools as uvt
from astropy.time import Time
from astropy.coordinates import EarthLocation, AltAz, Angle
from astropy.coordinates import SkyCoord as sc
import pandas
import warnings
import copy
from hera_notebook_templates import utils
import hera_qm
from hera_mc import cm_hookup
import importlib
from scipy import stats
from IPython.display import display, HTML
#warnings.filterwarnings('ignore')
%matplotlib inline
%config InlineBackend.figure_format = 'retina'
display(HTML("<style>.container { width:100% !important; }</style>"))
#get data location
data_path = os.environ['DATA_PATH']
print(f'DATA_PATH = "{data_path}"')
statuses = os.environ['APRIORI_STATUSES']
print(f'APRIORI_STATUSES = {statuses}')
JD = os.environ['JULIANDATE']
print(f'JULIANDATE = {JD}')
utc = Time(JD, format='jd').datetime
print(f'Date = {utc.month}-{utc.day}-{utc.year}')
DATA_PATH = "/mnt/sn1/2460369" APRIORI_STATUSES = dish_maintenance,dish_ok,RF_maintenance,RF_ok,digital_ok,digital_maintenance,calibration_maintenance,calibration_triage,calibration_ok JULIANDATE = 2460369 Date = 2-28-2024
# Load in data
HHfiles, difffiles, HHautos, diffautos, uvdx, uvdy = utils.load_data(data_path,JD)
uvd = UVData()
unread = True
readInd=0
while unread and readInd<len(HHautos):
try:
uvd.read(HHautos[readInd])
unread = False
except:
readInd += 1
continue
use_ants = utils.get_use_ants(uvd,statuses,JD)
print(f'This day contains {len(use_ants)} antennas of the given status category.')
uvd.read(HHautos[::10], skip_bad_files=True, antenna_nums = use_ants)
lsts = uvd.lst_array
uvdx.select(antenna_nums=use_ants)
uvdy.select(antenna_nums=use_ants)
1293 sum files found between JDs 2460369.18985 and 2460369.64744 1293 diff files found between JDs 2460369.18985 and 2460369.64744 1215 sum auto files found between JDs 2460369.18985 and 2460369.64744 1215 diff auto files found between JDs 2460369.18985 and 2460369.64744
This day contains 252 antennas of the given status category.
Sky Coverage Map¶
Map of the sky (made using the Haslam 408MHz map). The RA/DEC range covered by this night of observation is shaded based on a 12 degree FWHM of the beam. Horizontal dashed lines represent the stripe that HERA can observe, while the shaded region is what was observed on this night. Vertical lines represent the beginning and ending LSTs of this observation. Selected sources are labelled, sources included are those in the GLEAM 4Jy catalog with a flux >10.9 Jy. Note that the map is clipped at the northern horizon.
sources = utils.gather_source_list()
utils.plot_sky_map(uvd,dec_pad=55,ra_pad=55,clip=False,sources=sources)
LST Coverage¶
Shows the LSTs (in hours) and JDs for which data is collected. Green represents data, red means no data.
utils.plot_lst_coverage(uvd)
Autocorrelations for a single file¶
This plot shows autocorrelations for one timestamp of each antenna that is active and each polarization. For each node, antennas are ordered by SNAP number, and within that by SNAP input number. The antenna number label color corresponds to the a priori status of that antenna.
### plot autos
utils.plot_autos(uvdx, uvdy)
Waterfalls of Autocorrelation Amplitudes for each Antenna and Each polarization¶
These plots show autocorrelation waterfalls of each antenna that is active and whose status qualifies for this notebook. For each node, antennas are ordered by SNAP number, and within that by SNAP input number. The antenna number label color corresponds to the a priori status of that antenna.
utils.plot_wfs(uvd, pol = 0)
utils.plot_wfs(uvd, pol = 1)
Correlation Metrics¶
The first plot shows the correlation metric (described below) for a set of baseline types, as calculated at several times throughout the night. It is expected that longer baselines (darker color) will exhibit lower values than the short baselines.
The matrices show the phase correlation between antennas. Using the even and odd visibilities, each pixel is calculated as (even/abs(even)) * (conj(odd)/abs(odd)), and then averaged across time and frequency. If the phases are noise-like, this value will average down to zero. If the antennas are well correlated, the phases should not be noise-like, and this value should average to 1. The lines denoting node boundaries are intended to help confirm that inter-node correlations are functioning - if they aren't, this plot will appear block-diagonal.
This metric has shown to be LST locked - when comparing to other nights, be sure to compare for the same LST. It is expected that some LSTs will look much better or worse than others.
Note: Within each node, the order of antennas is determined by snap, and within that by snap input number.
badAnts = []
badAnts = utils.plotNodeAveragedSummary(uvd,HHfiles,JD,use_ants,mat_pols=['xx','yy','xy','yx'])
--------------------------------------------------------------------------- OSError Traceback (most recent call last) Cell In[9], line 2 1 badAnts = [] ----> 2 badAnts = utils.plotNodeAveragedSummary(uvd,HHfiles,JD,use_ants,mat_pols=['xx','yy','xy','yx']) File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/hera_notebook_templates/utils.py:811, in plotNodeAveragedSummary(uv, HHfiles, jd, use_ants, pols, mat_pols, baseline_groups, removeBadAnts, plotRatios, plotSummary) 807 if baseline_groups == []: 808 baseline_groups = [(14,0,'14m E-W'),(14,-11,'14m NW-SE'),(14,11,'14m SW-NE'),(29,0,'29m E-W'),(29,22,'29m SW-NE'), 809 (44,0,'44m E-W'),(58.5,0,'58m E-W'),(73,0,'73m E-W'),(87.6,0,'88m E-W'), 810 (102.3,0,'102m E-W')] --> 811 nodeMedians,lsts,badAnts=get_correlation_baseline_evolutions(uv,HHfiles,jd,use_ants,pols=pols,mat_pols=mat_pols, 812 bl_type=baseline_groups,removeBadAnts=removeBadAnts, 813 plotRatios=plotRatios) 814 pols = mat_pols 815 if plotSummary is False: File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/hera_notebook_templates/utils.py:1477, in get_correlation_baseline_evolutions(uv, HHfiles, jd, use_ants, badThresh, pols, bl_type, removeBadAnts, plotMatrix, mat_pols, plotRatios) 1444 def get_correlation_baseline_evolutions(uv,HHfiles,jd,use_ants='auto',badThresh=0.35,pols=['xx','yy'],bl_type=(14,0,'14m E-W'), 1445 removeBadAnts=False, plotMatrix=True,mat_pols=['xx','yy','xy','yx'],plotRatios=False): 1446 """ 1447 Calculates the average correlation metric for a set of redundant baseline groups at one hour intervals throughout a night of observation. 1448 (...) 1475 Antenna numbers flagged as bad based on badThresh parameter. 1476 """ -> 1477 files, lsts, inds = get_hourly_files(uv, HHfiles, jd) 1478 if use_ants == 'auto': 1479 use_ants = uv.get_ants() File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/hera_notebook_templates/utils.py:1388, in get_hourly_files(uv, HHfiles, jd) 1386 try: 1387 dat = UVData() -> 1388 dat.read(file, read_data=False) 1389 except KeyError: 1390 continue File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/pyuvdata/uvdata/uvdata.py:12660, in UVData.read(self, filename, axis, file_type, read_data, skip_bad_files, background_lsts, astrometry_library, ignore_name, use_future_array_shapes, allow_rephase, make_multi_phase, antenna_nums, antenna_names, ant_str, bls, catalog_names, frequencies, freq_chans, times, time_range, lsts, lst_range, polarizations, blt_inds, phase_center_ids, keep_all_metadata, run_check, check_extra, run_check_acceptability, strict_uvw_antpos_check, check_autos, fix_autos, phase_type, projected, correct_lat_lon, calc_lst, fix_old_proj, fix_use_ant_pos, use_model, data_column, pol_order, ignore_single_chan, raise_error, read_weights, allow_flex_pol, multidim_index, remove_flex_pol, blt_order, blts_are_rectangular, time_axis_faster_than_bls, data_array_dtype, use_aoflagger_flags, remove_dig_gains, remove_coarse_band, correct_cable_len, correct_van_vleck, cheby_approx, flag_small_auto_ants, propagate_coarse_flags, flag_init, edge_width, start_flag, end_flag, flag_dc_offset, remove_flagged_ants, phase_to_pointing_center, nsample_array_dtype, corrchunk, receivers, sidebands, mir_select_where, apply_tsys, apply_flags, apply_dedoppler, pseudo_cont, rechunk, compass_soln, swarm_only, codes_check, recompute_nbls) 12640 self.read_ms( 12641 filename, 12642 data_column=data_column, (...) 12656 astrometry_library=astrometry_library, 12657 ) 12659 elif file_type == "uvh5": > 12660 self.read_uvh5( 12661 filename, 12662 antenna_nums=antenna_nums, 12663 antenna_names=antenna_names, 12664 ant_str=ant_str, 12665 bls=bls, 12666 frequencies=frequencies, 12667 freq_chans=freq_chans, 12668 times=times, 12669 time_range=time_range, 12670 lsts=lsts, 12671 lst_range=lst_range, 12672 polarizations=polarizations, 12673 blt_inds=blt_inds, 12674 phase_center_ids=phase_center_ids, 12675 catalog_names=catalog_names, 12676 read_data=read_data, 12677 data_array_dtype=data_array_dtype, 12678 keep_all_metadata=keep_all_metadata, 12679 multidim_index=multidim_index, 12680 remove_flex_pol=remove_flex_pol, 12681 background_lsts=background_lsts, 12682 run_check=run_check, 12683 check_extra=check_extra, 12684 run_check_acceptability=run_check_acceptability, 12685 strict_uvw_antpos_check=strict_uvw_antpos_check, 12686 fix_old_proj=fix_old_proj, 12687 fix_use_ant_pos=fix_use_ant_pos, 12688 check_autos=check_autos, 12689 fix_autos=fix_autos, 12690 use_future_array_shapes=use_future_array_shapes, 12691 time_axis_faster_than_bls=time_axis_faster_than_bls, 12692 blts_are_rectangular=blts_are_rectangular, 12693 recompute_nbls=recompute_nbls, 12694 astrometry_library=astrometry_library, 12695 ) 12696 select = False 12698 if select: File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/pyuvdata/uvdata/uvdata.py:11471, in UVData.read_uvh5(self, filename, **kwargs) 11464 raise ValueError( 11465 "Reading multiple files from class specific " 11466 "read functions is no longer supported. " 11467 "Use the generic `uvdata.read` function instead." 11468 ) 11470 uvh5_obj = uvh5.UVH5() > 11471 uvh5_obj.read_uvh5(filename, **kwargs) 11472 self._convert_from_filetype(uvh5_obj) 11473 del uvh5_obj File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/pyuvdata/uvdata/uvh5.py:1468, in UVH5.read_uvh5(self, filename, antenna_nums, antenna_names, ant_str, bls, frequencies, freq_chans, times, time_range, lsts, lst_range, polarizations, blt_inds, phase_center_ids, catalog_names, keep_all_metadata, read_data, data_array_dtype, multidim_index, remove_flex_pol, background_lsts, run_check, check_extra, run_check_acceptability, strict_uvw_antpos_check, fix_old_proj, fix_use_ant_pos, check_autos, fix_autos, use_future_array_shapes, blt_order, blts_are_rectangular, time_axis_faster_than_bls, recompute_nbls, astrometry_library) 1465 self._filename.form = (1,) 1467 # open hdf5 file for reading -> 1468 self._read_header( 1469 meta, 1470 run_check_acceptability=run_check_acceptability, 1471 background_lsts=background_lsts, 1472 astrometry_library=astrometry_library, 1473 ) 1475 if read_data: 1476 # Now read in the data 1477 self._get_data( 1478 meta.datagrp, 1479 antenna_nums, (...) 1495 multidim_index, 1496 ) File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/pyuvdata/uvdata/uvh5.py:1090, in UVH5._read_header(self, filename, **kwargs) 1067 def _read_header( 1068 self, filename: str | Path | FastUVH5Meta | h5py.File | h5py.Group, **kwargs 1069 ): 1070 """ 1071 Read header information from a UVH5 file. 1072 (...) 1088 None 1089 """ -> 1090 self._read_header_with_fast_meta(filename, **kwargs) File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/pyuvdata/uvdata/uvh5.py:911, in UVH5._read_header_with_fast_meta(self, filename, run_check_acceptability, blt_order, blts_are_rectangular, time_axis_faster_than_bls, background_lsts, recompute_nbls, astrometry_library) 907 obj = filename 909 # First, get the things relevant for setting LSTs, so that can be run in the 910 # background if desired. --> 911 self.time_array = obj.time_array 912 # must set the frame before setting the location using lat/lon/alt 913 self._telescope_location.frame = obj.telescope_frame File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/pyuvdata/uvdata/uvh5.py:451, in FastUVH5Meta.__getattr__(self, name) 449 """Get attribute directly from header group.""" 450 try: --> 451 x = self.header[name][()] 452 if name in self._string_attrs: 453 x = bytes(x).decode("utf8") File ~/mambaforge/envs/RTP/lib/python3.12/functools.py:995, in cached_property.__get__(self, instance, owner) 993 val = cache.get(self.attrname, _NOT_FOUND) 994 if val is _NOT_FOUND: --> 995 val = self.func(instance) 996 try: 997 cache[self.attrname] = val File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/pyuvdata/uvdata/uvh5.py:413, in FastUVH5Meta.header(self) 411 """Get the header group.""" 412 if not self.__file: --> 413 self.open() 414 return self.__header File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/pyuvdata/uvdata/uvh5.py:405, in FastUVH5Meta.open(self) 403 """Open the file.""" 404 if not self.__file: --> 405 self.__file = h5py.File(self.path, "r") 406 self.__header = self.__file["/Header"] 407 self.__datagrp = self.__file["/Data"] File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/h5py/_hl/files.py:562, in File.__init__(self, name, mode, driver, libver, userblock_size, swmr, rdcc_nslots, rdcc_nbytes, rdcc_w0, track_order, fs_strategy, fs_persist, fs_threshold, fs_page_size, page_buf_size, min_meta_keep, min_raw_keep, locking, alignment_threshold, alignment_interval, meta_block_size, **kwds) 553 fapl = make_fapl(driver, libver, rdcc_nslots, rdcc_nbytes, rdcc_w0, 554 locking, page_buf_size, min_meta_keep, min_raw_keep, 555 alignment_threshold=alignment_threshold, 556 alignment_interval=alignment_interval, 557 meta_block_size=meta_block_size, 558 **kwds) 559 fcpl = make_fcpl(track_order=track_order, fs_strategy=fs_strategy, 560 fs_persist=fs_persist, fs_threshold=fs_threshold, 561 fs_page_size=fs_page_size) --> 562 fid = make_fid(name, mode, userblock_size, fapl, fcpl, swmr=swmr) 564 if isinstance(libver, tuple): 565 self._libver = libver File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/h5py/_hl/files.py:235, in make_fid(name, mode, userblock_size, fapl, fcpl, swmr) 233 if swmr and swmr_support: 234 flags |= h5f.ACC_SWMR_READ --> 235 fid = h5f.open(name, flags, fapl=fapl) 236 elif mode == 'r+': 237 fid = h5f.open(name, h5f.ACC_RDWR, fapl=fapl) File h5py/_objects.pyx:54, in h5py._objects.with_phil.wrapper() File h5py/_objects.pyx:55, in h5py._objects.with_phil.wrapper() File h5py/h5f.pyx:102, in h5py.h5f.open() OSError: Unable to synchronously open file (bad object header version number)
Visibility amplitude spectra for a set of redundant baselines, labeled by inter vs. intranode baselines. The red and blue should exhibit the same bandpass shape - if the red are consistently different from the blue, this indicates an issue with internode correlations.
Note: antennas that were identified as bad by the correlation matrix have been removed from this plot.
utils.plotVisibilitySpectra(HHfiles[len(HHfiles)//2+1], JD, use_ants, badAnts=[])
<Figure size 640x480 with 0 Axes>
Even and Odd File Checks¶
A waterfall showing the ratio between the even and odd visibilities. The purpose of this is to highlight xengine failures, which will cause this value to fall to zero or go to infinity. If things are working properly, this value should be stable at 1. The boundaries between different x-engines are shown by the vertical white lines.
if len(HHautos) == len(diffautos):
uvd_diff = UVData()
uvd_diff.read(diffautos[::10], skip_bad_files=True, antenna_nums=use_ants)
rat = utils.plotEvenOddWaterfalls(uvd,uvd_diff)
else:
uvd_diff = UVData()
use_diffs = [f for f in diffautos if '%s/zen.%s.%s.sum.autos.uvh5' % (data_path,f.split('.')[1],f.split('.')[2]) in HHautos[::10]]
uvd_diff.read(use_diffs, skip_bad_files=True, antenna_nums = use_ants)
uvd_sum = uvd.select(times=np.unique(uvd_diff.time_array),inplace=False)
rat = utils.plotEvenOddWaterfalls(uvd_sum,uvd_diff)
Crossed Antenna Check¶
These are differences between different panels of the correlation matrices shown above (see panel titles for specifics). Antennas showing as consistently blue are ones which are correlating stronger in the cross pols than in the auto pols, indicating that the antenna polarizations are likely crossed.
crossedAnts = utils.plotNodeAveragedSummary(uvd,HHfiles,JD,use_ants,mat_pols=['xx','yy','xy','yx'],plotRatios=True,
plotSummary=False)
--------------------------------------------------------------------------- OSError Traceback (most recent call last) Cell In[12], line 1 ----> 1 crossedAnts = utils.plotNodeAveragedSummary(uvd,HHfiles,JD,use_ants,mat_pols=['xx','yy','xy','yx'],plotRatios=True, 2 plotSummary=False) File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/hera_notebook_templates/utils.py:811, in plotNodeAveragedSummary(uv, HHfiles, jd, use_ants, pols, mat_pols, baseline_groups, removeBadAnts, plotRatios, plotSummary) 807 if baseline_groups == []: 808 baseline_groups = [(14,0,'14m E-W'),(14,-11,'14m NW-SE'),(14,11,'14m SW-NE'),(29,0,'29m E-W'),(29,22,'29m SW-NE'), 809 (44,0,'44m E-W'),(58.5,0,'58m E-W'),(73,0,'73m E-W'),(87.6,0,'88m E-W'), 810 (102.3,0,'102m E-W')] --> 811 nodeMedians,lsts,badAnts=get_correlation_baseline_evolutions(uv,HHfiles,jd,use_ants,pols=pols,mat_pols=mat_pols, 812 bl_type=baseline_groups,removeBadAnts=removeBadAnts, 813 plotRatios=plotRatios) 814 pols = mat_pols 815 if plotSummary is False: File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/hera_notebook_templates/utils.py:1477, in get_correlation_baseline_evolutions(uv, HHfiles, jd, use_ants, badThresh, pols, bl_type, removeBadAnts, plotMatrix, mat_pols, plotRatios) 1444 def get_correlation_baseline_evolutions(uv,HHfiles,jd,use_ants='auto',badThresh=0.35,pols=['xx','yy'],bl_type=(14,0,'14m E-W'), 1445 removeBadAnts=False, plotMatrix=True,mat_pols=['xx','yy','xy','yx'],plotRatios=False): 1446 """ 1447 Calculates the average correlation metric for a set of redundant baseline groups at one hour intervals throughout a night of observation. 1448 (...) 1475 Antenna numbers flagged as bad based on badThresh parameter. 1476 """ -> 1477 files, lsts, inds = get_hourly_files(uv, HHfiles, jd) 1478 if use_ants == 'auto': 1479 use_ants = uv.get_ants() File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/hera_notebook_templates/utils.py:1388, in get_hourly_files(uv, HHfiles, jd) 1386 try: 1387 dat = UVData() -> 1388 dat.read(file, read_data=False) 1389 except KeyError: 1390 continue File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/pyuvdata/uvdata/uvdata.py:12660, in UVData.read(self, filename, axis, file_type, read_data, skip_bad_files, background_lsts, astrometry_library, ignore_name, use_future_array_shapes, allow_rephase, make_multi_phase, antenna_nums, antenna_names, ant_str, bls, catalog_names, frequencies, freq_chans, times, time_range, lsts, lst_range, polarizations, blt_inds, phase_center_ids, keep_all_metadata, run_check, check_extra, run_check_acceptability, strict_uvw_antpos_check, check_autos, fix_autos, phase_type, projected, correct_lat_lon, calc_lst, fix_old_proj, fix_use_ant_pos, use_model, data_column, pol_order, ignore_single_chan, raise_error, read_weights, allow_flex_pol, multidim_index, remove_flex_pol, blt_order, blts_are_rectangular, time_axis_faster_than_bls, data_array_dtype, use_aoflagger_flags, remove_dig_gains, remove_coarse_band, correct_cable_len, correct_van_vleck, cheby_approx, flag_small_auto_ants, propagate_coarse_flags, flag_init, edge_width, start_flag, end_flag, flag_dc_offset, remove_flagged_ants, phase_to_pointing_center, nsample_array_dtype, corrchunk, receivers, sidebands, mir_select_where, apply_tsys, apply_flags, apply_dedoppler, pseudo_cont, rechunk, compass_soln, swarm_only, codes_check, recompute_nbls) 12640 self.read_ms( 12641 filename, 12642 data_column=data_column, (...) 12656 astrometry_library=astrometry_library, 12657 ) 12659 elif file_type == "uvh5": > 12660 self.read_uvh5( 12661 filename, 12662 antenna_nums=antenna_nums, 12663 antenna_names=antenna_names, 12664 ant_str=ant_str, 12665 bls=bls, 12666 frequencies=frequencies, 12667 freq_chans=freq_chans, 12668 times=times, 12669 time_range=time_range, 12670 lsts=lsts, 12671 lst_range=lst_range, 12672 polarizations=polarizations, 12673 blt_inds=blt_inds, 12674 phase_center_ids=phase_center_ids, 12675 catalog_names=catalog_names, 12676 read_data=read_data, 12677 data_array_dtype=data_array_dtype, 12678 keep_all_metadata=keep_all_metadata, 12679 multidim_index=multidim_index, 12680 remove_flex_pol=remove_flex_pol, 12681 background_lsts=background_lsts, 12682 run_check=run_check, 12683 check_extra=check_extra, 12684 run_check_acceptability=run_check_acceptability, 12685 strict_uvw_antpos_check=strict_uvw_antpos_check, 12686 fix_old_proj=fix_old_proj, 12687 fix_use_ant_pos=fix_use_ant_pos, 12688 check_autos=check_autos, 12689 fix_autos=fix_autos, 12690 use_future_array_shapes=use_future_array_shapes, 12691 time_axis_faster_than_bls=time_axis_faster_than_bls, 12692 blts_are_rectangular=blts_are_rectangular, 12693 recompute_nbls=recompute_nbls, 12694 astrometry_library=astrometry_library, 12695 ) 12696 select = False 12698 if select: File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/pyuvdata/uvdata/uvdata.py:11471, in UVData.read_uvh5(self, filename, **kwargs) 11464 raise ValueError( 11465 "Reading multiple files from class specific " 11466 "read functions is no longer supported. " 11467 "Use the generic `uvdata.read` function instead." 11468 ) 11470 uvh5_obj = uvh5.UVH5() > 11471 uvh5_obj.read_uvh5(filename, **kwargs) 11472 self._convert_from_filetype(uvh5_obj) 11473 del uvh5_obj File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/pyuvdata/uvdata/uvh5.py:1468, in UVH5.read_uvh5(self, filename, antenna_nums, antenna_names, ant_str, bls, frequencies, freq_chans, times, time_range, lsts, lst_range, polarizations, blt_inds, phase_center_ids, catalog_names, keep_all_metadata, read_data, data_array_dtype, multidim_index, remove_flex_pol, background_lsts, run_check, check_extra, run_check_acceptability, strict_uvw_antpos_check, fix_old_proj, fix_use_ant_pos, check_autos, fix_autos, use_future_array_shapes, blt_order, blts_are_rectangular, time_axis_faster_than_bls, recompute_nbls, astrometry_library) 1465 self._filename.form = (1,) 1467 # open hdf5 file for reading -> 1468 self._read_header( 1469 meta, 1470 run_check_acceptability=run_check_acceptability, 1471 background_lsts=background_lsts, 1472 astrometry_library=astrometry_library, 1473 ) 1475 if read_data: 1476 # Now read in the data 1477 self._get_data( 1478 meta.datagrp, 1479 antenna_nums, (...) 1495 multidim_index, 1496 ) File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/pyuvdata/uvdata/uvh5.py:1090, in UVH5._read_header(self, filename, **kwargs) 1067 def _read_header( 1068 self, filename: str | Path | FastUVH5Meta | h5py.File | h5py.Group, **kwargs 1069 ): 1070 """ 1071 Read header information from a UVH5 file. 1072 (...) 1088 None 1089 """ -> 1090 self._read_header_with_fast_meta(filename, **kwargs) File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/pyuvdata/uvdata/uvh5.py:911, in UVH5._read_header_with_fast_meta(self, filename, run_check_acceptability, blt_order, blts_are_rectangular, time_axis_faster_than_bls, background_lsts, recompute_nbls, astrometry_library) 907 obj = filename 909 # First, get the things relevant for setting LSTs, so that can be run in the 910 # background if desired. --> 911 self.time_array = obj.time_array 912 # must set the frame before setting the location using lat/lon/alt 913 self._telescope_location.frame = obj.telescope_frame File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/pyuvdata/uvdata/uvh5.py:451, in FastUVH5Meta.__getattr__(self, name) 449 """Get attribute directly from header group.""" 450 try: --> 451 x = self.header[name][()] 452 if name in self._string_attrs: 453 x = bytes(x).decode("utf8") File ~/mambaforge/envs/RTP/lib/python3.12/functools.py:995, in cached_property.__get__(self, instance, owner) 993 val = cache.get(self.attrname, _NOT_FOUND) 994 if val is _NOT_FOUND: --> 995 val = self.func(instance) 996 try: 997 cache[self.attrname] = val File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/pyuvdata/uvdata/uvh5.py:413, in FastUVH5Meta.header(self) 411 """Get the header group.""" 412 if not self.__file: --> 413 self.open() 414 return self.__header File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/pyuvdata/uvdata/uvh5.py:405, in FastUVH5Meta.open(self) 403 """Open the file.""" 404 if not self.__file: --> 405 self.__file = h5py.File(self.path, "r") 406 self.__header = self.__file["/Header"] 407 self.__datagrp = self.__file["/Data"] File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/h5py/_hl/files.py:562, in File.__init__(self, name, mode, driver, libver, userblock_size, swmr, rdcc_nslots, rdcc_nbytes, rdcc_w0, track_order, fs_strategy, fs_persist, fs_threshold, fs_page_size, page_buf_size, min_meta_keep, min_raw_keep, locking, alignment_threshold, alignment_interval, meta_block_size, **kwds) 553 fapl = make_fapl(driver, libver, rdcc_nslots, rdcc_nbytes, rdcc_w0, 554 locking, page_buf_size, min_meta_keep, min_raw_keep, 555 alignment_threshold=alignment_threshold, 556 alignment_interval=alignment_interval, 557 meta_block_size=meta_block_size, 558 **kwds) 559 fcpl = make_fcpl(track_order=track_order, fs_strategy=fs_strategy, 560 fs_persist=fs_persist, fs_threshold=fs_threshold, 561 fs_page_size=fs_page_size) --> 562 fid = make_fid(name, mode, userblock_size, fapl, fcpl, swmr=swmr) 564 if isinstance(libver, tuple): 565 self._libver = libver File ~/mambaforge/envs/RTP/lib/python3.12/site-packages/h5py/_hl/files.py:235, in make_fid(name, mode, userblock_size, fapl, fcpl, swmr) 233 if swmr and swmr_support: 234 flags |= h5f.ACC_SWMR_READ --> 235 fid = h5f.open(name, flags, fapl=fapl) 236 elif mode == 'r+': 237 fid = h5f.open(name, h5f.ACC_RDWR, fapl=fapl) File h5py/_objects.pyx:54, in h5py._objects.with_phil.wrapper() File h5py/_objects.pyx:55, in h5py._objects.with_phil.wrapper() File h5py/h5f.pyx:102, in h5py.h5f.open() OSError: Unable to synchronously open file (bad object header version number)
Antenna Positions¶
Antennas outlined in black here have been identified by the correlation matrix as bad antennas. Antennas with a colorful outline correspond to their status as identified by ant_metrics (see above plot). Faded antennas are those not meeting the apriori status requirement for this notebook run. Gold stars are node box locations.
uvd1 = UVData()
uvd1.read(HHfiles[readInd], skip_bad_files=True)
utils.plot_antenna_positions(uvd1, badAnts=badAnts,use_ants=use_ants)
Observer Inspection Plots¶
Antennas of status digital_OK or better that are flagged as bad by any of the above metrics are plotted here so observers can inspect their failures in more detail. Additionally, a 'good' template has been used to identify outliers. The upper line plots are averages over the whole observation, and the lower line plots are slices of a single time in the middle of the observation. These plots are recommended diagnostics for demoting antennas to lower statuses or reporting issues. If the plots below look OK, check other plots in notebook to hunt why the antenna was flagged. NOTE: The colorbar/power scales in these plots are NOT locked between antennas OR polarizations so that the detail will be visible on all plots. Be sure to check for reasonable power levels, as this may be the reason the antenna was flagged for inspection.
d, tempAnts = utils.flag_by_template(uvd,HHautos,JD,use_ants=use_ants,pols=['XX','YY'],plotMap=False)
inspectAnts = utils.plot_inspect_ants(uvd,JD,badAnts=badAnts,use_ants=use_ants,
tempAnts=tempAnts,crossedAnts=crossedAnts)
--------------------------------------------------------------------------- NameError Traceback (most recent call last) Cell In[15], line 2 1 inspectAnts = utils.plot_inspect_ants(uvd,JD,badAnts=badAnts,use_ants=use_ants, ----> 2 tempAnts=tempAnts,crossedAnts=crossedAnts) NameError: name 'crossedAnts' is not defined
Mean-Subtracted Waterfalls¶
Here the mean value in each frequency bin has been subtracted out. This effectively subtracts out the bandpass shape, making time variations more visible.
utils.plot_wfs(uvd,0,mean_sub=True,jd=JD)
utils.plot_wfs(uvd,1,mean_sub=True,jd=JD)