Download Wide Field Slittless Spectroscopy (WFSS) Data#

This notebook uses the python astroquery.mast Observations class of the MAST API to query specific data products of a specific program. We are looking for NIRISS imaging and WFSS files of the NGDEEP program (ID 2079). The observations are in three NIRISS filters: F115W, F150W, and F200W using both GR150R and GR150C grisms. A WFSS observation sequence typically consists of a direct image followed by a grism observation in the same blocking filter to help identify the sources in the field. In program 2079, the exposure sequence follows the pattern: direct image -> GR150R -> direct image -> GR150C -> direct image.

Use case: use MAST to download data products.
Data: JWST/NIRISS images and spectra from program 2079 observation 004.
Tools: astropy, astroquery, glob, matplotlib, numpy, os, pandas, (yaml)
Cross-instrument: all

Content

  • Imports

  • Querying for Observations

    • Search with Proposal ID

    • Search with Observation ID

  • Filter and Download Products

    • Filtering Data Before Downloading

    • Downloading Data

  • Inspect Downloaded Data

Author: Camilla Pacifici (cpacifici@stsci.edu) & Rachel Plesha (rplesha@stsci.edu) & Jo Taylor (jotaylor@stsci.edu)
First Published: May 2024

This notebook was inspired by the JWebbinar session about MAST.

Imports#

from astropy.io import fits
from astroquery.mast import Observations
from matplotlib import pyplot as plt
import numpy as np
import os
import glob
import pandas as pd

Querying for Observations#

The observations class in astroquery.mast is used to download JWST data. Use the metadata function to see the available search options and their descriptions.

Note that for JWST, the instrument names have a specific format. More information about that can be found at: https://outerspace.stsci.edu/display/MASTDOCS/JWST+Instrument+Names

Observations.get_metadata("observations")
Table length=34
Column NameColumn LabelData TypeUnitsDescriptionExamples/Valid Values
str21str25str7str10str72str116
intentTypeObservation TypestringWhether observation is for science or calibration.Valid values: science, calibration
obs_collectionMissionstringCollectionE.g. SWIFT, PS1, HST, IUE
provenance_nameProvenance NamestringProvenance name, or source of dataE.g. TASOC, CALSTIS, PS1
instrument_nameInstrumentstringInstrument NameE.g. WFPC2/WFC, UVOT, STIS/CCD
projectProjectstringProcessing projectE.g. HST, HLA, EUVE, hlsp_legus
filtersFiltersstringInstrument filtersF469N, NUV, FUV, LOW DISP, MIRROR
wavelength_regionWavebandstringEnergy BandEUV, XRAY, OPTICAL
target_nameTarget NamestringTarget NameEx. COMET-67P-CHURYUMOV-GER-UPDATE
target_classificationTarget ClassificationstringType of targetEx. COMET;COMET BEING ORBITED BY THE ROSETTA SPACECRAFT;SOLAR SYSTEM
..................
s_regions_regionstringICRS ShapeSTC/S FootprintWill be ICRS circle or polygon. E.g. CIRCLE ICRS 17.71740689 -58.40043015 0.625
jpegURLjpegURLstringPreview Image URLhttps://archive.stsci.edu/hst/previews/N4QF/N4QF18090.jpg
distanceDistance (")floatarcsecAngular separation between searched coordinates and center of obsevation
obsidProduct Group IDintegerDatabase identifier for obs_idLong integer, e.g. 2007590987
dataRightsData RightsstringData Rightsvalid values: public,exclusive_access,restricted
mtFlagMoving TargetbooleanMoving Target FlagIf True, observation contains a moving target, if False or absent observation may or may not contain a moving target
srcDenNumber of Catalog ObjectsfloatNumber of cataloged objects found in observation
dataURLData URLstringData URL
proposal_typeProposal TypestringType of telescope proposalEg. 3PI, GO, GO/DD, HLA, GII, AIS
sequence_numberSequence NumberintegerSequence number, e.g. Kepler quarter or TESS sector

The two most common ways to download specific datasets are by using the proposal ID or by using the observation ID.

Search with Proposal ID#

# Select the proposal ID, instrument, and some useful keywords (filters in this case).
obs_table = Observations.query_criteria(obs_collection=["JWST"], 
                                        instrument_name=["NIRISS/IMAGE", "NIRISS/WFSS"],
                                        provenance_name=["CALJWST"], # Executed observations
                                        filters=['F115W', 'F150W', 'F200W'],
                                        proposal_id=[2079],
                                        )

print(len(obs_table), 'files found')
# look at what was obtained in this query for a select number of column names of interest
obs_table[['obs_collection', 'instrument_name', 'filters', 'target_name', 'obs_id', 's_ra', 's_dec', 't_exptime', 'proposal_id']]
2445 files found
Table length=2445
obs_collectioninstrument_namefilterstarget_nameobs_ids_ras_dect_exptimeproposal_id
str4str12str12str15str43float64float64float64str4
JWSTNIRISS/IMAGECLEAR;F115WHUDF-DEEP-F160Wjw02079-o004_t001_niriss_clear-f115w53.16083625-27.7832861111111245153.642079
JWSTNIRISS/IMAGECLEAR;F200WHUDF-DEEP-F160Wjw02079-o004_t001_niriss_clear-f200w53.16083625-27.7832861111111241717.88000000000062079
JWSTNIRISS/IMAGECLEAR;F150WHUDF-DEEP-F160Wjw02079-o004_t001_niriss_clear-f150w53.16083625-27.7832861111111241717.88000000000062079
JWSTNIRISS/IMAGECLEAR;F115WHUDF-DEEP-F160Wjw02079-o001_t001_niriss_clear-f115w53.16083625-27.7832861111111245153.642079
JWSTNIRISS/IMAGECLEAR;F150WHUDF-DEEP-F160Wjw02079-o001_t001_niriss_clear-f150w53.16083625-27.7832861111111241717.88000000000062079
JWSTNIRISS/IMAGECLEAR;F200WHUDF-DEEP-F160Wjw02079-o001_t001_niriss_clear-f200w53.16083625-27.7832861111111241717.88000000000062079
JWSTNIRISS/WFSSGR150R;F200WHUDF-DEEP-F160Wjw02079-o001_s01139_niriss_f200w-gr150r53.16083625-27.7832861111111245153.652079
JWSTNIRISS/WFSSGR150C;F115WHUDF-DEEP-F160Wjw02079-o001_s00288_niriss_f115w-gr150c53.16083625-27.7832861111111245153.652079
JWSTNIRISS/WFSSGR150C;F115WHUDF-DEEP-F160Wjw02079-o001_s00499_niriss_f115w-gr150c53.16083625-27.7832861111111245153.652079
...........................
JWSTNIRISS/WFSSGR150C;F115WHUDF-DEEP-F160Wjw02079-o004_s000000624_niriss_f115w-gr150c53.16083625-27.7832861111111245153.652079
JWSTNIRISS/WFSSGR150C;F115WHUDF-DEEP-F160Wjw02079-o004_s000000622_niriss_f115w-gr150c53.16083625-27.7832861111111245153.652079
JWSTNIRISS/WFSSGR150C;F200WHUDF-DEEP-F160Wjw02079-o004_s000000525_niriss_f200w-gr150c53.16083625-27.7832861111111245153.652079
JWSTNIRISS/WFSSGR150C;F150WHUDF-DEEP-F160Wjw02079-o004_s000000996_niriss_f150w-gr150c53.16083625-27.7832861111111246871.5332079
JWSTNIRISS/WFSSGR150R;F115WHUDF-DEEP-F160Wjw02079-o004_s000000009_niriss_f115w-gr150r53.16083625-27.7832861111111245153.652079
JWSTNIRISS/WFSSGR150R;F150WHUDF-DEEP-F160Wjw02079-o004_s000000239_niriss_f150w-gr150r53.16083625-27.7832861111111246871.5332079
JWSTNIRISS/WFSSGR150R;F115WHUDF-DEEP-F160Wjw02079-o004_s000000453_niriss_f115w-gr150r53.16083625-27.7832861111111245153.652079
JWSTNIRISS/WFSSGR150C;F200WHUDF-DEEP-F160Wjw02079-o004_s000000643_niriss_f200w-gr150c53.16083625-27.7832861111111245153.652079
JWSTNIRISS/WFSSGR150C;F115WHUDF-DEEP-F160Wjw02079-o004_s000000425_niriss_f115w-gr150c53.16083625-27.7832861111111245153.652079
JWSTNIRISS/WFSSGR150R;F200WHUDF-DEEP-F160Wjw02079-o004_s000000280_niriss_f200w-gr150r53.16083625-27.7832861111111245153.652079

Search with Observation ID#

The observation ID (obs_id) allows for flexibility of searching by the proposal ID and the observation ID because of how the JWST filenames are structured. More information about the JWST file naming conventions can be found at: https://jwst-pipeline.readthedocs.io/en/latest/jwst/data_products/file_naming.html. For the purposes of this notebook series, we will use only one of the two observations (004) in program 2079.

Additionally, there is flexibility using wildcards inside of the search criteria. For example, instead of specifying both “NIRISS/IMAGE” and “NIRISS/WFSS”, we can specify “NIRISS*”, which picks up both file modes. The wildcard also works within the obs_id, so we do not have to list all of the different IDs.

# Obtain a list to download from a specific list of observation IDs instead
obs_id_table = Observations.query_criteria(instrument_name=["NIRISS*"],
                                           provenance_name=["CALJWST"], # Executed observations
                                           obs_id=['jw02079-o004*'], # Searching for PID 2079 observation 004
                                           ) 

# this number will change with JWST pipeline and reference file updates
print(len(obs_id_table), 'files found') # ~613 files
1220 files found

Filter and Download Products#

If there are too many files to download, the API will time out. Instead, it is better to divide the observations in batches to download one at a time.

batch_size = 5 # 5 files at a time maximizes the download speed.

# Let's split up our list of files, ``obs_id_table``, into batches according to our batch size.
obs_batches = [obs_id_table[i:i+batch_size] for i in range(0, len(obs_id_table), batch_size)]
print("How many batches?", len(obs_batches))

single_group = obs_batches[0] # Useful to inspect the files obtained from one group
print("Inspect the first batch to ensure that it matches expectations of what you want downloaded:") 
single_group['obs_collection', 'instrument_name', 'filters', 'target_name', 'obs_id', 's_ra', 's_dec', 't_exptime', 'proposal_id']
How many batches? 244
Inspect the first batch to ensure that it matches expectations of what you want downloaded:
Table length=5
obs_collectioninstrument_namefilterstarget_nameobs_ids_ras_dect_exptimeproposal_id
str4str12str12str15str43float64float64float64str4
JWSTNIRISS/WFSSGR150R;F200WHUDF-DEEP-F160Wjw02079-o004_s00909_niriss_f200w-gr150r53.16083625-27.7832861111111245153.652079
JWSTNIRISS/WFSSGR150R;F150WHUDF-DEEP-F160Wjw02079-o004_s01210_niriss_f150w-gr150r53.16083625-27.7832861111111246871.5332079
JWSTNIRISS/WFSSGR150R;F150WHUDF-DEEP-F160Wjw02079-o004_s00965_niriss_f150w-gr150r53.16083625-27.7832861111111246871.5332079
JWSTNIRISS/WFSSGR150C;F200WHUDF-DEEP-F160Wjw02079-o004_s00602_niriss_f200w-gr150c53.16083625-27.7832861111111245153.652079
JWSTNIRISS/WFSSGR150C;F200WHUDF-DEEP-F160Wjw02079-o004_s00711_niriss_f200w-gr150c53.16083625-27.7832861111111245153.652079

Select the type of products needed. The various levels are:

  • uncalibrated files

    • productType=[“SCIENCE”]

    • productSubGroupDescription=[‘UNCAL’]

    • calib_level=[1]

  • rate images

    • productType=[“SCIENCE”]

    • productSubGroupDescription=[‘RATE’]

    • calib_level=[2]

  • level 2 associations for both spectroscopy and imaging

    • productType=[“INFO”]

    • productSubGroupDescription=[‘ASN’]

    • calib_level=[2]

  • level 3 associations for imaging

    • productType=[“INFO”]

    • productSubGroupDescription=[‘ASN’]

    • dataproduct_type=[“image”]

    • calib_level=[3]

Filtering Data Before Downloading#

# creating a dictionary of the above information to use for inspection of the filtering function
file_dict = {'uncal': {'product_type': 'SCIENCE',
                       'productSubGroupDescription': 'UNCAL',
                       'calib_level': [1]},
             'rate': {'product_type': 'SCIENCE',
                      'productSubGroupDescription': 'RATE',
                      'calib_level': [2]},
             'level2_association': {'product_type': 'INFO',
                                    'productSubGroupDescription': 'ASN',
                                    'calib_level': [2]},
             'level3_association': {'product_type': 'INFO',
                                    'productSubGroupDescription': 'ASN',
                                    'calib_level': [3]},
             }
# Look at the files existing for each of these different levels
files_to_download = []
for index, batch_exposure in enumerate(single_group):
    
    print('*'*50)
    print(f"Exposure #{index+1} ({batch_exposure['obs_id']})")
    # pull out the product names from the list to filter
    products = Observations.get_product_list(batch_exposure)
    
    for filetype, query_dict in file_dict.items():
        print('File type:', filetype)
        filtered_products = Observations.filter_products(products,
                                                         productType=query_dict['product_type'],
                                                         productSubGroupDescription=query_dict['productSubGroupDescription'],
                                                         calib_level=query_dict['calib_level'],
                                                         )
        print(filtered_products['productFilename'])
        files_to_download.extend(filtered_products['productFilename'])
        print()
    print('*'*50)
**************************************************
Exposure #1 (jw02079-o004_s00909_niriss_f200w-gr150r)
File type: uncal
            productFilename             
----------------------------------------
jw02079004003_03101_00001_nis_uncal.fits
jw02079004003_03101_00002_nis_uncal.fits
jw02079004003_03101_00003_nis_uncal.fits

File type: rate
            productFilename            
---------------------------------------
jw02079004003_03101_00001_nis_rate.fits
jw02079004003_03101_00002_nis_rate.fits
jw02079004003_03101_00003_nis_rate.fits

File type: level2_association
                 productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00006_asn.json
jw02079-o004_20241005t184831_spec2_00005_asn.json
jw02079-o004_20241005t184831_spec2_00004_asn.json

File type: level3_association
                 productFilename                 
-------------------------------------------------
jw02079-o004_20240704t000032_spec3_00002_asn.json

**************************************************
**************************************************
Exposure #2 (jw02079-o004_s01210_niriss_f150w-gr150r)
File type: uncal
            productFilename             
----------------------------------------
jw02079004002_09101_00003_nis_uncal.fits
jw02079004002_09101_00002_nis_uncal.fits
jw02079004002_09101_00001_nis_uncal.fits

File type: rate
            productFilename            
---------------------------------------
jw02079004002_09101_00003_nis_rate.fits
jw02079004002_09101_00002_nis_rate.fits
jw02079004002_09101_00001_nis_rate.fits

File type: level2_association
                 productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00010_asn.json
jw02079-o004_20241005t184831_spec2_00011_asn.json
jw02079-o004_20241005t184831_spec2_00012_asn.json

File type: level3_association
                 productFilename                 
-------------------------------------------------
jw02079-o004_20240704t000032_spec3_00004_asn.json

**************************************************
**************************************************
Exposure #3 (jw02079-o004_s00965_niriss_f150w-gr150r)
File type: uncal
            productFilename             
----------------------------------------
jw02079004002_09101_00003_nis_uncal.fits
jw02079004002_09101_00002_nis_uncal.fits
jw02079004002_09101_00001_nis_uncal.fits

File type: rate
            productFilename            
---------------------------------------
jw02079004002_09101_00003_nis_rate.fits
jw02079004002_09101_00002_nis_rate.fits
jw02079004002_09101_00001_nis_rate.fits

File type: level2_association
                 productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00010_asn.json
jw02079-o004_20241005t184831_spec2_00011_asn.json
jw02079-o004_20241005t184831_spec2_00012_asn.json

File type: level3_association
                 productFilename                 
-------------------------------------------------
jw02079-o004_20240704t000032_spec3_00004_asn.json

**************************************************
**************************************************
Exposure #4 (jw02079-o004_s00602_niriss_f200w-gr150c)
File type: uncal
            productFilename             
----------------------------------------
jw02079004003_05101_00003_nis_uncal.fits
jw02079004003_05101_00002_nis_uncal.fits
jw02079004003_05101_00001_nis_uncal.fits

File type: rate
            productFilename            
---------------------------------------
jw02079004003_05101_00003_nis_rate.fits
jw02079004003_05101_00002_nis_rate.fits
jw02079004003_05101_00001_nis_rate.fits

File type: level2_association
                 productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00001_asn.json
jw02079-o004_20241005t184831_spec2_00002_asn.json
jw02079-o004_20241005t184831_spec2_00003_asn.json

File type: level3_association
                 productFilename                 
-------------------------------------------------
jw02079-o004_20240704t000032_spec3_00001_asn.json

**************************************************
**************************************************
Exposure #5 (jw02079-o004_s00711_niriss_f200w-gr150c)
File type: uncal
            productFilename             
----------------------------------------
jw02079004003_05101_00003_nis_uncal.fits
jw02079004003_05101_00002_nis_uncal.fits
jw02079004003_05101_00001_nis_uncal.fits

File type: rate
            productFilename            
---------------------------------------
jw02079004003_05101_00003_nis_rate.fits
jw02079004003_05101_00002_nis_rate.fits
jw02079004003_05101_00001_nis_rate.fits

File type: level2_association
                 productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00001_asn.json
jw02079-o004_20241005t184831_spec2_00002_asn.json
jw02079-o004_20241005t184831_spec2_00003_asn.json

File type: level3_association
                 productFilename                 
-------------------------------------------------
jw02079-o004_20240704t000032_spec3_00001_asn.json

**************************************************

From above, we can see that for each exposure name in the observation list (obs_id_table), there are many associated files in the background that need to be downloaded as well. This is why we need to work in batches to download.

Downloading Data#

To actually download the products, provide Observations.download_products() with a list of the filtered products.

Typically, adjustments aren’t needed to the detector1 pipeline, so we can start with the outputs from detector1, the rate files, rather than the uncal files. Because of this, we only need to download the rate and association files. If you need to rerun the detector1 pipeline, productSubGroupDescription and calib_level will need to be adjusted in the Observations.filter_products call to download the uncal files instead.

If the data are proprietary, you may also need to set up your API token. NEVER commit your token to a public repository. An alternative is to create a separate configuration file (config_file.yaml) that is readable only to you and has a key: ‘mast_token’ : API token

To make create a new API token visit to following link: https://auth.mast.stsci.edu/token?suggested_name=Astroquery&suggested_scope=mast:exclusive_access

Note that a version of astroquery >= 0.4.7 is required to have the call flat=True when downloading the data. If you prefer to use an earlier version, remove that line from the call, download the data, and move all of the files in all downloaded subfolders into the single directory as defined by the download_dir variable.

# check that the version is above 0.4.7. See above note for more information
import astroquery
astroquery.__version__
'0.4.7'
download_dir = 'data'

# make sure the download directory exists; if not, write a new directory
if not os.path.exists(download_dir):
    os.mkdir(download_dir)
# Now let's get the products for each batch of observations, and filter down to only the products of interest.
for index, batch in enumerate(obs_batches):
    
    # Progress indicator...
    print('\n'+f'Batch #{index+1} / {len(obs_batches)}')
    
    # Make a list of the `obsid` identifiers from our Astropy table of observations to get products for.
    obsids = batch['obsid']
    print('Working with the following obsids:')
    for number, obs_text in zip(obsids, batch['obs_id']):
        print(f"{number} : {obs_text}")
    
    # Get list of products 
    products = Observations.get_product_list(obsids)
    
    # Filter the products to only get only the products of interest
    filtered_products = Observations.filter_products(products, 
                                                     productType=["SCIENCE", "INFO"],
                                                     productSubGroupDescription=["RATE", "ASN"], # Not using "UNCAL" here since we can start with the rate files
                                                     calib_level=[2, 3] # not using 1 here since not getting the UNCAL files
                                                     )
    
    # Download products for these records.
    # The `flat=True` option stores all files in a single directory specified by `download_dir`.
    manifest = Observations.download_products(filtered_products,
                                              download_dir=download_dir,
                                              flat=True, # astroquery v0.4.7 or later only
                                              ) 
    print('Products downloaded:\n', filtered_products['productFilename'])
Batch #1 / 244
Working with the following obsids:
216640175 : jw02079-o004_s00909_niriss_f200w-gr150r
218211248 : jw02079-o004_s01210_niriss_f150w-gr150r
218211249 : jw02079-o004_s00965_niriss_f150w-gr150r
192843000 : jw02079-o004_s00602_niriss_f200w-gr150c
218211251 : jw02079-o004_s00711_niriss_f200w-gr150c
INFO: 14 of 35 products were duplicates. Only downloading 21 unique product(s). [astroquery.mast.observations]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00001_asn.json to data/jw02079-o004_20241005t184831_spec2_00001_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00002_asn.json to data/jw02079-o004_20241005t184831_spec2_00002_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00003_asn.json to data/jw02079-o004_20241005t184831_spec2_00003_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00004_asn.json to data/jw02079-o004_20241005t184831_spec2_00004_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00005_asn.json to data/jw02079-o004_20241005t184831_spec2_00005_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00006_asn.json to data/jw02079-o004_20241005t184831_spec2_00006_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00010_asn.json to data/jw02079-o004_20241005t184831_spec2_00010_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00011_asn.json to data/jw02079-o004_20241005t184831_spec2_00011_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00012_asn.json to data/jw02079-o004_20241005t184831_spec2_00012_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004002_09101_00001_nis_rate.fits to data/jw02079004002_09101_00001_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004002_09101_00002_nis_rate.fits to data/jw02079004002_09101_00002_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004002_09101_00003_nis_rate.fits to data/jw02079004002_09101_00003_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_03101_00001_nis_rate.fits to data/jw02079004003_03101_00001_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_03101_00002_nis_rate.fits to data/jw02079004003_03101_00002_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_03101_00003_nis_rate.fits to data/jw02079004003_03101_00003_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_05101_00001_nis_rate.fits to data/jw02079004003_05101_00001_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_05101_00002_nis_rate.fits to data/jw02079004003_05101_00002_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_05101_00003_nis_rate.fits to data/jw02079004003_05101_00003_nis_rate.fits ...
 [Done]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00001_asn.json
jw02079-o004_20241005t184831_spec2_00001_asn.json
          jw02079004003_05101_00003_nis_rate.fits
          jw02079004003_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00006_asn.json
          jw02079004003_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00002_asn.json
jw02079-o004_20241005t184831_spec2_00002_asn.json
          jw02079004003_05101_00002_nis_rate.fits
          jw02079004003_05101_00002_nis_rate.fits
                                              ...
          jw02079004002_09101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00012_asn.json
jw02079-o004_20241005t184831_spec2_00012_asn.json
          jw02079004002_09101_00001_nis_rate.fits
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 35 rows

Batch #2 / 244
Working with the following obsids:
218211253 : jw02079-o004_s01320_niriss_f115w-gr150r
216640176 : jw02079-o004_s01029_niriss_f200w-gr150r
218211255 : jw02079-o004_s01140_niriss_f115w-gr150r
218211256 : jw02079-o004_s00676_niriss_f150w-gr150r
218211259 : jw02079-o004_s01261_niriss_f150w-gr150r
INFO: 26 of 59 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00016_asn.json to data/jw02079-o004_20241005t184831_spec2_00016_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00017_asn.json to data/jw02079-o004_20241005t184831_spec2_00017_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00018_asn.json to data/jw02079-o004_20241005t184831_spec2_00018_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00022_asn.json to data/jw02079-o004_20241005t184831_spec2_00022_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00023_asn.json to data/jw02079-o004_20241005t184831_spec2_00023_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00024_asn.json to data/jw02079-o004_20241005t184831_spec2_00024_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00028_asn.json to data/jw02079-o004_20241005t184831_spec2_00028_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00029_asn.json to data/jw02079-o004_20241005t184831_spec2_00029_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00030_asn.json to data/jw02079-o004_20241005t184831_spec2_00030_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004001_03101_00001_nis_rate.fits to data/jw02079004001_03101_00001_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004001_03101_00002_nis_rate.fits to data/jw02079004001_03101_00002_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004001_03101_00003_nis_rate.fits to data/jw02079004001_03101_00003_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004001_09101_00001_nis_rate.fits to data/jw02079004001_09101_00001_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004001_09101_00002_nis_rate.fits to data/jw02079004001_09101_00002_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004001_09101_00003_nis_rate.fits to data/jw02079004001_09101_00003_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004002_03101_00001_nis_rate.fits to data/jw02079004002_03101_00001_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004002_03101_00002_nis_rate.fits to data/jw02079004002_03101_00002_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004002_03101_00003_nis_rate.fits to data/jw02079004002_03101_00003_nis_rate.fits ...
 [Done]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
jw02079-o004_20241005t184831_spec2_00029_asn.json
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 59 rows

Batch #3 / 244
Working with the following obsids:
218211260 : jw02079-o004_s00596_niriss_f150w-gr150c
218211261 : jw02079-o004_s00580_niriss_f150w-gr150c
218211262 : jw02079-o004_s00959_niriss_f150w-gr150c
216640177 : jw02079-o004_s00794_niriss_f115w-gr150c
218211263 : jw02079-o004_s01048_niriss_f150w-gr150c
INFO: 21 of 47 products were duplicates. Only downloading 26 unique product(s). [astroquery.mast.observations]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00007_asn.json to data/jw02079-o004_20241005t184831_spec2_00007_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00008_asn.json to data/jw02079-o004_20241005t184831_spec2_00008_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00009_asn.json to data/jw02079-o004_20241005t184831_spec2_00009_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00013_asn.json to data/jw02079-o004_20241005t184831_spec2_00013_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00014_asn.json to data/jw02079-o004_20241005t184831_spec2_00014_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00015_asn.json to data/jw02079-o004_20241005t184831_spec2_00015_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00019_asn.json to data/jw02079-o004_20241005t184831_spec2_00019_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00020_asn.json to data/jw02079-o004_20241005t184831_spec2_00020_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00021_asn.json to data/jw02079-o004_20241005t184831_spec2_00021_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00025_asn.json to data/jw02079-o004_20241005t184831_spec2_00025_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00026_asn.json to data/jw02079-o004_20241005t184831_spec2_00026_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079-o004_20241005t184831_spec2_00027_asn.json to data/jw02079-o004_20241005t184831_spec2_00027_asn.json ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004001_05101_00001_nis_rate.fits to data/jw02079004001_05101_00001_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004001_05101_00002_nis_rate.fits to data/jw02079004001_05101_00002_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004001_05101_00003_nis_rate.fits to data/jw02079004001_05101_00003_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004001_11101_00001_nis_rate.fits to data/jw02079004001_11101_00001_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004001_11101_00002_nis_rate.fits to data/jw02079004001_11101_00002_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004001_11101_00003_nis_rate.fits to data/jw02079004001_11101_00003_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004002_05101_00001_nis_rate.fits to data/jw02079004002_05101_00001_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004002_05101_00002_nis_rate.fits to data/jw02079004002_05101_00002_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004002_05101_00003_nis_rate.fits to data/jw02079004002_05101_00003_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004002_11101_00001_nis_rate.fits to data/jw02079004002_11101_00001_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004002_11101_00002_nis_rate.fits to data/jw02079004002_11101_00002_nis_rate.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004002_11101_00003_nis_rate.fits to data/jw02079004002_11101_00003_nis_rate.fits ...
 [Done]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
          jw02079004001_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00021_asn.json
          jw02079004001_11101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00020_asn.json
          jw02079004001_11101_00002_nis_rate.fits
                                              ...
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 47 rows

Batch #4 / 244
Working with the following obsids:
218211264 : jw02079-o004_s00519_niriss_f115w-gr150r
218211265 : jw02079-o004_s00358_niriss_f150w-gr150r
216640178 : jw02079-o004_s00400_niriss_f115w-gr150c
216640179 : jw02079-o004_s01106_niriss_f200w-gr150r
218211266 : jw02079-o004_s00411_niriss_f150w-gr150c
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 59 rows

Batch #5 / 244
Working with the following obsids:
216640180 : jw02079-o004_s01387_niriss_f115w-gr150c
218211267 : jw02079-o004_s00785_niriss_f150w-gr150c
218211269 : jw02079-o004_s00394_niriss_f150w-gr150c
218211270 : jw02079-o004_s00831_niriss_f115w-gr150r
218211271 : jw02079-o004_s01237_niriss_f115w-gr150r
INFO: 26 of 71 products were duplicates. Only downloading 45 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
          jw02079004001_09101_00003_nis_rate.fits
                                              ...
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 71 rows

Batch #6 / 244
Working with the following obsids:
218211273 : jw02079-o004_s00426_niriss_f150w-gr150c
218211275 : jw02079-o004_s00920_niriss_f200w-gr150c
218211276 : jw02079-o004_s00636_niriss_f150w-gr150r
218211277 : jw02079-o004_s00954_niriss_f200w-gr150c
212418707 : jw02079-o004_s00430_niriss_f150w-gr150r
INFO: 14 of 35 products were duplicates. Only downloading 21 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00001_asn.json
jw02079-o004_20241005t184831_spec2_00001_asn.json
          jw02079004003_05101_00003_nis_rate.fits
          jw02079004003_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00002_asn.json
jw02079-o004_20241005t184831_spec2_00002_asn.json
          jw02079004003_05101_00002_nis_rate.fits
          jw02079004003_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00003_asn.json
jw02079-o004_20241005t184831_spec2_00003_asn.json
                                              ...
jw02079-o004_20241005t184831_spec2_00012_asn.json
          jw02079004002_09101_00001_nis_rate.fits
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 35 rows

Batch #7 / 244
Working with the following obsids:
216640181 : jw02079-o004_s01362_niriss_f115w-gr150c
218211279 : jw02079-o004_s00182_niriss_f200w-gr150c
218211280 : jw02079-o004_s01433_niriss_f200w-gr150c
218211281 : jw02079-o004_s01231_niriss_f150w-gr150r
218211282 : jw02079-o004_s00785_niriss_f150w-gr150r
INFO: 14 of 47 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
          jw02079004001_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00021_asn.json
          jw02079004001_11101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00020_asn.json
          jw02079004001_11101_00002_nis_rate.fits
                                              ...
jw02079-o004_20241005t184831_spec2_00012_asn.json
          jw02079004002_09101_00001_nis_rate.fits
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 47 rows

Batch #8 / 244
Working with the following obsids:
216640182 : jw02079-o004_s01153_niriss_f115w-gr150c
216640183 : jw02079-o004_s00548_niriss_f200w-gr150r
218211283 : jw02079-o004_s00222_niriss_f150w-gr150r
218211284 : jw02079-o004_s01388_niriss_f200w-gr150c
216640184 : jw02079-o004_s01262_niriss_f115w-gr150c
INFO: 19 of 59 products were duplicates. Only downloading 40 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
jw02079-o004_20241005t184831_spec2_00025_asn.json
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 59 rows

Batch #9 / 244
Working with the following obsids:
212418718 : jw02079-o004_s00683_niriss_f200w-gr150r
216640185 : jw02079-o004_s00209_niriss_f115w-gr150c
218211287 : jw02079-o004_s01256_niriss_f150w-gr150r
218211288 : jw02079-o004_s00055_niriss_f115w-gr150r
216640186 : jw02079-o004_s01262_niriss_f200w-gr150r
INFO: 7 of 59 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 59 rows

Batch #10 / 244
Working with the following obsids:
212418727 : jw02079-o004_s01411_niriss_f115w-gr150r
218211290 : jw02079-o004_s01171_niriss_f200w-gr150c
218211291 : jw02079-o004_s00693_niriss_f150w-gr150c
218211293 : jw02079-o004_s00428_niriss_f200w-gr150c
218211294 : jw02079-o004_s00269_niriss_f150w-gr150r
INFO: 7 of 47 products were duplicates. Only downloading 40 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00030_asn.json
          jw02079004001_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00024_asn.json
          jw02079004001_09101_00001_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 47 rows

Batch #11 / 244
Working with the following obsids:
218211295 : jw02079-o004_s00311_niriss_f150w-gr150c
216640187 : jw02079-o004_s00406_niriss_f200w-gr150r
212418738 : jw02079-o004_s00748_niriss_f200w-gr150r
216640188 : jw02079-o004_s01321_niriss_f200w-gr150r
218211297 : jw02079-o004_s01272_niriss_f115w-gr150r
INFO: 14 of 47 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00030_asn.json
          jw02079004001_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00024_asn.json
          jw02079004001_09101_00001_nis_rate.fits
                                              ...
          jw02079004002_11101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 47 rows

Batch #12 / 244
Working with the following obsids:
216640189 : jw02079-o004_s01455_niriss_f200w-gr150r
218211299 : jw02079-o004_s01165_niriss_f115w-gr150r
216640190 : jw02079-o004_s01140_niriss_f115w-gr150c
216640191 : jw02079-o004_s00620_niriss_f200w-gr150r
192843955 : jw02079-o004_s00457_niriss_f150w-gr150c
INFO: 7 of 59 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 59 rows

Batch #13 / 244
Working with the following obsids:
218211300 : jw02079-o004_s00845_niriss_f115w-gr150r
212418746 : jw02079-o004_s00530_niriss_f200w-gr150c
218211302 : jw02079-o004_s00461_niriss_f150w-gr150r
218211303 : jw02079-o004_s01079_niriss_f150w-gr150c
216640192 : jw02079-o004_s00423_niriss_f115w-gr150c
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 59 rows

Batch #14 / 244
Working with the following obsids:
216640193 : jw02079-o004_s01328_niriss_f115w-gr150c
218211304 : jw02079-o004_s00411_niriss_f150w-gr150r
218211305 : jw02079-o004_s00949_niriss_f200w-gr150c
216640194 : jw02079-o004_s00398_niriss_f115w-gr150c
218211306 : jw02079-o004_s00589_niriss_f115w-gr150r
INFO: 19 of 71 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
jw02079-o004_20241005t184831_spec2_00027_asn.json
                                              ...
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 71 rows

Batch #15 / 244
Working with the following obsids:
218211307 : jw02079-o004_s01170_niriss_f115w-gr150r
212418757 : jw02079-o004_s00557_niriss_f200w-gr150c
218211308 : jw02079-o004_s00989_niriss_f200w-gr150c
218211309 : jw02079-o004_s00748_niriss_f150w-gr150c
212418766 : jw02079-o004_s00483_niriss_f150w-gr150c
INFO: 14 of 47 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00030_asn.json
          jw02079004001_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00024_asn.json
          jw02079004001_09101_00001_nis_rate.fits
                                              ...
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 47 rows

Batch #16 / 244
Working with the following obsids:
212418767 : jw02079-o004_s01276_niriss_f150w-gr150c
218211312 : jw02079-o004_s00423_niriss_f115w-gr150r
218211313 : jw02079-o004_s00676_niriss_f150w-gr150c
212418774 : jw02079-o004_s01391_niriss_f200w-gr150r
212418775 : jw02079-o004_s00557_niriss_f200w-gr150r
INFO: 14 of 47 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00030_asn.json
          jw02079004001_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00024_asn.json
          jw02079004001_09101_00001_nis_rate.fits
                                              ...
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 47 rows

Batch #17 / 244
Working with the following obsids:
216640195 : jw02079-o004_s00217_niriss_f200w-gr150r
218211315 : jw02079-o004_s00446_niriss_f150w-gr150r
218211316 : jw02079-o004_s00618_niriss_f150w-gr150r
216640196 : jw02079-o004_s01025_niriss_f115w-gr150c
218211317 : jw02079-o004_s00403_niriss_f115w-gr150r
INFO: 7 of 59 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 59 rows

Batch #18 / 244
Working with the following obsids:
218211318 : jw02079-o004_s00602_niriss_f115w-gr150r
218211319 : jw02079-o004_s01110_niriss_f115w-gr150r
216640197 : jw02079-o004_s00251_niriss_f115w-gr150c
218211320 : jw02079-o004_s00419_niriss_f150w-gr150c
216640198 : jw02079-o004_s01007_niriss_f115w-gr150c
INFO: 38 of 83 products were duplicates. Only downloading 45 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
jw02079-o004_20241005t184831_spec2_00022_asn.json
                                              ...
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 83 rows

Batch #19 / 244
Working with the following obsids:
218211321 : jw02079-o004_s01235_niriss_f150w-gr150r
218211322 : jw02079-o004_s00340_niriss_f150w-gr150r
218211323 : jw02079-o004_s00440_niriss_f150w-gr150c
218211324 : jw02079-o004_s00792_niriss_f150w-gr150c
216640199 : jw02079-o004_s00129_niriss_f115w-gr150c
INFO: 14 of 47 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
          jw02079004001_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00021_asn.json
          jw02079004001_11101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00020_asn.json
          jw02079004001_11101_00002_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 47 rows

Batch #20 / 244
Working with the following obsids:
216640200 : jw02079-o004_s00845_niriss_f115w-gr150c
216640201 : jw02079-o004_s00393_niriss_f115w-gr150c
216640202 : jw02079-o004_s01234_niriss_f200w-gr150r
218211326 : jw02079-o004_s01029_niriss_f200w-gr150c
216640203 : jw02079-o004_s01075_niriss_f115w-gr150c
INFO: 38 of 71 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
jw02079-o004_20241005t184831_spec2_00027_asn.json
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
                                              ...
jw02079-o004_20241005t184831_spec2_00013_asn.json
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
          jw02079004002_05101_00003_nis_rate.fits
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 71 rows

Batch #21 / 244
Working with the following obsids:
216640204 : jw02079-o004_s00961_niriss_f200w-gr150r
218211329 : jw02079-o004_s00834_niriss_f150w-gr150c
218211330 : jw02079-o004_s00645_niriss_f200w-gr150c
218211331 : jw02079-o004_s00393_niriss_f115w-gr150r
218211332 : jw02079-o004_s00411_niriss_f200w-gr150c
INFO: 7 of 47 products were duplicates. Only downloading 40 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00030_asn.json
          jw02079004001_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00024_asn.json
          jw02079004001_09101_00001_nis_rate.fits
                                              ...
          jw02079004002_11101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 47 rows

Batch #22 / 244
Working with the following obsids:
218211333 : jw02079-o004_s00630_niriss_f200w-gr150c
218211335 : jw02079-o004_s01089_niriss_f150w-gr150c
218211336 : jw02079-o004_s00379_niriss_f200w-gr150c
218211339 : jw02079-o004_s00648_niriss_f150w-gr150c
218211340 : jw02079-o004_s00993_niriss_f150w-gr150r
INFO: 14 of 35 products were duplicates. Only downloading 21 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00001_asn.json
jw02079-o004_20241005t184831_spec2_00001_asn.json
          jw02079004003_05101_00003_nis_rate.fits
          jw02079004003_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00002_asn.json
jw02079-o004_20241005t184831_spec2_00002_asn.json
          jw02079004003_05101_00002_nis_rate.fits
          jw02079004003_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00003_asn.json
jw02079-o004_20241005t184831_spec2_00003_asn.json
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 35 rows

Batch #23 / 244
Working with the following obsids:
216640205 : jw02079-o004_s00591_niriss_f115w-gr150c
216640206 : jw02079-o004_s00791_niriss_f115w-gr150c
216640207 : jw02079-o004_s01433_niriss_f200w-gr150r
218211342 : jw02079-o004_s00567_niriss_f115w-gr150r
216640208 : jw02079-o004_s00594_niriss_f115w-gr150c
INFO: 38 of 83 products were duplicates. Only downloading 45 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
          jw02079004002_05101_00003_nis_rate.fits
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 83 rows

Batch #24 / 244
Working with the following obsids:
212418808 : jw02079-o004_s00880_niriss_f115w-gr150r
216640209 : jw02079-o004_s00705_niriss_f200w-gr150r
216640210 : jw02079-o004_s00964_niriss_f200w-gr150r
218211346 : jw02079-o004_s01185_niriss_f150w-gr150r
216640211 : jw02079-o004_s01272_niriss_f115w-gr150c
INFO: 7 of 59 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 59 rows

Batch #25 / 244
Working with the following obsids:
218211347 : jw02079-o004_s01310_niriss_f115w-gr150r
218211348 : jw02079-o004_s00257_niriss_f200w-gr150c
218211349 : jw02079-o004_s00406_niriss_f200w-gr150c
218211350 : jw02079-o004_s00440_niriss_f150w-gr150r
218211351 : jw02079-o004_s00961_niriss_f200w-gr150c
INFO: 14 of 47 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00030_asn.json
          jw02079004001_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00024_asn.json
          jw02079004001_09101_00001_nis_rate.fits
                                              ...
          jw02079004002_09101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00012_asn.json
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 47 rows

Batch #26 / 244
Working with the following obsids:
216640212 : jw02079-o004_s00630_niriss_f200w-gr150r
216640213 : jw02079-o004_s00597_niriss_f115w-gr150c
218211353 : jw02079-o004_s00896_niriss_f115w-gr150r
218211354 : jw02079-o004_s00916_niriss_f115w-gr150r
218211355 : jw02079-o004_s00546_niriss_f200w-gr150c
INFO: 19 of 71 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
          jw02079004001_09101_00003_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 71 rows

Batch #27 / 244
Working with the following obsids:
218211356 : jw02079-o004_s01117_niriss_f200w-gr150c
216640214 : jw02079-o004_s00456_niriss_f115w-gr150c
218211357 : jw02079-o004_s01321_niriss_f200w-gr150c
216640215 : jw02079-o004_s00407_niriss_f115w-gr150c
218211358 : jw02079-o004_s00828_niriss_f150w-gr150c
INFO: 26 of 59 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
jw02079-o004_20241005t184831_spec2_00025_asn.json
                                              ...
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 59 rows

Batch #28 / 244
Working with the following obsids:
218211359 : jw02079-o004_s00522_niriss_f115w-gr150r
192845402 : jw02079-o004_s00661_niriss_f115w-gr150c
216640216 : jw02079-o004_s01340_niriss_f200w-gr150r
218211360 : jw02079-o004_s01024_niriss_f115w-gr150r
212418822 : jw02079-o004_s00684_niriss_f200w-gr150c
INFO: 19 of 71 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
          jw02079004001_09101_00003_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 71 rows

Batch #29 / 244
Working with the following obsids:
216640217 : jw02079-o004_s00510_niriss_f200w-gr150r
218211362 : jw02079-o004_s00775_niriss_f150w-gr150r
218211364 : jw02079-o004_s00160_niriss_f115w-gr150r
218211365 : jw02079-o004_s00693_niriss_f150w-gr150r
216640218 : jw02079-o004_s00403_niriss_f115w-gr150c
INFO: 7 of 59 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 59 rows

Batch #30 / 244
Working with the following obsids:
218211366 : jw02079-o004_s00761_niriss_f150w-gr150r
218211367 : jw02079-o004_s01118_niriss_f150w-gr150r
216640219 : jw02079-o004_s00743_niriss_f115w-gr150c
218211369 : jw02079-o004_s00442_niriss_f150w-gr150r
218211370 : jw02079-o004_s01210_niriss_f150w-gr150c
INFO: 14 of 47 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
          jw02079004001_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00021_asn.json
          jw02079004001_11101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00020_asn.json
          jw02079004001_11101_00002_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 47 rows

Batch #31 / 244
Working with the following obsids:
218211371 : jw02079-o004_s00556_niriss_f115w-gr150r
218211372 : jw02079-o004_s00741_niriss_f150w-gr150c
212418842 : jw02079-o004_s00748_niriss_f200w-gr150c
216640220 : jw02079-o004_s00755_niriss_f115w-gr150c
212418844 : jw02079-o004_s00962_niriss_f200w-gr150c
INFO: 7 of 59 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 59 rows

Batch #32 / 244
Working with the following obsids:
192831709 : jw02079-o004_s00602_niriss_f200w-gr150r
216640221 : jw02079-o004_s00427_niriss_f115w-gr150c
218211375 : jw02079-o004_s00311_niriss_f150w-gr150r
218211376 : jw02079-o004_s00597_niriss_f115w-gr150r
216640222 : jw02079-o004_s01182_niriss_f115w-gr150c
INFO: 19 of 71 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
jw02079-o004_20241005t184831_spec2_00027_asn.json
                                              ...
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 71 rows

Batch #33 / 244
Working with the following obsids:
218211379 : jw02079-o004_s00596_niriss_f200w-gr150c
218211380 : jw02079-o004_s00157_niriss_f150w-gr150r
218211381 : jw02079-o004_s00307_niriss_f150w-gr150r
218211382 : jw02079-o004_s00495_niriss_f200w-gr150c
218211383 : jw02079-o004_s01193_niriss_f150w-gr150c
INFO: 14 of 35 products were duplicates. Only downloading 21 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00001_asn.json
jw02079-o004_20241005t184831_spec2_00001_asn.json
          jw02079004003_05101_00003_nis_rate.fits
          jw02079004003_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00002_asn.json
jw02079-o004_20241005t184831_spec2_00002_asn.json
          jw02079004003_05101_00002_nis_rate.fits
          jw02079004003_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00003_asn.json
jw02079-o004_20241005t184831_spec2_00003_asn.json
                                              ...
jw02079-o004_20241005t184831_spec2_00012_asn.json
          jw02079004002_09101_00001_nis_rate.fits
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 35 rows

Batch #34 / 244
Working with the following obsids:
212418854 : jw02079-o004_s00862_niriss_f200w-gr150r
216640223 : jw02079-o004_s00785_niriss_f200w-gr150r
218211384 : jw02079-o004_s01007_niriss_f115w-gr150r
216640224 : jw02079-o004_s00920_niriss_f200w-gr150r
218211385 : jw02079-o004_s01317_niriss_f115w-gr150r
INFO: 33 of 59 products were duplicates. Only downloading 26 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
jw02079-o004_20241005t184831_spec2_00029_asn.json
                                              ...
          jw02079004002_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 59 rows

Batch #35 / 244
Working with the following obsids:
218211387 : jw02079-o004_s00074_niriss_f150w-gr150r
212418861 : jw02079-o004_s00644_niriss_f150w-gr150c
218211388 : jw02079-o004_s00835_niriss_f150w-gr150c
218211389 : jw02079-o004_s01048_niriss_f150w-gr150r
212418865 : jw02079-o004_s00148_niriss_f115w-gr150c
INFO: 14 of 47 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
          jw02079004001_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00021_asn.json
          jw02079004001_11101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00020_asn.json
          jw02079004001_11101_00002_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 47 rows

Batch #36 / 244
Working with the following obsids:
216640225 : jw02079-o004_s01237_niriss_f115w-gr150c
218211390 : jw02079-o004_s01064_niriss_f200w-gr150c
218211391 : jw02079-o004_s00580_niriss_f150w-gr150r
218211393 : jw02079-o004_s00840_niriss_f115w-gr150r
218211394 : jw02079-o004_s01208_niriss_f150w-gr150c
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 59 rows

Batch #37 / 244
Working with the following obsids:
218211395 : jw02079-o004_s00217_niriss_f200w-gr150c
212418869 : jw02079-o004_s00644_niriss_f150w-gr150r
212418870 : jw02079-o004_s00809_niriss_f200w-gr150c
218211396 : jw02079-o004_s00251_niriss_f115w-gr150r
218211397 : jw02079-o004_s00901_niriss_f200w-gr150c
INFO: 14 of 47 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00030_asn.json
          jw02079004001_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00024_asn.json
          jw02079004001_09101_00001_nis_rate.fits
                                              ...
          jw02079004002_09101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00012_asn.json
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 47 rows

Batch #38 / 244
Working with the following obsids:
216640226 : jw02079-o004_s00387_niriss_f115w-gr150c
216640227 : jw02079-o004_s00506_niriss_f200w-gr150r
216640228 : jw02079-o004_s00160_niriss_f115w-gr150c
212418873 : jw02079-o004_s00526_niriss_f200w-gr150c
212418875 : jw02079-o004_s00526_niriss_f200w-gr150r
INFO: 26 of 59 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
jw02079-o004_20241005t184831_spec2_00025_asn.json
                                              ...
          jw02079004002_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
Length = 59 rows

Batch #39 / 244
Working with the following obsids:
218211399 : jw02079-o004_s00173_niriss_f200w-gr150c
218211400 : jw02079-o004_s00477_niriss_f115w-gr150r
218211401 : jw02079-o004_s00684_niriss_f115w-gr150r
216640229 : jw02079-o004_s00901_niriss_f200w-gr150r
216640230 : jw02079-o004_s00764_niriss_f115w-gr150c
INFO: 19 of 71 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
          jw02079004001_09101_00003_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 71 rows

Batch #40 / 244
Working with the following obsids:
216640231 : jw02079-o004_s00752_niriss_f115w-gr150c
216640232 : jw02079-o004_s01097_niriss_f200w-gr150r
216640233 : jw02079-o004_s00546_niriss_f200w-gr150r
216640234 : jw02079-o004_s00916_niriss_f115w-gr150c
218211402 : jw02079-o004_s00558_niriss_f200w-gr150c
INFO: 26 of 59 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
jw02079-o004_20241005t184831_spec2_00025_asn.json
                                              ...
          jw02079004002_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 59 rows

Batch #41 / 244
Working with the following obsids:
218211403 : jw02079-o004_s00606_niriss_f150w-gr150r
218211404 : jw02079-o004_s00827_niriss_f150w-gr150c
212418884 : jw02079-o004_s00008_niriss_f200w-gr150r
216640235 : jw02079-o004_s01009_niriss_f200w-gr150r
216640236 : jw02079-o004_s01420_niriss_f200w-gr150r
INFO: 14 of 35 products were duplicates. Only downloading 21 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00006_asn.json
jw02079-o004_20241005t184831_spec2_00006_asn.json
jw02079-o004_20241005t184831_spec2_00006_asn.json
          jw02079004003_03101_00001_nis_rate.fits
          jw02079004003_03101_00001_nis_rate.fits
          jw02079004003_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00005_asn.json
jw02079-o004_20241005t184831_spec2_00005_asn.json
jw02079-o004_20241005t184831_spec2_00005_asn.json
          jw02079004003_03101_00002_nis_rate.fits
                                              ...
          jw02079004002_11101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00012_asn.json
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 35 rows

Batch #42 / 244
Working with the following obsids:
218211405 : jw02079-o004_s01182_niriss_f115w-gr150r
218211406 : jw02079-o004_s01025_niriss_f115w-gr150r
216640237 : jw02079-o004_s00168_niriss_f115w-gr150c
218211407 : jw02079-o004_s00848_niriss_f115w-gr150r
218211408 : jw02079-o004_s00480_niriss_f200w-gr150c
INFO: 38 of 83 products were duplicates. Only downloading 45 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
jw02079-o004_20241005t184831_spec2_00028_asn.json
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
          jw02079004001_03101_00003_nis_rate.fits
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
jw02079-o004_20241005t184831_spec2_00022_asn.json
                                              ...
jw02079-o004_20241005t184831_spec2_00017_asn.json
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
          jw02079004002_03101_00002_nis_rate.fits
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 83 rows

Batch #43 / 244
Working with the following obsids:
212418891 : jw02079-o004_s00721_niriss_f200w-gr150c
192832151 : jw02079-o004_s00608_niriss_f150w-gr150r
218211409 : jw02079-o004_s00614_niriss_f150w-gr150r
212418895 : jw02079-o004_s00483_niriss_f150w-gr150r
218211410 : jw02079-o004_s00591_niriss_f115w-gr150r
INFO: 14 of 47 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00030_asn.json
          jw02079004001_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00024_asn.json
          jw02079004001_09101_00001_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
          jw02079004002_09101_00001_nis_rate.fits
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 47 rows

Batch #44 / 244
Working with the following obsids:
218211411 : jw02079-o004_s00548_niriss_f200w-gr150c
216640238 : jw02079-o004_s00754_niriss_f200w-gr150r
218211412 : jw02079-o004_s01079_niriss_f150w-gr150r
216640239 : jw02079-o004_s00789_niriss_f200w-gr150r
218211413 : jw02079-o004_s00879_niriss_f150w-gr150c
INFO: 7 of 35 products were duplicates. Only downloading 28 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00001_asn.json
          jw02079004003_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00006_asn.json
jw02079-o004_20241005t184831_spec2_00006_asn.json
          jw02079004003_03101_00001_nis_rate.fits
          jw02079004003_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00002_asn.json
          jw02079004003_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00005_asn.json
jw02079-o004_20241005t184831_spec2_00005_asn.json
                                              ...
          jw02079004002_11101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00012_asn.json
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 35 rows

Batch #45 / 244
Working with the following obsids:
218211414 : jw02079-o004_s01235_niriss_f150w-gr150c
218211415 : jw02079-o004_s00193_niriss_f150w-gr150r
216640240 : jw02079-o004_s00519_niriss_f115w-gr150c
216640241 : jw02079-o004_s00405_niriss_f115w-gr150c
218211417 : jw02079-o004_s00743_niriss_f115w-gr150r
INFO: 19 of 71 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
jw02079-o004_20241005t184831_spec2_00027_asn.json
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 71 rows

Batch #46 / 244
Working with the following obsids:
218211418 : jw02079-o004_s00786_niriss_f150w-gr150c
218211419 : jw02079-o004_s01022_niriss_f150w-gr150c
216640242 : jw02079-o004_s00558_niriss_f200w-gr150r
218211420 : jw02079-o004_s01018_niriss_f150w-gr150c
218211421 : jw02079-o004_s00759_niriss_f200w-gr150c
INFO: 14 of 35 products were duplicates. Only downloading 21 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00001_asn.json
          jw02079004003_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00006_asn.json
          jw02079004003_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00002_asn.json
          jw02079004003_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00005_asn.json
          jw02079004003_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00004_asn.json
          jw02079004003_03101_00003_nis_rate.fits
                                              ...
jw02079-o004_20241005t184831_spec2_00008_asn.json
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 35 rows

Batch #47 / 244
Working with the following obsids:
218211422 : jw02079-o004_s00625_niriss_f115w-gr150r
218211423 : jw02079-o004_s00638_niriss_f115w-gr150r
218211424 : jw02079-o004_s00879_niriss_f150w-gr150r
212418911 : jw02079-o004_s01119_niriss_f200w-gr150r
216640243 : jw02079-o004_s01312_niriss_f115w-gr150c
INFO: 19 of 71 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
          jw02079004001_09101_00003_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 71 rows

Batch #48 / 244
Working with the following obsids:
216640244 : jw02079-o004_s01367_niriss_f200w-gr150r
218211425 : jw02079-o004_s00377_niriss_f200w-gr150c
218211426 : jw02079-o004_s00129_niriss_f115w-gr150r
218211428 : jw02079-o004_s01241_niriss_f150w-gr150r
218211429 : jw02079-o004_s01340_niriss_f200w-gr150c
INFO: 7 of 47 products were duplicates. Only downloading 40 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00030_asn.json
          jw02079004001_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00024_asn.json
          jw02079004001_09101_00001_nis_rate.fits
                                              ...
          jw02079004002_09101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00012_asn.json
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 47 rows

Batch #49 / 244
Working with the following obsids:
192832328 : jw02079-o004_s00457_niriss_f150w-gr150r
218211432 : jw02079-o004_s00959_niriss_f150w-gr150r
192832353 : jw02079-o004_s00737_niriss_f200w-gr150r
218211433 : jw02079-o004_s00705_niriss_f200w-gr150c
218211434 : jw02079-o004_s01193_niriss_f150w-gr150r
INFO: 14 of 35 products were duplicates. Only downloading 21 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00001_asn.json
          jw02079004003_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00006_asn.json
          jw02079004003_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00002_asn.json
          jw02079004003_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00005_asn.json
          jw02079004003_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00004_asn.json
          jw02079004003_03101_00003_nis_rate.fits
                                              ...
jw02079-o004_20241005t184831_spec2_00012_asn.json
jw02079-o004_20241005t184831_spec2_00012_asn.json
          jw02079004002_09101_00001_nis_rate.fits
          jw02079004002_09101_00001_nis_rate.fits
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 35 rows

Batch #50 / 244
Working with the following obsids:
218211435 : jw02079-o004_s00120_niriss_f150w-gr150r
218211436 : jw02079-o004_s00748_niriss_f150w-gr150r
218211437 : jw02079-o004_s00449_niriss_f115w-gr150r
218211438 : jw02079-o004_s01138_niriss_f200w-gr150c
216640245 : jw02079-o004_s00449_niriss_f115w-gr150c
INFO: 7 of 59 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 59 rows

Batch #51 / 244
Working with the following obsids:
218211439 : jw02079-o004_s00387_niriss_f115w-gr150r
218211440 : jw02079-o004_s00120_niriss_f150w-gr150c
218211441 : jw02079-o004_s00605_niriss_f150w-gr150c
216640246 : jw02079-o004_s00381_niriss_f115w-gr150c
218211443 : jw02079-o004_s00827_niriss_f150w-gr150r
INFO: 7 of 59 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
                                              ...
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 59 rows

Batch #52 / 244
Working with the following obsids:
216640247 : jw02079-o004_s01066_niriss_f115w-gr150c
218211444 : jw02079-o004_s00504_niriss_f150w-gr150c
218211445 : jw02079-o004_s01208_niriss_f150w-gr150r
216640248 : jw02079-o004_s00840_niriss_f115w-gr150c
218211446 : jw02079-o004_s00510_niriss_f200w-gr150c
INFO: 19 of 59 products were duplicates. Only downloading 40 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
jw02079-o004_20241005t184831_spec2_00025_asn.json
                                              ...
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 59 rows

Batch #53 / 244
Working with the following obsids:
218211447 : jw02079-o004_s00994_niriss_f115w-gr150r
216640249 : jw02079-o004_s00994_niriss_f115w-gr150c
216640250 : jw02079-o004_s01317_niriss_f115w-gr150c
218211448 : jw02079-o004_s00279_niriss_f115w-gr150r
218211450 : jw02079-o004_s00375_niriss_f200w-gr150c
INFO: 38 of 83 products were duplicates. Only downloading 45 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
jw02079-o004_20241005t184831_spec2_00022_asn.json
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 83 rows

Batch #54 / 244
Working with the following obsids:
218211451 : jw02079-o004_s00761_niriss_f150w-gr150c
212418939 : jw02079-o004_s00333_niriss_f200w-gr150c
216640251 : jw02079-o004_s01403_niriss_f200w-gr150r
218211453 : jw02079-o004_s00982_niriss_f150w-gr150r
216640252 : jw02079-o004_s01385_niriss_f115w-gr150c
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
          jw02079004001_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00021_asn.json
          jw02079004001_11101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00020_asn.json
          jw02079004001_11101_00002_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 47 rows

Batch #55 / 244
Working with the following obsids:
218211454 : jw02079-o004_s01080_niriss_f150w-gr150r
212418943 : jw02079-o004_s00875_niriss_f115w-gr150r
218211455 : jw02079-o004_s01018_niriss_f150w-gr150r
216640253 : jw02079-o004_s00702_niriss_f200w-gr150r
218211457 : jw02079-o004_s01245_niriss_f150w-gr150r
INFO: 14 of 47 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00030_asn.json
          jw02079004001_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00024_asn.json
          jw02079004001_09101_00001_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
          jw02079004002_09101_00001_nis_rate.fits
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 47 rows

Batch #56 / 244
Working with the following obsids:
218211458 : jw02079-o004_s00088_niriss_f115w-gr150r
216640254 : jw02079-o004_s00094_niriss_f115w-gr150c
218211459 : jw02079-o004_s00659_niriss_f150w-gr150r
216640255 : jw02079-o004_s00759_niriss_f200w-gr150r
216640256 : jw02079-o004_s01163_niriss_f200w-gr150r
INFO: 7 of 59 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 59 rows

Batch #57 / 244
Working with the following obsids:
218211460 : jw02079-o004_s01331_niriss_f150w-gr150r
218211461 : jw02079-o004_s00222_niriss_f150w-gr150c
216640257 : jw02079-o004_s00914_niriss_f200w-gr150r
218211462 : jw02079-o004_s01097_niriss_f200w-gr150c
216640258 : jw02079-o004_s00638_niriss_f115w-gr150c
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
          jw02079004001_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00021_asn.json
          jw02079004001_11101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00020_asn.json
          jw02079004001_11101_00002_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 47 rows

Batch #58 / 244
Working with the following obsids:
218211463 : jw02079-o004_s01105_niriss_f150w-gr150c
218211464 : jw02079-o004_s00274_niriss_f200w-gr150c
218211465 : jw02079-o004_s00168_niriss_f115w-gr150r
216640259 : jw02079-o004_s00119_niriss_f200w-gr150r
218211466 : jw02079-o004_s00546_niriss_f150w-gr150r
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00030_asn.json
          jw02079004001_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00024_asn.json
          jw02079004001_09101_00001_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 47 rows

Batch #59 / 244
Working with the following obsids:
216640260 : jw02079-o004_s00144_niriss_f115w-gr150c
218211469 : jw02079-o004_s01245_niriss_f150w-gr150c
216640261 : jw02079-o004_s01239_niriss_f200w-gr150r
218211470 : jw02079-o004_s00427_niriss_f115w-gr150r
216640262 : jw02079-o004_s00294_niriss_f200w-gr150r
INFO: 7 of 59 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 59 rows

Batch #60 / 244
Working with the following obsids:
216640263 : jw02079-o004_s01199_niriss_f200w-gr150r
216640264 : jw02079-o004_s00495_niriss_f200w-gr150r
212418974 : jw02079-o004_s00529_niriss_f200w-gr150r
218211473 : jw02079-o004_s00659_niriss_f150w-gr150c
216640265 : jw02079-o004_s00600_niriss_f115w-gr150c
INFO: 14 of 47 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
          jw02079004001_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00021_asn.json
          jw02079004001_11101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00020_asn.json
          jw02079004001_11101_00002_nis_rate.fits
                                              ...
          jw02079004002_11101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 47 rows

Batch #61 / 244
Working with the following obsids:
218211475 : jw02079-o004_s00459_niriss_f150w-gr150r
218211476 : jw02079-o004_s00774_niriss_f115w-gr150r
216640266 : jw02079-o004_s00257_niriss_f200w-gr150r
216640267 : jw02079-o004_s00896_niriss_f115w-gr150c
181967842 : jw02079-o004_s00333_niriss_f200w-gr150r
INFO: 7 of 59 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 59 rows

Batch #62 / 244
Working with the following obsids:
218211477 : jw02079-o004_s01275_niriss_f200w-gr150c
218211478 : jw02079-o004_s00614_niriss_f150w-gr150c
218211479 : jw02079-o004_s00918_niriss_f200w-gr150c
181967932 : jw02079-o004_s00437_niriss_f150w-gr150r
218211480 : jw02079-o004_s01299_niriss_f150w-gr150c
INFO: 14 of 35 products were duplicates. Only downloading 21 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00001_asn.json
jw02079-o004_20241005t184831_spec2_00001_asn.json
          jw02079004003_05101_00003_nis_rate.fits
          jw02079004003_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00002_asn.json
jw02079-o004_20241005t184831_spec2_00002_asn.json
          jw02079004003_05101_00002_nis_rate.fits
          jw02079004003_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00003_asn.json
jw02079-o004_20241005t184831_spec2_00003_asn.json
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 35 rows

Batch #63 / 244
Working with the following obsids:
216640268 : jw02079-o004_s00711_niriss_f200w-gr150r
212418990 : jw02079-o004_s00550_niriss_f150w-gr150r
216640269 : jw02079-o004_s00428_niriss_f115w-gr150c
218211481 : jw02079-o004_s00775_niriss_f150w-gr150c
218211482 : jw02079-o004_s00516_niriss_f150w-gr150c
INFO: 7 of 47 products were duplicates. Only downloading 40 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
          jw02079004001_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00021_asn.json
          jw02079004001_11101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00020_asn.json
          jw02079004001_11101_00002_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 47 rows

Batch #64 / 244
Working with the following obsids:
216640270 : jw02079-o004_s00522_niriss_f115w-gr150c
218211483 : jw02079-o004_s01234_niriss_f200w-gr150c
218211484 : jw02079-o004_s00982_niriss_f150w-gr150c
218211485 : jw02079-o004_s01393_niriss_f200w-gr150c
212418998 : jw02079-o004_s01119_niriss_f200w-gr150c
INFO: 14 of 47 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
          jw02079004001_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00021_asn.json
          jw02079004001_11101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00020_asn.json
          jw02079004001_11101_00002_nis_rate.fits
                                              ...
          jw02079004002_11101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 47 rows

Batch #65 / 244
Working with the following obsids:
216640271 : jw02079-o004_s00372_niriss_f115w-gr150c
216640272 : jw02079-o004_s00279_niriss_f115w-gr150c
218211486 : jw02079-o004_s01262_niriss_f200w-gr150c
218211487 : jw02079-o004_s00428_niriss_f115w-gr150r
218211488 : jw02079-o004_s00596_niriss_f150w-gr150r
INFO: 19 of 71 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
jw02079-o004_20241005t184831_spec2_00027_asn.json
                                              ...
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 71 rows

Batch #66 / 244
Working with the following obsids:
192848640 : jw02079-o004_s00737_niriss_f200w-gr150c
218211490 : jw02079-o004_s01009_niriss_f200w-gr150c
212419002 : jw02079-o004_s00533_niriss_f200w-gr150c
212419004 : jw02079-o004_s00721_niriss_f200w-gr150r
218211491 : jw02079-o004_s00461_niriss_f150w-gr150c
INFO: 14 of 35 products were duplicates. Only downloading 21 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00001_asn.json
jw02079-o004_20241005t184831_spec2_00001_asn.json
jw02079-o004_20241005t184831_spec2_00001_asn.json
          jw02079004003_05101_00003_nis_rate.fits
          jw02079004003_05101_00003_nis_rate.fits
          jw02079004003_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00006_asn.json
          jw02079004003_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00002_asn.json
jw02079-o004_20241005t184831_spec2_00002_asn.json
                                              ...
          jw02079004002_11101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00007_asn.json
          jw02079004002_11101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 35 rows

Batch #67 / 244
Working with the following obsids:
216640273 : jw02079-o004_s00062_niriss_f115w-gr150c
218211493 : jw02079-o004_s00008_niriss_f200w-gr150c
218211494 : jw02079-o004_s00254_niriss_f115w-gr150r
218211495 : jw02079-o004_s00794_niriss_f115w-gr150r
216640274 : jw02079-o004_s01117_niriss_f200w-gr150r
INFO: 19 of 71 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
          jw02079004001_09101_00003_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 71 rows

Batch #68 / 244
Working with the following obsids:
212419005 : jw02079-o004_s00129_niriss_f150w-gr150r
212419006 : jw02079-o004_s00722_niriss_f200w-gr150r
216640275 : jw02079-o004_s00848_niriss_f115w-gr150c
218211496 : jw02079-o004_s00148_niriss_f150w-gr150c
218211497 : jw02079-o004_s01199_niriss_f200w-gr150c
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
          jw02079004001_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00021_asn.json
          jw02079004001_11101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00020_asn.json
          jw02079004001_11101_00002_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 47 rows

Batch #69 / 244
Working with the following obsids:
218211499 : jw02079-o004_s00886_niriss_f200w-gr150c
218211500 : jw02079-o004_s00893_niriss_f150w-gr150r
218211501 : jw02079-o004_s00205_niriss_f150w-gr150c
218211502 : jw02079-o004_s00472_niriss_f150w-gr150c
216640276 : jw02079-o004_s00958_niriss_f115w-gr150c
INFO: 7 of 47 products were duplicates. Only downloading 40 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
          jw02079004001_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00021_asn.json
          jw02079004001_11101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00020_asn.json
          jw02079004001_11101_00002_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 47 rows

Batch #70 / 244
Working with the following obsids:
218211503 : jw02079-o004_s00741_niriss_f150w-gr150r
212419012 : jw02079-o004_s00875_niriss_f115w-gr150c
212419019 : jw02079-o004_s00722_niriss_f200w-gr150c
216640277 : jw02079-o004_s00477_niriss_f115w-gr150c
216640278 : jw02079-o004_s00664_niriss_f115w-gr150c
INFO: 38 of 71 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
jw02079-o004_20241005t184831_spec2_00027_asn.json
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
                                              ...
jw02079-o004_20241005t184831_spec2_00013_asn.json
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
          jw02079004002_05101_00003_nis_rate.fits
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 71 rows

Batch #71 / 244
Working with the following obsids:
218211504 : jw02079-o004_s00574_niriss_f150w-gr150c
218211505 : jw02079-o004_s00754_niriss_f200w-gr150c
218211506 : jw02079-o004_s00615_niriss_f150w-gr150c
212419022 : jw02079-o004_s00862_niriss_f200w-gr150c
216640279 : jw02079-o004_s00774_niriss_f115w-gr150c
INFO: 14 of 47 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
          jw02079004001_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00021_asn.json
          jw02079004001_11101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00020_asn.json
          jw02079004001_11101_00002_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 47 rows

Batch #72 / 244
Working with the following obsids:
216640280 : jw02079-o004_s01024_niriss_f115w-gr150c
218211508 : jw02079-o004_s00456_niriss_f115w-gr150r
212419025 : jw02079-o004_s00710_niriss_f200w-gr150c
216640281 : jw02079-o004_s00583_niriss_f115w-gr150c
218211509 : jw02079-o004_s00752_niriss_f115w-gr150r
INFO: 38 of 83 products were duplicates. Only downloading 45 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
jw02079-o004_20241005t184831_spec2_00022_asn.json
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 83 rows

Batch #73 / 244
Working with the following obsids:
212419029 : jw02079-o004_s00861_niriss_f200w-gr150c
218211510 : jw02079-o004_s01075_niriss_f115w-gr150r
218211511 : jw02079-o004_s00446_niriss_f150w-gr150c
218211512 : jw02079-o004_s01080_niriss_f150w-gr150c
216640282 : jw02079-o004_s01388_niriss_f200w-gr150r
INFO: 7 of 47 products were duplicates. Only downloading 40 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00030_asn.json
          jw02079004001_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00024_asn.json
          jw02079004001_09101_00001_nis_rate.fits
                                              ...
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 47 rows

Batch #74 / 244
Working with the following obsids:
218211513 : jw02079-o004_s00144_niriss_f115w-gr150r
218211514 : jw02079-o004_s00834_niriss_f150w-gr150r
216640283 : jw02079-o004_s00949_niriss_f200w-gr150r
218211515 : jw02079-o004_s00648_niriss_f150w-gr150r
218211516 : jw02079-o004_s00899_niriss_f150w-gr150c
INFO: 7 of 47 products were duplicates. Only downloading 40 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00030_asn.json
          jw02079004001_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00024_asn.json
          jw02079004001_09101_00001_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 47 rows

Batch #75 / 244
Working with the following obsids:
218211517 : jw02079-o004_s00618_niriss_f150w-gr150c
218211518 : jw02079-o004_s00472_niriss_f150w-gr150r
212419037 : jw02079-o004_s01411_niriss_f115w-gr150c
216640284 : jw02079-o004_s01337_niriss_f115w-gr150c
218211519 : jw02079-o004_s01289_niriss_f115w-gr150r
INFO: 19 of 71 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
jw02079-o004_20241005t184831_spec2_00027_asn.json
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 71 rows

Batch #76 / 244
Working with the following obsids:
212419040 : jw02079-o004_s00684_niriss_f200w-gr150r
218211520 : jw02079-o004_s00835_niriss_f150w-gr150r
218211521 : jw02079-o004_s00993_niriss_f150w-gr150c
216640285 : jw02079-o004_s01064_niriss_f200w-gr150r
212419043 : jw02079-o004_s00725_niriss_f200w-gr150r
INFO: 14 of 35 products were duplicates. Only downloading 21 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00006_asn.json
jw02079-o004_20241005t184831_spec2_00006_asn.json
jw02079-o004_20241005t184831_spec2_00006_asn.json
          jw02079004003_03101_00001_nis_rate.fits
          jw02079004003_03101_00001_nis_rate.fits
          jw02079004003_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00005_asn.json
jw02079-o004_20241005t184831_spec2_00005_asn.json
jw02079-o004_20241005t184831_spec2_00005_asn.json
          jw02079004003_03101_00002_nis_rate.fits
                                              ...
          jw02079004002_11101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00012_asn.json
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 35 rows

Batch #77 / 244
Working with the following obsids:
192833055 : jw02079-o004_s00523_niriss_f200w-gr150r
218211522 : jw02079-o004_s00929_niriss_f150w-gr150r
218211523 : jw02079-o004_s01367_niriss_f200w-gr150c
218211524 : jw02079-o004_s00157_niriss_f150w-gr150c
218211525 : jw02079-o004_s00273_niriss_f150w-gr150c
INFO: 7 of 35 products were duplicates. Only downloading 28 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00001_asn.json
          jw02079004003_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00006_asn.json
          jw02079004003_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00002_asn.json
          jw02079004003_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00005_asn.json
          jw02079004003_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00004_asn.json
          jw02079004003_03101_00003_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 35 rows

Batch #78 / 244
Working with the following obsids:
218211526 : jw02079-o004_s00193_niriss_f150w-gr150c
216640286 : jw02079-o004_s00182_niriss_f200w-gr150r
216640287 : jw02079-o004_s00954_niriss_f200w-gr150r
218211527 : jw02079-o004_s01022_niriss_f150w-gr150r
216640288 : jw02079-o004_s00567_niriss_f115w-gr150c
INFO: 7 of 47 products were duplicates. Only downloading 40 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
          jw02079004001_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00021_asn.json
          jw02079004001_11101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00020_asn.json
          jw02079004001_11101_00002_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 47 rows

Batch #79 / 244
Working with the following obsids:
218211528 : jw02079-o004_s00268_niriss_f200w-gr150c
218211529 : jw02079-o004_s00214_niriss_f115w-gr150r
216640289 : jw02079-o004_s00173_niriss_f200w-gr150r
218211530 : jw02079-o004_s00381_niriss_f115w-gr150r
216640290 : jw02079-o004_s00268_niriss_f200w-gr150r
INFO: 26 of 59 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
jw02079-o004_20241005t184831_spec2_00029_asn.json
                                              ...
          jw02079004002_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 59 rows

Batch #80 / 244
Working with the following obsids:
216640291 : jw02079-o004_s00254_niriss_f115w-gr150c
218211531 : jw02079-o004_s00800_niriss_f115w-gr150r
212419058 : jw02079-o004_s00861_niriss_f200w-gr150r
218211532 : jw02079-o004_s00294_niriss_f200w-gr150c
218211533 : jw02079-o004_s00094_niriss_f115w-gr150r
INFO: 19 of 71 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
          jw02079004001_09101_00003_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 71 rows

Batch #81 / 244
Working with the following obsids:
216640292 : jw02079-o004_s01343_niriss_f115w-gr150c
218211534 : jw02079-o004_s00584_niriss_f150w-gr150c
218211535 : jw02079-o004_s00789_niriss_f200w-gr150c
218211536 : jw02079-o004_s00675_niriss_f150w-gr150c
216640293 : jw02079-o004_s00004_niriss_f115w-gr150c
INFO: 26 of 59 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
jw02079-o004_20241005t184831_spec2_00025_asn.json
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 59 rows

Batch #82 / 244
Working with the following obsids:
218211537 : jw02079-o004_s00583_niriss_f115w-gr150r
218211538 : jw02079-o004_s00444_niriss_f150w-gr150r
218211539 : jw02079-o004_s00782_niriss_f150w-gr150r
216640294 : jw02079-o004_s01310_niriss_f115w-gr150c
218211540 : jw02079-o004_s01300_niriss_f150w-gr150r
INFO: 14 of 59 products were duplicates. Only downloading 45 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 59 rows

Batch #83 / 244
Working with the following obsids:
212419075 : jw02079-o004_s00430_niriss_f150w-gr150c
216640295 : jw02079-o004_s00989_niriss_f200w-gr150r
218211542 : jw02079-o004_s00004_niriss_f115w-gr150r
212419080 : jw02079-o004_s01276_niriss_f150w-gr150r
216640296 : jw02079-o004_s00596_niriss_f200w-gr150r
INFO: 7 of 47 products were duplicates. Only downloading 40 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00030_asn.json
          jw02079004001_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00024_asn.json
          jw02079004001_09101_00001_nis_rate.fits
                                              ...
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 47 rows

Batch #84 / 244
Working with the following obsids:
218211543 : jw02079-o004_s01403_niriss_f200w-gr150c
218211544 : jw02079-o004_s00426_niriss_f150w-gr150r
218211545 : jw02079-o004_s00600_niriss_f115w-gr150r
216640297 : jw02079-o004_s00480_niriss_f200w-gr150r
218211546 : jw02079-o004_s00574_niriss_f150w-gr150r
INFO: 7 of 47 products were duplicates. Only downloading 40 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00030_asn.json
          jw02079004001_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00024_asn.json
          jw02079004001_09101_00001_nis_rate.fits
                                              ...
jw02079-o004_20241005t184831_spec2_00012_asn.json
          jw02079004002_09101_00001_nis_rate.fits
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 47 rows

Batch #85 / 244
Working with the following obsids:
216640298 : jw02079-o004_s00274_niriss_f200w-gr150r
218211547 : jw02079-o004_s00620_niriss_f200w-gr150c
218211549 : jw02079-o004_s00837_niriss_f150w-gr150c
216640299 : jw02079-o004_s00602_niriss_f115w-gr150c
218211550 : jw02079-o004_s00208_niriss_f200w-gr150c
INFO: 7 of 47 products were duplicates. Only downloading 40 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
          jw02079004001_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00021_asn.json
          jw02079004001_11101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00020_asn.json
          jw02079004001_11101_00002_nis_rate.fits
                                              ...
          jw02079004002_11101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 47 rows

Batch #86 / 244
Working with the following obsids:
212419089 : jw02079-o004_s00533_niriss_f200w-gr150r
218211551 : jw02079-o004_s00335_niriss_f200w-gr150c
218211552 : jw02079-o004_s01118_niriss_f150w-gr150c
218211553 : jw02079-o004_s01106_niriss_f200w-gr150c
216640300 : jw02079-o004_s01370_niriss_f200w-gr150r
INFO: 14 of 35 products were duplicates. Only downloading 21 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00001_asn.json
jw02079-o004_20241005t184831_spec2_00001_asn.json
          jw02079004003_05101_00003_nis_rate.fits
          jw02079004003_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00006_asn.json
jw02079-o004_20241005t184831_spec2_00006_asn.json
          jw02079004003_03101_00001_nis_rate.fits
          jw02079004003_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00002_asn.json
jw02079-o004_20241005t184831_spec2_00002_asn.json
                                              ...
          jw02079004002_11101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00007_asn.json
          jw02079004002_11101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 35 rows

Batch #87 / 244
Working with the following obsids:
212419102 : jw02079-o004_s00725_niriss_f200w-gr150c
218211554 : jw02079-o004_s00508_niriss_f150w-gr150c
216640301 : jw02079-o004_s01165_niriss_f115w-gr150c
218211555 : jw02079-o004_s00372_niriss_f115w-gr150r
216640302 : jw02079-o004_s00214_niriss_f115w-gr150c
INFO: 19 of 71 products were duplicates. Only downloading 52 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
jw02079-o004_20241005t184831_spec2_00027_asn.json
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 71 rows

Batch #88 / 244
Working with the following obsids:
216640303 : jw02079-o004_s01170_niriss_f115w-gr150c
218211556 : jw02079-o004_s00893_niriss_f150w-gr150c
218211557 : jw02079-o004_s00506_niriss_f200w-gr150c
216640304 : jw02079-o004_s00428_niriss_f200w-gr150r
216640305 : jw02079-o004_s00595_niriss_f200w-gr150r
INFO: 7 of 47 products were duplicates. Only downloading 40 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
          jw02079004001_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00021_asn.json
          jw02079004001_11101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00020_asn.json
          jw02079004001_11101_00002_nis_rate.fits
                                              ...
          jw02079004002_11101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00013_asn.json
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 47 rows

Batch #89 / 244
Working with the following obsids:
216640306 : jw02079-o004_s01247_niriss_f200w-gr150r
216640307 : jw02079-o004_s01352_niriss_f200w-gr150r
218211558 : jw02079-o004_s00899_niriss_f150w-gr150r
218211559 : jw02079-o004_s00419_niriss_f150w-gr150r
216640308 : jw02079-o004_s01138_niriss_f200w-gr150r
INFO: 21 of 35 products were duplicates. Only downloading 14 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00006_asn.json
jw02079-o004_20241005t184831_spec2_00006_asn.json
jw02079-o004_20241005t184831_spec2_00006_asn.json
          jw02079004003_03101_00001_nis_rate.fits
          jw02079004003_03101_00001_nis_rate.fits
          jw02079004003_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00005_asn.json
jw02079-o004_20241005t184831_spec2_00005_asn.json
jw02079-o004_20241005t184831_spec2_00005_asn.json
          jw02079004003_03101_00002_nis_rate.fits
                                              ...
          jw02079004002_09101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00012_asn.json
jw02079-o004_20241005t184831_spec2_00012_asn.json
          jw02079004002_09101_00001_nis_rate.fits
          jw02079004002_09101_00001_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
Length = 35 rows

Batch #90 / 244
Working with the following obsids:
218211560 : jw02079-o004_s00437_niriss_f115w-gr150r
218211561 : jw02079-o004_s00965_niriss_f150w-gr150c
216640309 : jw02079-o004_s00556_niriss_f115w-gr150c
218211562 : jw02079-o004_s00792_niriss_f150w-gr150r
218211563 : jw02079-o004_s00639_niriss_f200w-gr150c
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
Length = 59 rows

Batch #91 / 244
Working with the following obsids:
218211564 : jw02079-o004_s01153_niriss_f115w-gr150r
218211565 : jw02079-o004_s00785_niriss_f200w-gr150c
218211566 : jw02079-o004_s01362_niriss_f115w-gr150r
212419118 : jw02079-o004_s00674_niriss_f200w-gr150r
216640310 : jw02079-o004_s01259_niriss_f200w-gr150r
INFO: 26 of 59 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
jw02079-o004_20241005t184831_spec2_00029_asn.json
                                              ...
          jw02079004002_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 59 rows

Batch #92 / 244
Working with the following obsids:
218211567 : jw02079-o004_s00205_niriss_f150w-gr150r
218211568 : jw02079-o004_s01102_niriss_f150w-gr150c
218211569 : jw02079-o004_s00335_niriss_f150w-gr150c
218211570 : jw02079-o004_s00914_niriss_f200w-gr150c
218211571 : jw02079-o004_s00664_niriss_f115w-gr150r
INFO: 7 of 47 products were duplicates. Only downloading 40 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00001_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00002_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00003_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00022_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00023_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00024_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00028_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00029_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00030_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_09101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00028_asn.json
          jw02079004001_03101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00022_asn.json
          jw02079004001_09101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00029_asn.json
          jw02079004001_03101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00030_asn.json
          jw02079004001_03101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00024_asn.json
          jw02079004001_09101_00001_nis_rate.fits
                                              ...
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00017_asn.json
          jw02079004002_03101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00004_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00001_asn.json
jw02079-o004_20240704t000032_spec3_00006_asn.json
Length = 47 rows

Batch #93 / 244
Working with the following obsids:
212419122 : jw02079-o004_s00497_niriss_f115w-gr150c
218211573 : jw02079-o004_s00442_niriss_f150w-gr150c
216640311 : jw02079-o004_s00437_niriss_f115w-gr150c
216640312 : jw02079-o004_s00208_niriss_f200w-gr150r
218211574 : jw02079-o004_s00340_niriss_f150w-gr150c
INFO: 26 of 59 products were duplicates. Only downloading 33 unique product(s). [astroquery.mast.observations]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00020_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00021_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00025_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00026_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00027_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004001_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_05101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004002_11101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00001_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00002_nis_rate.fits with expected size 83943360. [astroquery.query]
INFO: Found cached file data/jw02079004003_03101_00003_nis_rate.fits with expected size 83943360. [astroquery.query]
Products downloaded:
                  productFilename                 
-------------------------------------------------
jw02079-o004_20241005t184831_spec2_00026_asn.json
jw02079-o004_20241005t184831_spec2_00026_asn.json
          jw02079004001_05101_00002_nis_rate.fits
          jw02079004001_05101_00002_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00027_asn.json
jw02079-o004_20241005t184831_spec2_00027_asn.json
          jw02079004001_05101_00001_nis_rate.fits
          jw02079004001_05101_00001_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00025_asn.json
jw02079-o004_20241005t184831_spec2_00025_asn.json
                                              ...
          jw02079004002_05101_00003_nis_rate.fits
jw02079-o004_20241005t184831_spec2_00008_asn.json
jw02079-o004_20241005t184831_spec2_00008_asn.json
          jw02079004002_11101_00002_nis_rate.fits
          jw02079004002_11101_00002_nis_rate.fits
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00005_asn.json
jw02079-o004_20240704t000032_spec3_00002_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
jw02079-o004_20240704t000032_spec3_00003_asn.json
Length = 59 rows

Batch #94 / 244
Working with the following obsids:
216640313 : jw02079-o004_s00375_niriss_f200w-gr150r
218211575 : jw02079-o004_s00782_niriss_f150w-gr150c
216640314 : jw02079-o004_s01043_niriss_f115w-gr150c
218211576 : jw02079-o004_s00504_niriss_f150w-gr150r
218211578 : jw02079-o004_s00209_niriss_f115w-gr150r
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00004_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00005_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00006_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00007_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00008_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00009_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00010_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00011_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00012_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00013_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00014_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00015_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00016_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00017_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00018_asn.json with expected size 2051. [astroquery.query]
INFO: Found cached file data/jw02079-o004_20241005t184831_spec2_00019_asn.json with expected size 2051. [astroquery.query]
INF