Combining COS Data from Multiple Lifetime Positions and Central Wavelengths#
In this notebook, we will explore the implications of combining COS data taken at different lifetime positions and central wavelengths.#
Learning Goals:#
In this tutorial, you will learn
How the COS line-spread functions (LSFs) vary with central wavelength and lifetime position
How to smooth one COS spectrum to the resolution of another – and the limits of this approach
How to construct a bespoke line-spread function appropriate for particular combination of spectra
Table of Contents#
0. Introduction
1. Download the COS Line-Spread Functions
2. Define Functions for Later Use
3. Compare LSFs from Various Lifetime Positions and CENWAVEs
- 3.1 LSFs from Various Central Wavelenths
- 3.2 LSFs from Various Lifetime Positions
4. Techniques for Combining Spectra with Different LSFs
- 4.1 Retrieve and Combine the Spectra
- 4.2 Fit each combination of grating, LSF, and CENWAVE separately
- 4.3 Convolve the LP1 Spectrum to Match LP4
- 4.4 Construct a bespoke LSF for this spectral combination
0. Introduction#
The Hubble Advanced Spectral Products (HASP) program provides co-added spectra within individual observing programs that use the Space Telescope Imaging Spectrograph (STIS) and the Cosmic Origins Spectrograph (COS) instruments onboard the Hubble Space Telescope (HST). The Hubble Spectroscopic Legacy Archive (HSLA), goes one step farther, combining data from multiple instruments and observing programs to create spectra with the highest possible signal-to-noise and wavelength range.
When analyzing any scientific measurement, it is important to consider all of the instrumental effects to which your data are subject. In the case of imaging, point sources in the sky are broadened by the telescope and instrument optics. In the case of spectroscopy, narrow absorption lines are broadened by the line-spread function (LSF; the shape imposed on an infinitely narrow line by the optics) of the spectrograph. In most cases, the LSF of a spectrograph can be approximated by a Gaussian of known FHWM. For COS, the LSF is not a Gaussian; it has more power in the wings than a Gaussian of the same FWHM. Ignoring this effect could lead one to under-estimate the flux in an emission line or the equivalent width of an absorption feature. The COS LSF is described in Section 3.3.1 of the COS Instrument Handbook.
A second effect comes into play with both HASP and HSLA: the LSFs of spectra taken in the blue modes (CENWAVES 1055, 1096, and 1222) are considerably broader than those of spectra with CENWAVE 1291 and higher. For full wavelength coverage, observers are instructed to use both CENWAVE 1222 and CENWAVE 1291. But in the region where the resulting spectra overlap (from about 1100 to 1350 A), both HASP and HSLA simply co-add the two spectra, resulting in a hybrid LSF that complicates the analysis.
A third effect: Because the COS detector is susceptible to gain sag, the instrument is adjusted at regular intervals so that spectra fall on previously unilluminated regions of the detector, called lifetime positions (LPs). Spectra taken at LP1 have the highest spectral resolution, while spectra taken at other LPs have successively lower resolution. The final product of the HSLA, a spectrum made by co-adding data from multiple observing programs, may contain data taken at multiple LPs, again resulting in a hybrid LSF. These effects are illustrated in Figure 3.7 of the COS Instrument Handbook.
In this notebook, we will compare the COS LSFs from multiple CENWAVEs and lifetime positions to better understand these effects. Then we will consider three ways to deal with them. The first is not to use the final HASP and HSLA products at all, but to create products that contain data from a single grating, LP, and CENWAVE and fit them separately. The second is to combine these single-configuration products into a co-added spectrum, first smoothing the higher-resolution spectra to the resolution of the lowest-resolution spectrum. The third approach is to use the HASP/HSLA final products, but to scale and combine the relevant LSFs to match your data.
By the way, the G130M and G160M gratings have different LSFs in the region of overlap, so everything in this notebook applies to the case of multiple gratings. The difference is that neither HASP nor HSLA co-adds data from different instruments or gratings, so the final data products are immune to this effect.
Imports#
We will be using multiple libraries to retrieve and analyze data:
astropy.units
to assign units to various quantitiesastropy.convolution.convolve
to convolve functions with a Gaussianastropy.io.ascii
andfits
to work with ASCII and FITS filesastropy.visualization.quantity_support
to put units on our plotsastroquery.mast.Observations
to retrieve COS spectra from MASTglob
to work with multiple files in our directoriesmatplotlib.pyplot
to plot spectranumpy
to calculate various valuesos
to interact with the operating systempathlib.Path
to create a data directoryscipy.optimize.curve_fit
to fit a function to a spectrumshutil
to perform directory and file operationsspecutils.Spectrum1d
to create Spectrum1d objects
We recommend creating a HASP-specific conda
environment. You can check out our Setup.ipynb notebook to create such an environment.
Let’s import all of the packages that we will use in this notebook by running the next cell:
%matplotlib inline
import glob
import matplotlib
import numpy as np
import os
import shutil
import urllib
from astropy.convolution import convolve
from astropy.io import ascii, fits
from astropy.visualization import quantity_support
from astroquery.mast import Observations
from matplotlib import pyplot as plt
from pathlib import Path
from scipy.optimize import curve_fit
# Specify plot parameters.
quantity_support() # to put units on the axes below
matplotlib.rcParams['figure.figsize'] = [15, 5]
1. Download the COS Line-Spread Functions#
From the COS homepage, you can find all the COS Line Spread Functions. They are all located in tables containing the various LSFs entitled “Tabulated Theoretical Line Spread Functions” for each individual lifetime position. We will use Python to create a directory to store the LSFs we need, and then download the following LSF files:
The LSFs for grating G130M across all lifetime positions (1-5) for central wavelength 1291
The LSFs for grating G130M for LP2 and central wavelengths 1055, 1096, 1222, and 1327
The LSF for G130M for LP4 and central wavelength 1309
# Define the LSF directory to hold the files.
lsf_dir = Path("./LSF/")
# If the directory doesn't exist, then create it.
lsf_dir.mkdir(exist_ok=True)
# Create a function that downloads the LSF files we need based on grating, lifetime position, and cenwave.
def fetch_files(grating, lpPos, cenwave):
# Link to where all the files live
COS_site_rootname = (
"https://www.stsci.edu/files/live/sites/www/files/home/hst/instrumentation/cos/"
"performance/spectral-resolution/_documents/")
LSF_file_name = f"aa_LSFTable_{grating}_{cenwave}_LP{lpPos}_cn.dat"
LSF_file_webpath = COS_site_rootname + LSF_file_name # Where to find file online
urllib.request.urlretrieve(
LSF_file_webpath, str(lsf_dir / LSF_file_name)
) # Where to save file to locally
# Use this function to download the LSF files
# LSFs for grating G130M and central wavelength 1291, across all lifetime positions (1-5)
fetch_files('G130M', '1', '1291')
fetch_files('G130M', '2', '1291')
fetch_files('G130M', '3', '1291')
fetch_files('G130M', '4', '1291')
fetch_files('G130M', '5', '1291')
# LSFs for G130M LP2 central wavelengths 1055, 1096, 1222, and 1327
fetch_files('G130M', '2', '1055')
fetch_files('G130M', '2', '1096')
fetch_files('G130M', '2', '1222')
fetch_files('G130M', '2', '1327')
# LSFs for G130M LP1/LP4 central wavelength 1309
fetch_files('G130M', '1', '1309')
fetch_files('G130M', '4', '1309')
2. Define Functions for Later Use#
Here we define a handful of functions that we will use later.
# Function to compute emperical FWHM of a LSF
def get_fwhm(x, y):
xprime = np.arange(x.size * 10.) / 10.
yprime = np.interp(xprime, x, y)
center = np.argmax(yprime)
half = np.max(y) / 2.
diff = abs(yprime - half)
x1 = np.argmin(diff[:center])
x2 = np.argmin(diff[center:]) + center
return (x2 - x1)/10
# Function to compute a Gaussian given the value of sigma
def get_gaussian(sigma):
length = int(8 * sigma)
# Kernel length must be odd.
if (length % 2 == 0):
length += 1
xx = np.arange(length)
mu = int(length / 2)
x = (xx - mu)/sigma
return np.exp(-0.5 * x**2)
# Function to read an LSF file
def get_lsf(filename, wave):
table = ascii.read(filename, format='basic')
lsf = table[str(wave)]
x = np.arange(lsf.size)
fwhm = get_fwhm(x, lsf)
d130 = 0.01
resolution = wave / fwhm / d130
return lsf, resolution, fwhm
# Define an LSF object, which we will use when convolving an LSF with a Gaussian.
class LSF(object):
def __init__(self):
self.lsf = []
def add_lsf(self, wave, lsf):
self.wave = wave
self.lsf = lsf
def my_func(self, data_wave, sigma):
"""
This function convolves a line-spread function with a Gaussian of a given width (sigma).
"""
gauss = get_gaussian(sigma) # Compute Gaussian in LP1 pixels.
a = convolve(self.lsf, gauss) # Convolve LP1 LSF with Gaussian.
return a/np.sum(a) # Normalize new LSF.
3. Compare LSFs from Various Lifetime Positions and CENWAVEs#
3.1 LSFs from Various Central Wavelenths#
First, let’s see how much the LSF changes from one CENWAVE to another. We’ll start at 1200 A, then move to 1350 A.
# Read LSF file for G130M, LP2, cenwave = 1222, lambda = 1194
lsf_1055, res_1055, fwhm_1055 = get_lsf('LSF/aa_LSFTable_G130M_1055_LP2_cn.dat', 1194)
# Read LSF file for G130M, LP2, cenwave = 1222, lambda = 1195
lsf_1096, res_1096, fwhm_1096 = get_lsf('LSF/aa_LSFTable_G130M_1096_LP2_cn.dat', 1195)
# Read LSF file for G130M, LP2, cenwave = 1222, lambda = 1197
lsf_1222, res_1222, fwhm_1222 = get_lsf('LSF/aa_LSFTable_G130M_1222_LP2_cn.dat', 1197)
# Read LSF file for G130M, LP2, cenwave = 1291, lambda = 1194
lsf_1291, res_1291, fwhm_1291 = get_lsf('LSF/aa_LSFTable_G130M_1291_LP2_cn.dat', 1194)
# Read LSF files for G130M, LP2, cenwave = 1327, lambda = 1197
lsf_1327, res_1327, fwhm_1327 = get_lsf('LSF/aa_LSFTable_G130M_1327_LP2_cn.dat', 1197)
x = np.arange(lsf_1291.size)
print('CENWAVE Res FWHM (pix) ')
print('1055 ', int(res_1055), fwhm_1055)
print('1096 ', int(res_1096), fwhm_1096)
print('1222 ', int(res_1222), fwhm_1222)
print('1291 ', int(res_1291), fwhm_1291)
print('1327 ', int(res_1327), fwhm_1327)
f, ax = plt.subplots()
plt.plot(x, lsf_1055, label='1055')
plt.plot(x, lsf_1096, label='1096')
plt.plot(x, lsf_1222, label='1222')
plt.plot(x, lsf_1291, label='1291')
plt.plot(x, lsf_1327, label='1327')
plt.title('COS LSFs at 1200 Angstroms')
ax.legend()
ax.set_xlim([120, 200])
CENWAVE Res FWHM (pix)
1055 2524 47.3
1096 4092 29.2
1222 14082 8.5
1291 14385 8.3
1327 14421 8.3
(120.0, 200.0)

1200 A represents the red end of the CENWAVE 1055 and 1096 spectra. In this region, their LSFs are completely different from those of the bluer modes. This matters because HASP and HSLA co-add spectra with all available CENWAVEs. At wavelengths where the LSFs differ, spectral lines in the combined spectra could have unexpected shapes.
# Read LSF file for G130M, LP2, cenwave = 1222, lambda = 1352
lsf_1222, res_1222, fwhm_1222 = get_lsf('LSF/aa_LSFTable_G130M_1222_LP2_cn.dat', 1352)
# Read LSF file for G130M, LP2, cenwave = 1291, lambda = 1350
lsf_1291, res_1291, fwhm_1291 = get_lsf('LSF/aa_LSFTable_G130M_1291_LP2_cn.dat', 1350)
# Read LSF files for G130M, LP2, cenwave = 1327, lambda = 1351
lsf_1327, res_1327, fwhm_1327 = get_lsf('LSF/aa_LSFTable_G130M_1327_LP2_cn.dat', 1351)
x = np.arange(lsf_1291.size)
print('CENWAVE Res FWHM (pix) ')
print('1222 ', int(res_1222), fwhm_1222)
print('1291 ', int(res_1291), fwhm_1291)
print('1327 ', int(res_1327), fwhm_1327)
f, ax = plt.subplots()
plt.plot(x, lsf_1222, label='1222')
plt.plot(x, lsf_1291, label='1291')
plt.plot(x, lsf_1327, label='1327')
plt.title('COS LSFs at 1350 Angstroms')
ax.legend()
ax.set_xlim([140, 180])
CENWAVE Res FWHM (pix)
1222 9013 15.0
1291 17532 7.7
1327 17320 7.8
(140.0, 180.0)

At 1350 A, we are at the red end of the CENWAVE 1222 spectrum. Again, its LSF is much broader than those of the redder CENWAVEs. If you need the highest possible spectral resolution, then you don’t want to co-add spectra taken in the blue modes (CENWAVE 1055, 1096, or 1222) with those taken in the standard modes (CENWAVE >= 1291).
Which CENWAVEs contribute to the final HASP/HSLA spectrum? Information about the CENWAVE is lost early in HASP processing. It is not included in the HSLA metadata files. The metadata files do list the minimum wavelength contributed by each grating/LP combination; values smaller than 1400 A indicate that at least one of the input spectra has CENWAVE <= 1222.
3.2 LSFs from Various Lifetime Positions#
The COS LSF varies with lifetime position as well as with CENWAVE. To explore this effect, we read the LSFs for lifetime positions 1 through 5, compute their resolution and FWHM, and plot them.
# Read LSF files for G130M, cenwave = 1291, lambda = 1300
lsf_lp1, res_lp1, fwhm_lp1 = get_lsf('LSF/aa_LSFTable_G130M_1291_LP1_cn.dat', 1300)
lsf_lp2, res_lp2, fwhm_lp2 = get_lsf('LSF/aa_LSFTable_G130M_1291_LP2_cn.dat', 1300)
lsf_lp3, res_lp3, fwhm_lp3 = get_lsf('LSF/aa_LSFTable_G130M_1291_LP3_cn.dat', 1300)
lsf_lp4, res_lp4, fwhm_lp4 = get_lsf('LSF/aa_LSFTable_G130M_1291_LP4_cn.dat', 1300)
lsf_lp5, res_lp5, fwhm_lp5 = get_lsf('LSF/aa_LSFTable_G130M_1291_LP5_cn.dat', 1300)
print('LP Res FWHM (pixels)')
print('1 ', int(res_lp1), fwhm_lp1)
print('2 ', int(res_lp2), fwhm_lp2)
print('3 ', int(res_lp3), fwhm_lp3)
print('4 ', int(res_lp4), fwhm_lp4)
print('5 ', int(res_lp5), fwhm_lp5)
f, ax = plt.subplots()
x = np.arange(lsf_lp1.size)
plt.plot(x, lsf_lp1, label='LP1')
plt.plot(x, lsf_lp2, label='LP2')
plt.plot(x, lsf_lp3, label='LP3')
plt.plot(x, lsf_lp4, label='LP4')
plt.plot(x, lsf_lp5, label='LP5')
plt.title('COS LSFs at 1300 Angstroms')
ax.legend()
ax.set_xlim([140, 180])
LP Res FWHM (pixels)
1 19117 6.8
2 16666 7.8
3 16883 7.7
4 14772 8.8
5 15476 8.4
(140.0, 180.0)

We see that there are three families of LSF curves, corresponding to their distance from LP1. LP1 itself has the highest resolution. LP2 and LP3, which lie immediately above and below LP1 on the COS detector, have slightly lower resolution. LP4 and LP5, which are still farther from LP1, have the lowest resolution.
While the peaks of these curves shift to the left with increasing LP number, all five have the same mean value. This is because, as the curves broaden, more of the flux moves into the wings on the right-hand side of the distribution.
If your science requires that you understand the subtleties of the instrumental line-spread function, then you should proceed carefully when combining data taken at multiple lifetime positions. We consider two techniques for doing this below.
4. Techniques for Combining Spectra with Different LSFs#
4.1 Retrieve and Combine the Spectra#
The star WD0308-565 (WG 7) is a calibration standard. Let’s use spectra taken at two lifetime positions. For maximum contrast, we will use LP1 and LP4.
We begin by setting up our directory structure and querying the MAST database for all COS spectra of the star. This will give us a list of all observations for the program.
# Define the data-download directory.
cos_data_dir = Path("./cos_data/")
# Define the products directory to hold the output.
cos_products_dir = Path("./cos_products/")
# If the directories doesn't exist, then create them.
cos_data_dir.mkdir(exist_ok=True)
cos_products_dir.mkdir(exist_ok=True)
# Conduct the query
wg7_products = Observations.get_product_list(
Observations.query_criteria(
instrument_name='COS',
target_name='WD*0308-565',
dataproduct_type="SPECTRUM"
)
)
This query returns all available data, but we want only the x1d files of spectra taken with the G130M grating. (This takes a few minutes, so be patient.)
Observations.download_products(
wg7_products,
download_dir=str(cos_data_dir),
filters='G130M',
productSubGroupDescription=["X1D"]
)
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02a2q_x1d.fits to cos_data/mastDownload/HST/lbnm02a2q/lbnm02a2q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02a4q_x1d.fits to cos_data/mastDownload/HST/lbnm02a4q/lbnm02a4q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02a6q_x1d.fits to cos_data/mastDownload/HST/lbnm02a6q/lbnm02a6q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02arq_x1d.fits to cos_data/mastDownload/HST/lbnm02arq/lbnm02arq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02auq_x1d.fits to cos_data/mastDownload/HST/lbnm02auq/lbnm02auq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02awq_x1d.fits to cos_data/mastDownload/HST/lbnm02awq/lbnm02awq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02ayq_x1d.fits to cos_data/mastDownload/HST/lbnm02ayq/lbnm02ayq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02b0q_x1d.fits to cos_data/mastDownload/HST/lbnm02b0q/lbnm02b0q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02b2q_x1d.fits to cos_data/mastDownload/HST/lbnm02b2q/lbnm02b2q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02b4q_x1d.fits to cos_data/mastDownload/HST/lbnm02b4q/lbnm02b4q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02b6q_x1d.fits to cos_data/mastDownload/HST/lbnm02b6q/lbnm02b6q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02b8q_x1d.fits to cos_data/mastDownload/HST/lbnm02b8q/lbnm02b8q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02baq_x1d.fits to cos_data/mastDownload/HST/lbnm02baq/lbnm02baq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02bcq_x1d.fits to cos_data/mastDownload/HST/lbnm02bcq/lbnm02bcq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02zmq_x1d.fits to cos_data/mastDownload/HST/lbnm02zmq/lbnm02zmq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02zsq_x1d.fits to cos_data/mastDownload/HST/lbnm02zsq/lbnm02zsq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02zvq_x1d.fits to cos_data/mastDownload/HST/lbnm02zvq/lbnm02zvq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02zxq_x1d.fits to cos_data/mastDownload/HST/lbnm02zxq/lbnm02zxq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbnm02zzq_x1d.fits to cos_data/mastDownload/HST/lbnm02zzq/lbnm02zzq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbui50qnq_x1d.fits to cos_data/mastDownload/HST/lbui50qnq/lbui50qnq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbui50qpq_x1d.fits to cos_data/mastDownload/HST/lbui50qpq/lbui50qpq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbui50qrq_x1d.fits to cos_data/mastDownload/HST/lbui50qrq/lbui50qrq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbui50qtq_x1d.fits to cos_data/mastDownload/HST/lbui50qtq/lbui50qtq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1aq6q_x1d.fits to cos_data/mastDownload/HST/lbxm1aq6q/lbxm1aq6q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1aqdq_x1d.fits to cos_data/mastDownload/HST/lbxm1aqdq/lbxm1aqdq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1aqfq_x1d.fits to cos_data/mastDownload/HST/lbxm1aqfq/lbxm1aqfq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1aqpq_x1d.fits to cos_data/mastDownload/HST/lbxm1aqpq/lbxm1aqpq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1aqrq_x1d.fits to cos_data/mastDownload/HST/lbxm1aqrq/lbxm1aqrq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1aqtq_x1d.fits to cos_data/mastDownload/HST/lbxm1aqtq/lbxm1aqtq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1aqvq_x1d.fits to cos_data/mastDownload/HST/lbxm1aqvq/lbxm1aqvq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1ar4q_x1d.fits to cos_data/mastDownload/HST/lbxm1ar4q/lbxm1ar4q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1ar6q_x1d.fits to cos_data/mastDownload/HST/lbxm1ar6q/lbxm1ar6q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1ar8q_x1d.fits to cos_data/mastDownload/HST/lbxm1ar8q/lbxm1ar8q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1araq_x1d.fits to cos_data/mastDownload/HST/lbxm1araq/lbxm1araq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1arcq_x1d.fits to cos_data/mastDownload/HST/lbxm1arcq/lbxm1arcq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1areq_x1d.fits to cos_data/mastDownload/HST/lbxm1areq/lbxm1areq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1argq_x1d.fits to cos_data/mastDownload/HST/lbxm1argq/lbxm1argq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1ariq_x1d.fits to cos_data/mastDownload/HST/lbxm1ariq/lbxm1ariq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1arkq_x1d.fits to cos_data/mastDownload/HST/lbxm1arkq/lbxm1arkq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1burq_x1d.fits to cos_data/mastDownload/HST/lbxm1burq/lbxm1burq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1bv3q_x1d.fits to cos_data/mastDownload/HST/lbxm1bv3q/lbxm1bv3q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1bv7q_x1d.fits to cos_data/mastDownload/HST/lbxm1bv7q/lbxm1bv7q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1bv9q_x1d.fits to cos_data/mastDownload/HST/lbxm1bv9q/lbxm1bv9q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1bvbq_x1d.fits to cos_data/mastDownload/HST/lbxm1bvbq/lbxm1bvbq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1bviq_x1d.fits to cos_data/mastDownload/HST/lbxm1bviq/lbxm1bviq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1bvkq_x1d.fits to cos_data/mastDownload/HST/lbxm1bvkq/lbxm1bvkq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lbxm1bvmq_x1d.fits to cos_data/mastDownload/HST/lbxm1bvmq/lbxm1bvmq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y30djq_x1d.fits to cos_data/mastDownload/HST/lc3y30djq/lc3y30djq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y30dlq_x1d.fits to cos_data/mastDownload/HST/lc3y30dlq/lc3y30dlq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y30dnq_x1d.fits to cos_data/mastDownload/HST/lc3y30dnq/lc3y30dnq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y31fnq_x1d.fits to cos_data/mastDownload/HST/lc3y31fnq/lc3y31fnq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y31fpq_x1d.fits to cos_data/mastDownload/HST/lc3y31fpq/lc3y31fpq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y31frq_x1d.fits to cos_data/mastDownload/HST/lc3y31frq/lc3y31frq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y32e7q_x1d.fits to cos_data/mastDownload/HST/lc3y32e7q/lc3y32e7q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y32e9q_x1d.fits to cos_data/mastDownload/HST/lc3y32e9q/lc3y32e9q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y32ebq_x1d.fits to cos_data/mastDownload/HST/lc3y32ebq/lc3y32ebq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y33e7q_x1d.fits to cos_data/mastDownload/HST/lc3y33e7q/lc3y33e7q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y33e9q_x1d.fits to cos_data/mastDownload/HST/lc3y33e9q/lc3y33e9q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y33ecq_x1d.fits to cos_data/mastDownload/HST/lc3y33ecq/lc3y33ecq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y34xxq_x1d.fits to cos_data/mastDownload/HST/lc3y34xxq/lc3y34xxq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y34xzq_x1d.fits to cos_data/mastDownload/HST/lc3y34xzq/lc3y34xzq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y34y1q_x1d.fits to cos_data/mastDownload/HST/lc3y34y1q/lc3y34y1q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y35l5q_x1d.fits to cos_data/mastDownload/HST/lc3y35l5q/lc3y35l5q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y35l7q_x1d.fits to cos_data/mastDownload/HST/lc3y35l7q/lc3y35l7q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y35l9q_x1d.fits to cos_data/mastDownload/HST/lc3y35l9q/lc3y35l9q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y36qqq_x1d.fits to cos_data/mastDownload/HST/lc3y36qqq/lc3y36qqq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y36qsq_x1d.fits to cos_data/mastDownload/HST/lc3y36qsq/lc3y36qsq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y36qvq_x1d.fits to cos_data/mastDownload/HST/lc3y36qvq/lc3y36qvq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y37loq_x1d.fits to cos_data/mastDownload/HST/lc3y37loq/lc3y37loq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y37lqq_x1d.fits to cos_data/mastDownload/HST/lc3y37lqq/lc3y37lqq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y37ltq_x1d.fits to cos_data/mastDownload/HST/lc3y37ltq/lc3y37ltq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y38qtq_x1d.fits to cos_data/mastDownload/HST/lc3y38qtq/lc3y38qtq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y38qvq_x1d.fits to cos_data/mastDownload/HST/lc3y38qvq/lc3y38qvq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y38qxq_x1d.fits to cos_data/mastDownload/HST/lc3y38qxq/lc3y38qxq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y39d8q_x1d.fits to cos_data/mastDownload/HST/lc3y39d8q/lc3y39d8q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y39daq_x1d.fits to cos_data/mastDownload/HST/lc3y39daq/lc3y39daq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y39dcq_x1d.fits to cos_data/mastDownload/HST/lc3y39dcq/lc3y39dcq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y40vuq_x1d.fits to cos_data/mastDownload/HST/lc3y40vuq/lc3y40vuq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y40vwq_x1d.fits to cos_data/mastDownload/HST/lc3y40vwq/lc3y40vwq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc3y40vyq_x1d.fits to cos_data/mastDownload/HST/lc3y40vyq/lc3y40vyq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc9201w1q_x1d.fits to cos_data/mastDownload/HST/lc9201w1q/lc9201w1q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc9201w3q_x1d.fits to cos_data/mastDownload/HST/lc9201w3q/lc9201w3q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc9201w5q_x1d.fits to cos_data/mastDownload/HST/lc9201w5q/lc9201w5q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc9201w7q_x1d.fits to cos_data/mastDownload/HST/lc9201w7q/lc9201w7q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc9202c0q_x1d.fits to cos_data/mastDownload/HST/lc9202c0q/lc9202c0q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc9202c4q_x1d.fits to cos_data/mastDownload/HST/lc9202c4q/lc9202c4q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc9202c6q_x1d.fits to cos_data/mastDownload/HST/lc9202c6q/lc9202c6q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lc9202c8q_x1d.fits to cos_data/mastDownload/HST/lc9202c8q/lc9202c8q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcaoe1ohq_x1d.fits to cos_data/mastDownload/HST/lcaoe1ohq/lcaoe1ohq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcaoe1ojq_x1d.fits to cos_data/mastDownload/HST/lcaoe1ojq/lcaoe1ojq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcaoe1olq_x1d.fits to cos_data/mastDownload/HST/lcaoe1olq/lcaoe1olq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcaoe1onq_x1d.fits to cos_data/mastDownload/HST/lcaoe1onq/lcaoe1onq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcaoe1p4q_x1d.fits to cos_data/mastDownload/HST/lcaoe1p4q/lcaoe1p4q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcaoe1p6q_x1d.fits to cos_data/mastDownload/HST/lcaoe1p6q/lcaoe1p6q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcaoe1p8q_x1d.fits to cos_data/mastDownload/HST/lcaoe1p8q/lcaoe1p8q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcaoe1paq_x1d.fits to cos_data/mastDownload/HST/lcaoe1paq/lcaoe1paq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce801kzq_x1d.fits to cos_data/mastDownload/HST/lce801kzq/lce801kzq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce802maq_x1d.fits to cos_data/mastDownload/HST/lce802maq/lce802maq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce802mcq_x1d.fits to cos_data/mastDownload/HST/lce802mcq/lce802mcq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce802meq_x1d.fits to cos_data/mastDownload/HST/lce802meq/lce802meq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce802mgq_x1d.fits to cos_data/mastDownload/HST/lce802mgq/lce802mgq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce803chq_x1d.fits to cos_data/mastDownload/HST/lce803chq/lce803chq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce804h8q_x1d.fits to cos_data/mastDownload/HST/lce804h8q/lce804h8q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce804haq_x1d.fits to cos_data/mastDownload/HST/lce804haq/lce804haq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce804hcq_x1d.fits to cos_data/mastDownload/HST/lce804hcq/lce804hcq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce804heq_x1d.fits to cos_data/mastDownload/HST/lce804heq/lce804heq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce805auq_x1d.fits to cos_data/mastDownload/HST/lce805auq/lce805auq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce806g6q_x1d.fits to cos_data/mastDownload/HST/lce806g6q/lce806g6q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce806g8q_x1d.fits to cos_data/mastDownload/HST/lce806g8q/lce806g8q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce806gaq_x1d.fits to cos_data/mastDownload/HST/lce806gaq/lce806gaq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce806gdq_x1d.fits to cos_data/mastDownload/HST/lce806gdq/lce806gdq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce807i0q_x1d.fits to cos_data/mastDownload/HST/lce807i0q/lce807i0q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce808yaq_x1d.fits to cos_data/mastDownload/HST/lce808yaq/lce808yaq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce808ycq_x1d.fits to cos_data/mastDownload/HST/lce808ycq/lce808ycq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce808yeq_x1d.fits to cos_data/mastDownload/HST/lce808yeq/lce808yeq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce808ygq_x1d.fits to cos_data/mastDownload/HST/lce808ygq/lce808ygq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce809riq_x1d.fits to cos_data/mastDownload/HST/lce809riq/lce809riq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce810e7q_x1d.fits to cos_data/mastDownload/HST/lce810e7q/lce810e7q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce810e9q_x1d.fits to cos_data/mastDownload/HST/lce810e9q/lce810e9q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce810ebq_x1d.fits to cos_data/mastDownload/HST/lce810ebq/lce810ebq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lce810edq_x1d.fits to cos_data/mastDownload/HST/lce810edq/lce810edq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb01hrs_x1d.fits to cos_data/mastDownload/HST/lcpb01hrs/lcpb01hrs_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb01hts_x1d.fits to cos_data/mastDownload/HST/lcpb01hts/lcpb01hts_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb01hvs_x1d.fits to cos_data/mastDownload/HST/lcpb01hvs/lcpb01hvs_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb01hxs_x1d.fits to cos_data/mastDownload/HST/lcpb01hxs/lcpb01hxs_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb01hzs_x1d.fits to cos_data/mastDownload/HST/lcpb01hzs/lcpb01hzs_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb01i1s_x1d.fits to cos_data/mastDownload/HST/lcpb01i1s/lcpb01i1s_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb01i3s_x1d.fits to cos_data/mastDownload/HST/lcpb01i3s/lcpb01i3s_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb01i5s_x1d.fits to cos_data/mastDownload/HST/lcpb01i5s/lcpb01i5s_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb01i7s_x1d.fits to cos_data/mastDownload/HST/lcpb01i7s/lcpb01i7s_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb01i9s_x1d.fits to cos_data/mastDownload/HST/lcpb01i9s/lcpb01i9s_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb01ibs_x1d.fits to cos_data/mastDownload/HST/lcpb01ibs/lcpb01ibs_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb01ids_x1d.fits to cos_data/mastDownload/HST/lcpb01ids/lcpb01ids_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb01ifs_x1d.fits to cos_data/mastDownload/HST/lcpb01ifs/lcpb01ifs_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb01ihs_x1d.fits to cos_data/mastDownload/HST/lcpb01ihs/lcpb01ihs_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb01ijs_x1d.fits to cos_data/mastDownload/HST/lcpb01ijs/lcpb01ijs_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb01ils_x1d.fits to cos_data/mastDownload/HST/lcpb01ils/lcpb01ils_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb02ecq_x1d.fits to cos_data/mastDownload/HST/lcpb02ecq/lcpb02ecq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb02eeq_x1d.fits to cos_data/mastDownload/HST/lcpb02eeq/lcpb02eeq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb02egq_x1d.fits to cos_data/mastDownload/HST/lcpb02egq/lcpb02egq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb02eiq_x1d.fits to cos_data/mastDownload/HST/lcpb02eiq/lcpb02eiq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb02ekq_x1d.fits to cos_data/mastDownload/HST/lcpb02ekq/lcpb02ekq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb02emq_x1d.fits to cos_data/mastDownload/HST/lcpb02emq/lcpb02emq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb02eoq_x1d.fits to cos_data/mastDownload/HST/lcpb02eoq/lcpb02eoq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcpb02eqq_x1d.fits to cos_data/mastDownload/HST/lcpb02eqq/lcpb02eqq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz01phq_x1d.fits to cos_data/mastDownload/HST/lcqz01phq/lcqz01phq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz01pjq_x1d.fits to cos_data/mastDownload/HST/lcqz01pjq/lcqz01pjq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz01pmq_x1d.fits to cos_data/mastDownload/HST/lcqz01pmq/lcqz01pmq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz01pvq_x1d.fits to cos_data/mastDownload/HST/lcqz01pvq/lcqz01pvq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz02r5q_x1d.fits to cos_data/mastDownload/HST/lcqz02r5q/lcqz02r5q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz03ogq_x1d.fits to cos_data/mastDownload/HST/lcqz03ogq/lcqz03ogq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz03oiq_x1d.fits to cos_data/mastDownload/HST/lcqz03oiq/lcqz03oiq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz03okq_x1d.fits to cos_data/mastDownload/HST/lcqz03okq/lcqz03okq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz03omq_x1d.fits to cos_data/mastDownload/HST/lcqz03omq/lcqz03omq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz04h8q_x1d.fits to cos_data/mastDownload/HST/lcqz04h8q/lcqz04h8q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz04haq_x1d.fits to cos_data/mastDownload/HST/lcqz04haq/lcqz04haq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz04hcq_x1d.fits to cos_data/mastDownload/HST/lcqz04hcq/lcqz04hcq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz04heq_x1d.fits to cos_data/mastDownload/HST/lcqz04heq/lcqz04heq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz05eaq_x1d.fits to cos_data/mastDownload/HST/lcqz05eaq/lcqz05eaq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz06vsq_x1d.fits to cos_data/mastDownload/HST/lcqz06vsq/lcqz06vsq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz06vuq_x1d.fits to cos_data/mastDownload/HST/lcqz06vuq/lcqz06vuq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz06vwq_x1d.fits to cos_data/mastDownload/HST/lcqz06vwq/lcqz06vwq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz06vyq_x1d.fits to cos_data/mastDownload/HST/lcqz06vyq/lcqz06vyq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz07aeq_x1d.fits to cos_data/mastDownload/HST/lcqz07aeq/lcqz07aeq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz08cwq_x1d.fits to cos_data/mastDownload/HST/lcqz08cwq/lcqz08cwq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz08cyq_x1d.fits to cos_data/mastDownload/HST/lcqz08cyq/lcqz08cyq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz08d0q_x1d.fits to cos_data/mastDownload/HST/lcqz08d0q/lcqz08d0q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz08d5q_x1d.fits to cos_data/mastDownload/HST/lcqz08d5q/lcqz08d5q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz09f9q_x1d.fits to cos_data/mastDownload/HST/lcqz09f9q/lcqz09f9q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz10sxq_x1d.fits to cos_data/mastDownload/HST/lcqz10sxq/lcqz10sxq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz10t0q_x1d.fits to cos_data/mastDownload/HST/lcqz10t0q/lcqz10t0q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz10t2q_x1d.fits to cos_data/mastDownload/HST/lcqz10t2q/lcqz10t2q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz10t4q_x1d.fits to cos_data/mastDownload/HST/lcqz10t4q/lcqz10t4q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lcqz11o2q_x1d.fits to cos_data/mastDownload/HST/lcqz11o2q/lcqz11o2q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y01dfq_x1d.fits to cos_data/mastDownload/HST/ld0y01dfq/ld0y01dfq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y02cgq_x1d.fits to cos_data/mastDownload/HST/ld0y02cgq/ld0y02cgq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y02ciq_x1d.fits to cos_data/mastDownload/HST/ld0y02ciq/ld0y02ciq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y02ckq_x1d.fits to cos_data/mastDownload/HST/ld0y02ckq/ld0y02ckq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y02cmq_x1d.fits to cos_data/mastDownload/HST/ld0y02cmq/ld0y02cmq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y03exq_x1d.fits to cos_data/mastDownload/HST/ld0y03exq/ld0y03exq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y04i8q_x1d.fits to cos_data/mastDownload/HST/ld0y04i8q/ld0y04i8q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y04idq_x1d.fits to cos_data/mastDownload/HST/ld0y04idq/ld0y04idq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y04ifq_x1d.fits to cos_data/mastDownload/HST/ld0y04ifq/ld0y04ifq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y04j2q_x1d.fits to cos_data/mastDownload/HST/ld0y04j2q/ld0y04j2q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y05gaq_x1d.fits to cos_data/mastDownload/HST/ld0y05gaq/ld0y05gaq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y06icq_x1d.fits to cos_data/mastDownload/HST/ld0y06icq/ld0y06icq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y06iiq_x1d.fits to cos_data/mastDownload/HST/ld0y06iiq/ld0y06iiq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y06ikq_x1d.fits to cos_data/mastDownload/HST/ld0y06ikq/ld0y06ikq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y06inq_x1d.fits to cos_data/mastDownload/HST/ld0y06inq/ld0y06inq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y07acq_x1d.fits to cos_data/mastDownload/HST/ld0y07acq/ld0y07acq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y08mkq_x1d.fits to cos_data/mastDownload/HST/ld0y08mkq/ld0y08mkq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y08mmq_x1d.fits to cos_data/mastDownload/HST/ld0y08mmq/ld0y08mmq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y08muq_x1d.fits to cos_data/mastDownload/HST/ld0y08muq/ld0y08muq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y08mwq_x1d.fits to cos_data/mastDownload/HST/ld0y08mwq/ld0y08mwq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y09flq_x1d.fits to cos_data/mastDownload/HST/ld0y09flq/ld0y09flq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y10dkq_x1d.fits to cos_data/mastDownload/HST/ld0y10dkq/ld0y10dkq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y10dmq_x1d.fits to cos_data/mastDownload/HST/ld0y10dmq/ld0y10dmq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y10dpq_x1d.fits to cos_data/mastDownload/HST/ld0y10dpq/ld0y10dpq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y10drq_x1d.fits to cos_data/mastDownload/HST/ld0y10drq/ld0y10drq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ld0y11bmq_x1d.fits to cos_data/mastDownload/HST/ld0y11bmq/ld0y11bmq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv01opq_x1d.fits to cos_data/mastDownload/HST/ldcv01opq/ldcv01opq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv02ylq_x1d.fits to cos_data/mastDownload/HST/ldcv02ylq/ldcv02ylq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv02ynq_x1d.fits to cos_data/mastDownload/HST/ldcv02ynq/ldcv02ynq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv02ypq_x1d.fits to cos_data/mastDownload/HST/ldcv02ypq/ldcv02ypq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv02yrq_x1d.fits to cos_data/mastDownload/HST/ldcv02yrq/ldcv02yrq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv04baq_x1d.fits to cos_data/mastDownload/HST/ldcv04baq/ldcv04baq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv05ejq_x1d.fits to cos_data/mastDownload/HST/ldcv05ejq/ldcv05ejq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv05elq_x1d.fits to cos_data/mastDownload/HST/ldcv05elq/ldcv05elq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv05enq_x1d.fits to cos_data/mastDownload/HST/ldcv05enq/ldcv05enq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv05epq_x1d.fits to cos_data/mastDownload/HST/ldcv05epq/ldcv05epq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv07baq_x1d.fits to cos_data/mastDownload/HST/ldcv07baq/ldcv07baq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv08emq_x1d.fits to cos_data/mastDownload/HST/ldcv08emq/ldcv08emq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv08eos_x1d.fits to cos_data/mastDownload/HST/ldcv08eos/ldcv08eos_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv08eqq_x1d.fits to cos_data/mastDownload/HST/ldcv08eqq/ldcv08eqq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv08esq_x1d.fits to cos_data/mastDownload/HST/ldcv08esq/ldcv08esq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv10hcq_x1d.fits to cos_data/mastDownload/HST/ldcv10hcq/ldcv10hcq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv11f1q_x1d.fits to cos_data/mastDownload/HST/ldcv11f1q/ldcv11f1q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv11f3q_x1d.fits to cos_data/mastDownload/HST/ldcv11f3q/ldcv11f3q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv11f5q_x1d.fits to cos_data/mastDownload/HST/ldcv11f5q/ldcv11f5q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv11f7q_x1d.fits to cos_data/mastDownload/HST/ldcv11f7q/ldcv11f7q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv13hbq_x1d.fits to cos_data/mastDownload/HST/ldcv13hbq/ldcv13hbq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv17meq_x1d.fits to cos_data/mastDownload/HST/ldcv17meq/ldcv17meq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv17mgq_x1d.fits to cos_data/mastDownload/HST/ldcv17mgq/ldcv17mgq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv17miq_x1d.fits to cos_data/mastDownload/HST/ldcv17miq/ldcv17miq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv17mkq_x1d.fits to cos_data/mastDownload/HST/ldcv17mkq/ldcv17mkq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv20elq_x1d.fits to cos_data/mastDownload/HST/ldcv20elq/ldcv20elq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv20enq_x1d.fits to cos_data/mastDownload/HST/ldcv20enq/ldcv20enq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv20epq_x1d.fits to cos_data/mastDownload/HST/ldcv20epq/ldcv20epq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv20esq_x1d.fits to cos_data/mastDownload/HST/ldcv20esq/ldcv20esq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv22wpq_x1d.fits to cos_data/mastDownload/HST/ldcv22wpq/ldcv22wpq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv22wrq_x1d.fits to cos_data/mastDownload/HST/ldcv22wrq/ldcv22wrq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldcv22x1q_x1d.fits to cos_data/mastDownload/HST/ldcv22x1q/ldcv22x1q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel01oyq_x1d.fits to cos_data/mastDownload/HST/ldel01oyq/ldel01oyq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel01p0q_x1d.fits to cos_data/mastDownload/HST/ldel01p0q/ldel01p0q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel01p2q_x1d.fits to cos_data/mastDownload/HST/ldel01p2q/ldel01p2q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel01p4q_x1d.fits to cos_data/mastDownload/HST/ldel01p4q/ldel01p4q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel01p6q_x1d.fits to cos_data/mastDownload/HST/ldel01p6q/ldel01p6q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel01p8q_x1d.fits to cos_data/mastDownload/HST/ldel01p8q/ldel01p8q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel01paq_x1d.fits to cos_data/mastDownload/HST/ldel01paq/ldel01paq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel01pcq_x1d.fits to cos_data/mastDownload/HST/ldel01pcq/ldel01pcq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel01peq_x1d.fits to cos_data/mastDownload/HST/ldel01peq/ldel01peq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel01pgq_x1d.fits to cos_data/mastDownload/HST/ldel01pgq/ldel01pgq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel01piq_x1d.fits to cos_data/mastDownload/HST/ldel01piq/ldel01piq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel01pkq_x1d.fits to cos_data/mastDownload/HST/ldel01pkq/ldel01pkq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel02ctq_x1d.fits to cos_data/mastDownload/HST/ldel02ctq/ldel02ctq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel02cvq_x1d.fits to cos_data/mastDownload/HST/ldel02cvq/ldel02cvq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel02cxq_x1d.fits to cos_data/mastDownload/HST/ldel02cxq/ldel02cxq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel02czq_x1d.fits to cos_data/mastDownload/HST/ldel02czq/ldel02czq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel02d1q_x1d.fits to cos_data/mastDownload/HST/ldel02d1q/ldel02d1q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel02d3q_x1d.fits to cos_data/mastDownload/HST/ldel02d3q/ldel02d3q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel02d5q_x1d.fits to cos_data/mastDownload/HST/ldel02d5q/ldel02d5q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel02d7q_x1d.fits to cos_data/mastDownload/HST/ldel02d7q/ldel02d7q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel02d9q_x1d.fits to cos_data/mastDownload/HST/ldel02d9q/ldel02d9q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel02dbq_x1d.fits to cos_data/mastDownload/HST/ldel02dbq/ldel02dbq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel02ddq_x1d.fits to cos_data/mastDownload/HST/ldel02ddq/ldel02ddq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldel02dfq_x1d.fits to cos_data/mastDownload/HST/ldel02dfq/ldel02dfq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldmk01ddq_x1d.fits to cos_data/mastDownload/HST/ldmk01ddq/ldmk01ddq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldmk01dfq_x1d.fits to cos_data/mastDownload/HST/ldmk01dfq/ldmk01dfq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldmk01dhq_x1d.fits to cos_data/mastDownload/HST/ldmk01dhq/ldmk01dhq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldmk01dkq_x1d.fits to cos_data/mastDownload/HST/ldmk01dkq/ldmk01dkq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj01mmq_x1d.fits to cos_data/mastDownload/HST/ldqj01mmq/ldqj01mmq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj01moq_x1d.fits to cos_data/mastDownload/HST/ldqj01moq/ldqj01moq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj01n0q_x1d.fits to cos_data/mastDownload/HST/ldqj01n0q/ldqj01n0q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj01ncq_x1d.fits to cos_data/mastDownload/HST/ldqj01ncq/ldqj01ncq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj03gxq_x1d.fits to cos_data/mastDownload/HST/ldqj03gxq/ldqj03gxq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj03hyq_x1d.fits to cos_data/mastDownload/HST/ldqj03hyq/ldqj03hyq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj03i2q_x1d.fits to cos_data/mastDownload/HST/ldqj03i2q/ldqj03i2q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj03igq_x1d.fits to cos_data/mastDownload/HST/ldqj03igq/ldqj03igq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj05xuq_x1d.fits to cos_data/mastDownload/HST/ldqj05xuq/ldqj05xuq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj05xwq_x1d.fits to cos_data/mastDownload/HST/ldqj05xwq/ldqj05xwq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj05xyq_x1d.fits to cos_data/mastDownload/HST/ldqj05xyq/ldqj05xyq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj05yoq_x1d.fits to cos_data/mastDownload/HST/ldqj05yoq/ldqj05yoq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj07xtq_x1d.fits to cos_data/mastDownload/HST/ldqj07xtq/ldqj07xtq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj07xvq_x1d.fits to cos_data/mastDownload/HST/ldqj07xvq/ldqj07xvq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj07xxq_x1d.fits to cos_data/mastDownload/HST/ldqj07xxq/ldqj07xxq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj07y7q_x1d.fits to cos_data/mastDownload/HST/ldqj07y7q/ldqj07y7q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj08ixq_x1d.fits to cos_data/mastDownload/HST/ldqj08ixq/ldqj08ixq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj08izq_x1d.fits to cos_data/mastDownload/HST/ldqj08izq/ldqj08izq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj08j1q_x1d.fits to cos_data/mastDownload/HST/ldqj08j1q/ldqj08j1q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj08jdq_x1d.fits to cos_data/mastDownload/HST/ldqj08jdq/ldqj08jdq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj10deq_x1d.fits to cos_data/mastDownload/HST/ldqj10deq/ldqj10deq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj10dgq_x1d.fits to cos_data/mastDownload/HST/ldqj10dgq/ldqj10dgq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj10diq_x1d.fits to cos_data/mastDownload/HST/ldqj10diq/ldqj10diq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj10dsq_x1d.fits to cos_data/mastDownload/HST/ldqj10dsq/ldqj10dsq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj12e2q_x1d.fits to cos_data/mastDownload/HST/ldqj12e2q/ldqj12e2q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj12e4q_x1d.fits to cos_data/mastDownload/HST/ldqj12e4q/ldqj12e4q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj12e6q_x1d.fits to cos_data/mastDownload/HST/ldqj12e6q/ldqj12e6q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj55xiq_x1d.fits to cos_data/mastDownload/HST/ldqj55xiq/ldqj55xiq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj55xkq_x1d.fits to cos_data/mastDownload/HST/ldqj55xkq/ldqj55xkq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj55xmq_x1d.fits to cos_data/mastDownload/HST/ldqj55xmq/ldqj55xmq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj55xwq_x1d.fits to cos_data/mastDownload/HST/ldqj55xwq/ldqj55xwq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj56a3q_x1d.fits to cos_data/mastDownload/HST/ldqj56a3q/ldqj56a3q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj56a5q_x1d.fits to cos_data/mastDownload/HST/ldqj56a5q/ldqj56a5q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj56a7q_x1d.fits to cos_data/mastDownload/HST/ldqj56a7q/ldqj56a7q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj57trq_x1d.fits to cos_data/mastDownload/HST/ldqj57trq/ldqj57trq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj57ttq_x1d.fits to cos_data/mastDownload/HST/ldqj57ttq/ldqj57ttq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj57tvq_x1d.fits to cos_data/mastDownload/HST/ldqj57tvq/ldqj57tvq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj59jtq_x1d.fits to cos_data/mastDownload/HST/ldqj59jtq/ldqj59jtq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj59jvq_x1d.fits to cos_data/mastDownload/HST/ldqj59jvq/ldqj59jvq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldqj59jxq_x1d.fits to cos_data/mastDownload/HST/ldqj59jxq/ldqj59jxq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv001ivq_x1d.fits to cos_data/mastDownload/HST/ldv001ivq/ldv001ivq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv001ixq_x1d.fits to cos_data/mastDownload/HST/ldv001ixq/ldv001ixq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv001izq_x1d.fits to cos_data/mastDownload/HST/ldv001izq/ldv001izq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv001kaq_x1d.fits to cos_data/mastDownload/HST/ldv001kaq/ldv001kaq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv003d9q_x1d.fits to cos_data/mastDownload/HST/ldv003d9q/ldv003d9q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv003dbq_x1d.fits to cos_data/mastDownload/HST/ldv003dbq/ldv003dbq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv003ddq_x1d.fits to cos_data/mastDownload/HST/ldv003ddq/ldv003ddq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv005f6q_x1d.fits to cos_data/mastDownload/HST/ldv005f6q/ldv005f6q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv005f9q_x1d.fits to cos_data/mastDownload/HST/ldv005f9q/ldv005f9q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv005g2q_x1d.fits to cos_data/mastDownload/HST/ldv005g2q/ldv005g2q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv005gjq_x1d.fits to cos_data/mastDownload/HST/ldv005gjq/ldv005gjq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv007p4q_x1d.fits to cos_data/mastDownload/HST/ldv007p4q/ldv007p4q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv007p6q_x1d.fits to cos_data/mastDownload/HST/ldv007p6q/ldv007p6q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv007p8q_x1d.fits to cos_data/mastDownload/HST/ldv007p8q/ldv007p8q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv007pmq_x1d.fits to cos_data/mastDownload/HST/ldv007pmq/ldv007pmq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv008o9q_x1d.fits to cos_data/mastDownload/HST/ldv008o9q/ldv008o9q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv008obq_x1d.fits to cos_data/mastDownload/HST/ldv008obq/ldv008obq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv008orq_x1d.fits to cos_data/mastDownload/HST/ldv008orq/ldv008orq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv010ekq_x1d.fits to cos_data/mastDownload/HST/ldv010ekq/ldv010ekq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv010eoq_x1d.fits to cos_data/mastDownload/HST/ldv010eoq/ldv010eoq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv010etq_x1d.fits to cos_data/mastDownload/HST/ldv010etq/ldv010etq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv010fvq_x1d.fits to cos_data/mastDownload/HST/ldv010fvq/ldv010fvq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv053mqq_x1d.fits to cos_data/mastDownload/HST/ldv053mqq/ldv053mqq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv053msq_x1d.fits to cos_data/mastDownload/HST/ldv053msq/ldv053msq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv053mwq_x1d.fits to cos_data/mastDownload/HST/ldv053mwq/ldv053mwq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv053naq_x1d.fits to cos_data/mastDownload/HST/ldv053naq/ldv053naq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv057a9q_x1d.fits to cos_data/mastDownload/HST/ldv057a9q/ldv057a9q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv057yoq_x1d.fits to cos_data/mastDownload/HST/ldv057yoq/ldv057yoq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv057yqq_x1d.fits to cos_data/mastDownload/HST/ldv057yqq/ldv057yqq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv057ysq_x1d.fits to cos_data/mastDownload/HST/ldv057ysq/ldv057ysq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv058axq_x1d.fits to cos_data/mastDownload/HST/ldv058axq/ldv058axq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv058azq_x1d.fits to cos_data/mastDownload/HST/ldv058azq/ldv058azq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv058b2q_x1d.fits to cos_data/mastDownload/HST/ldv058b2q/ldv058b2q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv058cbq_x1d.fits to cos_data/mastDownload/HST/ldv058cbq/ldv058cbq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv060d2s_x1d.fits to cos_data/mastDownload/HST/ldv060d2s/ldv060d2s_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv060d5s_x1d.fits to cos_data/mastDownload/HST/ldv060d5s/ldv060d5s_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv060dbq_x1d.fits to cos_data/mastDownload/HST/ldv060dbq/ldv060dbq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ldv060e2q_x1d.fits to cos_data/mastDownload/HST/ldv060e2q/ldv060e2q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g01ezq_x1d.fits to cos_data/mastDownload/HST/le5g01ezq/le5g01ezq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g01f2q_x1d.fits to cos_data/mastDownload/HST/le5g01f2q/le5g01f2q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g01f4q_x1d.fits to cos_data/mastDownload/HST/le5g01f4q/le5g01f4q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g01foq_x1d.fits to cos_data/mastDownload/HST/le5g01foq/le5g01foq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g05pgq_x1d.fits to cos_data/mastDownload/HST/le5g05pgq/le5g05pgq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g05pnq_x1d.fits to cos_data/mastDownload/HST/le5g05pnq/le5g05pnq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g05ppq_x1d.fits to cos_data/mastDownload/HST/le5g05ppq/le5g05ppq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g05r4q_x1d.fits to cos_data/mastDownload/HST/le5g05r4q/le5g05r4q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g07mgq_x1d.fits to cos_data/mastDownload/HST/le5g07mgq/le5g07mgq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g07mjq_x1d.fits to cos_data/mastDownload/HST/le5g07mjq/le5g07mjq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g07mlq_x1d.fits to cos_data/mastDownload/HST/le5g07mlq/le5g07mlq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g07naq_x1d.fits to cos_data/mastDownload/HST/le5g07naq/le5g07naq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g08ltq_x1d.fits to cos_data/mastDownload/HST/le5g08ltq/le5g08ltq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g08lwq_x1d.fits to cos_data/mastDownload/HST/le5g08lwq/le5g08lwq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g08lyq_x1d.fits to cos_data/mastDownload/HST/le5g08lyq/le5g08lyq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g10jyq_x1d.fits to cos_data/mastDownload/HST/le5g10jyq/le5g10jyq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g10k0q_x1d.fits to cos_data/mastDownload/HST/le5g10k0q/le5g10k0q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g10k3q_x1d.fits to cos_data/mastDownload/HST/le5g10k3q/le5g10k3q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g10l5q_x1d.fits to cos_data/mastDownload/HST/le5g10l5q/le5g10l5q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g53bsq_x1d.fits to cos_data/mastDownload/HST/le5g53bsq/le5g53bsq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g53bvq_x1d.fits to cos_data/mastDownload/HST/le5g53bvq/le5g53bvq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g53bxq_x1d.fits to cos_data/mastDownload/HST/le5g53bxq/le5g53bxq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g53deq_x1d.fits to cos_data/mastDownload/HST/le5g53deq/le5g53deq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g57ljq_x1d.fits to cos_data/mastDownload/HST/le5g57ljq/le5g57ljq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le5g58bcq_x1d.fits to cos_data/mastDownload/HST/le5g58bcq/le5g58bcq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le9a01fcq_x1d.fits to cos_data/mastDownload/HST/le9a01fcq/le9a01fcq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/le9a02klq_x1d.fits to cos_data/mastDownload/HST/le9a02klq/le9a02klq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes1vuq_x1d.fits to cos_data/mastDownload/HST/ledes1vuq/ledes1vuq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes1vwq_x1d.fits to cos_data/mastDownload/HST/ledes1vwq/ledes1vwq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes1vyq_x1d.fits to cos_data/mastDownload/HST/ledes1vyq/ledes1vyq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes1w0q_x1d.fits to cos_data/mastDownload/HST/ledes1w0q/ledes1w0q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes2epq_x1d.fits to cos_data/mastDownload/HST/ledes2epq/ledes2epq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes2erq_x1d.fits to cos_data/mastDownload/HST/ledes2erq/ledes2erq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes2etq_x1d.fits to cos_data/mastDownload/HST/ledes2etq/ledes2etq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes2evq_x1d.fits to cos_data/mastDownload/HST/ledes2evq/ledes2evq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes3fhq_x1d.fits to cos_data/mastDownload/HST/ledes3fhq/ledes3fhq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes3fjq_x1d.fits to cos_data/mastDownload/HST/ledes3fjq/ledes3fjq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes3flq_x1d.fits to cos_data/mastDownload/HST/ledes3flq/ledes3flq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes3fnq_x1d.fits to cos_data/mastDownload/HST/ledes3fnq/ledes3fnq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes4egq_x1d.fits to cos_data/mastDownload/HST/ledes4egq/ledes4egq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes4eiq_x1d.fits to cos_data/mastDownload/HST/ledes4eiq/ledes4eiq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes4ekq_x1d.fits to cos_data/mastDownload/HST/ledes4ekq/ledes4ekq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes4emq_x1d.fits to cos_data/mastDownload/HST/ledes4emq/ledes4emq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes6f7q_x1d.fits to cos_data/mastDownload/HST/ledes6f7q/ledes6f7q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes6f9q_x1d.fits to cos_data/mastDownload/HST/ledes6f9q/ledes6f9q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes6fbq_x1d.fits to cos_data/mastDownload/HST/ledes6fbq/ledes6fbq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes6fdq_x1d.fits to cos_data/mastDownload/HST/ledes6fdq/ledes6fdq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes9hdq_x1d.fits to cos_data/mastDownload/HST/ledes9hdq/ledes9hdq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes9hgq_x1d.fits to cos_data/mastDownload/HST/ledes9hgq/ledes9hgq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes9hiq_x1d.fits to cos_data/mastDownload/HST/ledes9hiq/ledes9hiq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledes9hkq_x1d.fits to cos_data/mastDownload/HST/ledes9hkq/ledes9hkq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledesapwq_x1d.fits to cos_data/mastDownload/HST/ledesapwq/ledesapwq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledesapyq_x1d.fits to cos_data/mastDownload/HST/ledesapyq/ledesapyq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledesaq0q_x1d.fits to cos_data/mastDownload/HST/ledesaq0q/ledesaq0q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledesaq6q_x1d.fits to cos_data/mastDownload/HST/ledesaq6q/ledesaq6q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledesdniq_x1d.fits to cos_data/mastDownload/HST/ledesdniq/ledesdniq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledesdnkq_x1d.fits to cos_data/mastDownload/HST/ledesdnkq/ledesdnkq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledesdnmq_x1d.fits to cos_data/mastDownload/HST/ledesdnmq/ledesdnmq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledesdnoq_x1d.fits to cos_data/mastDownload/HST/ledesdnoq/ledesdnoq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledesex9q_x1d.fits to cos_data/mastDownload/HST/ledesex9q/ledesex9q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledesexbq_x1d.fits to cos_data/mastDownload/HST/ledesexbq/ledesexbq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledesexdq_x1d.fits to cos_data/mastDownload/HST/ledesexdq/ledesexdq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ledesexfq_x1d.fits to cos_data/mastDownload/HST/ledesexfq/ledesexfq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe01pkq_x1d.fits to cos_data/mastDownload/HST/lefe01pkq/lefe01pkq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe01pmq_x1d.fits to cos_data/mastDownload/HST/lefe01pmq/lefe01pmq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe01poq_x1d.fits to cos_data/mastDownload/HST/lefe01poq/lefe01poq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe01q3q_x1d.fits to cos_data/mastDownload/HST/lefe01q3q/lefe01q3q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe03gjq_x1d.fits to cos_data/mastDownload/HST/lefe03gjq/lefe03gjq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe03gmq_x1d.fits to cos_data/mastDownload/HST/lefe03gmq/lefe03gmq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe03goq_x1d.fits to cos_data/mastDownload/HST/lefe03goq/lefe03goq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe05nwq_x1d.fits to cos_data/mastDownload/HST/lefe05nwq/lefe05nwq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe05nyq_x1d.fits to cos_data/mastDownload/HST/lefe05nyq/lefe05nyq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe05o0q_x1d.fits to cos_data/mastDownload/HST/lefe05o0q/lefe05o0q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe05o2q_x1d.fits to cos_data/mastDownload/HST/lefe05o2q/lefe05o2q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe05piq_x1d.fits to cos_data/mastDownload/HST/lefe05piq/lefe05piq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe05pkq_x1d.fits to cos_data/mastDownload/HST/lefe05pkq/lefe05pkq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe07ljq_x1d.fits to cos_data/mastDownload/HST/lefe07ljq/lefe07ljq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe07llq_x1d.fits to cos_data/mastDownload/HST/lefe07llq/lefe07llq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe07lnq_x1d.fits to cos_data/mastDownload/HST/lefe07lnq/lefe07lnq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe07m3q_x1d.fits to cos_data/mastDownload/HST/lefe07m3q/lefe07m3q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe08ouq_x1d.fits to cos_data/mastDownload/HST/lefe08ouq/lefe08ouq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe08owq_x1d.fits to cos_data/mastDownload/HST/lefe08owq/lefe08owq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe08oyq_x1d.fits to cos_data/mastDownload/HST/lefe08oyq/lefe08oyq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe08pdq_x1d.fits to cos_data/mastDownload/HST/lefe08pdq/lefe08pdq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe10ouq_x1d.fits to cos_data/mastDownload/HST/lefe10ouq/lefe10ouq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe10oyq_x1d.fits to cos_data/mastDownload/HST/lefe10oyq/lefe10oyq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe10p0q_x1d.fits to cos_data/mastDownload/HST/lefe10p0q/lefe10p0q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe10ptq_x1d.fits to cos_data/mastDownload/HST/lefe10ptq/lefe10ptq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe53e9q_x1d.fits to cos_data/mastDownload/HST/lefe53e9q/lefe53e9q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe53ebq_x1d.fits to cos_data/mastDownload/HST/lefe53ebq/lefe53ebq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe53edq_x1d.fits to cos_data/mastDownload/HST/lefe53edq/lefe53edq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lefe53erq_x1d.fits to cos_data/mastDownload/HST/lefe53erq/lefe53erq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia02ppq_x1d.fits to cos_data/mastDownload/HST/leia02ppq/leia02ppq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia02prq_x1d.fits to cos_data/mastDownload/HST/leia02prq/leia02prq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia03kbq_x1d.fits to cos_data/mastDownload/HST/leia03kbq/leia03kbq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia03keq_x1d.fits to cos_data/mastDownload/HST/leia03keq/leia03keq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia03kkq_x1d.fits to cos_data/mastDownload/HST/leia03kkq/leia03kkq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia03kmq_x1d.fits to cos_data/mastDownload/HST/leia03kmq/leia03kmq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia04q2q_x1d.fits to cos_data/mastDownload/HST/leia04q2q/leia04q2q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia04q5q_x1d.fits to cos_data/mastDownload/HST/leia04q5q/leia04q5q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia04qdq_x1d.fits to cos_data/mastDownload/HST/leia04qdq/leia04qdq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia04qfq_x1d.fits to cos_data/mastDownload/HST/leia04qfq/leia04qfq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia51fdq_x1d.fits to cos_data/mastDownload/HST/leia51fdq/leia51fdq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia51fjq_x1d.fits to cos_data/mastDownload/HST/leia51fjq/leia51fjq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia51g5q_x1d.fits to cos_data/mastDownload/HST/leia51g5q/leia51g5q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia51g8q_x1d.fits to cos_data/mastDownload/HST/leia51g8q/leia51g8q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia51gaq_x1d.fits to cos_data/mastDownload/HST/leia51gaq/leia51gaq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia51gcq_x1d.fits to cos_data/mastDownload/HST/leia51gcq/leia51gcq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia51geq_x1d.fits to cos_data/mastDownload/HST/leia51geq/leia51geq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia51ggq_x1d.fits to cos_data/mastDownload/HST/leia51ggq/leia51ggq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia52dpq_x1d.fits to cos_data/mastDownload/HST/leia52dpq/leia52dpq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/leia52drq_x1d.fits to cos_data/mastDownload/HST/leia52drq/leia52drq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler101bsq_x1d.fits to cos_data/mastDownload/HST/ler101bsq/ler101bsq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler101buq_x1d.fits to cos_data/mastDownload/HST/ler101buq/ler101buq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler101bwq_x1d.fits to cos_data/mastDownload/HST/ler101bwq/ler101bwq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler101cnq_x1d.fits to cos_data/mastDownload/HST/ler101cnq/ler101cnq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler103a7q_x1d.fits to cos_data/mastDownload/HST/ler103a7q/ler103a7q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler103aaq_x1d.fits to cos_data/mastDownload/HST/ler103aaq/ler103aaq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler103avq_x1d.fits to cos_data/mastDownload/HST/ler103avq/ler103avq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler107a3q_x1d.fits to cos_data/mastDownload/HST/ler107a3q/ler107a3q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler107a5q_x1d.fits to cos_data/mastDownload/HST/ler107a5q/ler107a5q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler107a7q_x1d.fits to cos_data/mastDownload/HST/ler107a7q/ler107a7q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler107a9q_x1d.fits to cos_data/mastDownload/HST/ler107a9q/ler107a9q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler107bfq_x1d.fits to cos_data/mastDownload/HST/ler107bfq/ler107bfq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler108ebq_x1d.fits to cos_data/mastDownload/HST/ler108ebq/ler108ebq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler108eeq_x1d.fits to cos_data/mastDownload/HST/ler108eeq/ler108eeq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler108egq_x1d.fits to cos_data/mastDownload/HST/ler108egq/ler108egq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler110wgq_x1d.fits to cos_data/mastDownload/HST/ler110wgq/ler110wgq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler110wjq_x1d.fits to cos_data/mastDownload/HST/ler110wjq/ler110wjq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler110woq_x1d.fits to cos_data/mastDownload/HST/ler110woq/ler110woq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler110xvq_x1d.fits to cos_data/mastDownload/HST/ler110xvq/ler110xvq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler153fkq_x1d.fits to cos_data/mastDownload/HST/ler153fkq/ler153fkq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler158p2q_x1d.fits to cos_data/mastDownload/HST/ler158p2q/ler158p2q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler15akaq_x1d.fits to cos_data/mastDownload/HST/ler15akaq/ler15akaq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler15akcq_x1d.fits to cos_data/mastDownload/HST/ler15akcq/ler15akcq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler15akgq_x1d.fits to cos_data/mastDownload/HST/ler15akgq/ler15akgq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler15bhaq_x1d.fits to cos_data/mastDownload/HST/ler15bhaq/ler15bhaq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/ler15bhcq_x1d.fits to cos_data/mastDownload/HST/ler15bhcq/ler15bhcq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf2010m6q_x1d.fits to cos_data/mastDownload/HST/lf2010m6q/lf2010m6q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf2010m8q_x1d.fits to cos_data/mastDownload/HST/lf2010m8q/lf2010m8q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf2010maq_x1d.fits to cos_data/mastDownload/HST/lf2010maq/lf2010maq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf2010mmq_x1d.fits to cos_data/mastDownload/HST/lf2010mmq/lf2010mmq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf201aouq_x1d.fits to cos_data/mastDownload/HST/lf201aouq/lf201aouq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf201aowq_x1d.fits to cos_data/mastDownload/HST/lf201aowq/lf201aowq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf201ap0q_x1d.fits to cos_data/mastDownload/HST/lf201ap0q/lf201ap0q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf201apbq_x1d.fits to cos_data/mastDownload/HST/lf201apbq/lf201apbq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf203abbq_x1d.fits to cos_data/mastDownload/HST/lf203abbq/lf203abbq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf203abdq_x1d.fits to cos_data/mastDownload/HST/lf203abdq/lf203abdq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf203abfq_x1d.fits to cos_data/mastDownload/HST/lf203abfq/lf203abfq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf203abtq_x1d.fits to cos_data/mastDownload/HST/lf203abtq/lf203abtq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf205ag7q_x1d.fits to cos_data/mastDownload/HST/lf205ag7q/lf205ag7q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf205cxiq_x1d.fits to cos_data/mastDownload/HST/lf205cxiq/lf205cxiq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf205cxkq_x1d.fits to cos_data/mastDownload/HST/lf205cxkq/lf205cxkq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf205cxmq_x1d.fits to cos_data/mastDownload/HST/lf205cxmq/lf205cxmq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf205cymq_x1d.fits to cos_data/mastDownload/HST/lf205cymq/lf205cymq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf207af1q_x1d.fits to cos_data/mastDownload/HST/lf207af1q/lf207af1q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf207af3q_x1d.fits to cos_data/mastDownload/HST/lf207af3q/lf207af3q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf207af5q_x1d.fits to cos_data/mastDownload/HST/lf207af5q/lf207af5q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf207affq_x1d.fits to cos_data/mastDownload/HST/lf207affq/lf207affq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf208alnq_x1d.fits to cos_data/mastDownload/HST/lf208alnq/lf208alnq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf208alpq_x1d.fits to cos_data/mastDownload/HST/lf208alpq/lf208alpq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf208alrq_x1d.fits to cos_data/mastDownload/HST/lf208alrq/lf208alrq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf208am1q_x1d.fits to cos_data/mastDownload/HST/lf208am1q/lf208am1q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf2110y6q_x1d.fits to cos_data/mastDownload/HST/lf2110y6q/lf2110y6q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf2110y8q_x1d.fits to cos_data/mastDownload/HST/lf2110y8q/lf2110y8q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf2110yaq_x1d.fits to cos_data/mastDownload/HST/lf2110yaq/lf2110yaq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf2110ykq_x1d.fits to cos_data/mastDownload/HST/lf2110ykq/lf2110ykq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf218aegq_x1d.fits to cos_data/mastDownload/HST/lf218aegq/lf218aegq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf218aeiq_x1d.fits to cos_data/mastDownload/HST/lf218aeiq/lf218aeiq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf218aekq_x1d.fits to cos_data/mastDownload/HST/lf218aekq/lf218aekq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf218aeuq_x1d.fits to cos_data/mastDownload/HST/lf218aeuq/lf218aeuq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4g1arlq_x1d.fits to cos_data/mastDownload/HST/lf4g1arlq/lf4g1arlq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4g1arnq_x1d.fits to cos_data/mastDownload/HST/lf4g1arnq/lf4g1arnq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4g1arpq_x1d.fits to cos_data/mastDownload/HST/lf4g1arpq/lf4g1arpq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4g1as0q_x1d.fits to cos_data/mastDownload/HST/lf4g1as0q/lf4g1as0q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4g3aciq_x1d.fits to cos_data/mastDownload/HST/lf4g3aciq/lf4g3aciq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4g3acnq_x1d.fits to cos_data/mastDownload/HST/lf4g3acnq/lf4g3acnq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4g3acpq_x1d.fits to cos_data/mastDownload/HST/lf4g3acpq/lf4g3acpq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4g3ad4q_x1d.fits to cos_data/mastDownload/HST/lf4g3ad4q/lf4g3ad4q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4g8aj2q_x1d.fits to cos_data/mastDownload/HST/lf4g8aj2q/lf4g8aj2q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4g8aj5q_x1d.fits to cos_data/mastDownload/HST/lf4g8aj5q/lf4g8aj5q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4g8aj7q_x1d.fits to cos_data/mastDownload/HST/lf4g8aj7q/lf4g8aj7q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4g8ajhq_x1d.fits to cos_data/mastDownload/HST/lf4g8ajhq/lf4g8ajhq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4h1abcq_x1d.fits to cos_data/mastDownload/HST/lf4h1abcq/lf4h1abcq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4h1abeq_x1d.fits to cos_data/mastDownload/HST/lf4h1abeq/lf4h1abeq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4h1abgq_x1d.fits to cos_data/mastDownload/HST/lf4h1abgq/lf4h1abgq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4h1absq_x1d.fits to cos_data/mastDownload/HST/lf4h1absq/lf4h1absq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4h3aekq_x1d.fits to cos_data/mastDownload/HST/lf4h3aekq/lf4h3aekq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4h3aenq_x1d.fits to cos_data/mastDownload/HST/lf4h3aenq/lf4h3aenq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4h3aepq_x1d.fits to cos_data/mastDownload/HST/lf4h3aepq/lf4h3aepq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4h3af6q_x1d.fits to cos_data/mastDownload/HST/lf4h3af6q/lf4h3af6q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4h5agqq_x1d.fits to cos_data/mastDownload/HST/lf4h5agqq/lf4h5agqq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4h7arrq_x1d.fits to cos_data/mastDownload/HST/lf4h7arrq/lf4h7arrq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4h7artq_x1d.fits to cos_data/mastDownload/HST/lf4h7artq/lf4h7artq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4h7arwq_x1d.fits to cos_data/mastDownload/HST/lf4h7arwq/lf4h7arwq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4h7as7q_x1d.fits to cos_data/mastDownload/HST/lf4h7as7q/lf4h7as7q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4h9aaxq_x1d.fits to cos_data/mastDownload/HST/lf4h9aaxq/lf4h9aaxq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4h9ab2q_x1d.fits to cos_data/mastDownload/HST/lf4h9ab2q/lf4h9ab2q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4h9ab4q_x1d.fits to cos_data/mastDownload/HST/lf4h9ab4q/lf4h9ab4q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lf4h9abgq_x1d.fits to cos_data/mastDownload/HST/lf4h9abgq/lf4h9abgq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lfib1arjq_x1d.fits to cos_data/mastDownload/HST/lfib1arjq/lfib1arjq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lfib1arlq_x1d.fits to cos_data/mastDownload/HST/lfib1arlq/lfib1arlq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lfib1aroq_x1d.fits to cos_data/mastDownload/HST/lfib1aroq/lfib1aroq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lfib1arzq_x1d.fits to cos_data/mastDownload/HST/lfib1arzq/lfib1arzq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lfib2ab2q_x1d.fits to cos_data/mastDownload/HST/lfib2ab2q/lfib2ab2q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lfib2ab5q_x1d.fits to cos_data/mastDownload/HST/lfib2ab5q/lfib2ab5q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lfib2ab7q_x1d.fits to cos_data/mastDownload/HST/lfib2ab7q/lfib2ab7q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lfib2abnq_x1d.fits to cos_data/mastDownload/HST/lfib2abnq/lfib2abnq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lfib3aj5q_x1d.fits to cos_data/mastDownload/HST/lfib3aj5q/lfib3aj5q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lfib3aj7q_x1d.fits to cos_data/mastDownload/HST/lfib3aj7q/lfib3aj7q_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lfic3aggq_x1d.fits to cos_data/mastDownload/HST/lfic3aggq/lfic3aggq_x1d.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:HST/product/lfic3ahiq_x1d.fits to cos_data/mastDownload/HST/lfic3ahiq/lfic3ahiq_x1d.fits ...
[Done]
Local Path | Status | Message | URL |
---|---|---|---|
str54 | str8 | object | object |
cos_data/mastDownload/HST/lbnm02a2q/lbnm02a2q_x1d.fits | COMPLETE | None | None |
cos_data/mastDownload/HST/lbnm02a4q/lbnm02a4q_x1d.fits | COMPLETE | None | None |
cos_data/mastDownload/HST/lbnm02a6q/lbnm02a6q_x1d.fits | COMPLETE | None | None |
cos_data/mastDownload/HST/lbnm02arq/lbnm02arq_x1d.fits | COMPLETE | None | None |
cos_data/mastDownload/HST/lbnm02auq/lbnm02auq_x1d.fits | COMPLETE | None | None |
cos_data/mastDownload/HST/lbnm02awq/lbnm02awq_x1d.fits | COMPLETE | None | None |
cos_data/mastDownload/HST/lbnm02ayq/lbnm02ayq_x1d.fits | COMPLETE | None | None |
cos_data/mastDownload/HST/lbnm02b0q/lbnm02b0q_x1d.fits | COMPLETE | None | None |
cos_data/mastDownload/HST/lbnm02b2q/lbnm02b2q_x1d.fits | COMPLETE | None | None |
... | ... | ... | ... |
cos_data/mastDownload/HST/lfib1aroq/lfib1aroq_x1d.fits | COMPLETE | None | None |
cos_data/mastDownload/HST/lfib1arzq/lfib1arzq_x1d.fits | COMPLETE | None | None |
cos_data/mastDownload/HST/lfib2ab2q/lfib2ab2q_x1d.fits | COMPLETE | None | None |
cos_data/mastDownload/HST/lfib2ab5q/lfib2ab5q_x1d.fits | COMPLETE | None | None |
cos_data/mastDownload/HST/lfib2ab7q/lfib2ab7q_x1d.fits | COMPLETE | None | None |
cos_data/mastDownload/HST/lfib2abnq/lfib2abnq_x1d.fits | COMPLETE | None | None |
cos_data/mastDownload/HST/lfib3aj5q/lfib3aj5q_x1d.fits | COMPLETE | None | None |
cos_data/mastDownload/HST/lfib3aj7q/lfib3aj7q_x1d.fits | COMPLETE | None | None |
cos_data/mastDownload/HST/lfic3aggq/lfic3aggq_x1d.fits | COMPLETE | None | None |
cos_data/mastDownload/HST/lfic3ahiq/lfic3ahiq_x1d.fits | COMPLETE | None | None |
When we download data using astroquery, it creates a directory called mastDownload/HST. Each dataset goes into a separate subfolder within that directory. Before running the combination script, we must move all of the x1d files into a single directory.
# The path to all obs_id folders
mast_path = f"{cos_data_dir}/mastDownload/HST/"
# Check if mastDownload exists
if not os.path.exists(mast_path):
print(f"Directory {mast_path} doesn't exist.")
# Getting a list of all obs_id folders. Each folder contains the FITS files
obs_id_dirs = os.listdir(mast_path)
# Iterating through sub-folders to change the path of each FITS file
for obs_id in obs_id_dirs:
# This is the path to each obs_id folder
obs_id_path = os.path.join(mast_path, obs_id)
# Getting list of FITS files in /mastDownload/HST/<obs_id> folder
cos_files = glob.glob(obs_id_path + "/*fits")
# Iterating through each of these files to change their path individually
# We will be moving them to /cos_data
for file in cos_files:
file_path = Path(file)
new_path = cos_data_dir / file_path.name
shutil.move(file, new_path)
# Now we can remove the mastDownload directory
if os.path.exists(mast_path):
shutil.rmtree(f"{cos_data_dir}/mastDownload/")
We want only the files taken at lifetime positions 1 and 4 and with CENWAVE > 1250, so delete everything else.
cos_files = glob.glob('./cos_data/*fits')
for file in cos_files:
hdr = fits.getheader(file)
cenwave = hdr['CENWAVE']
life_adj = hdr['LIFE_ADJ']
if (cenwave < 1250):
os.remove(file)
continue
if not ((life_adj == 1) or (life_adj == 4)):
os.remove(file)
Now that we’ve retrieved and filtered the spectra, we can run the co-add script.
In a terminal window, execute the following command (or run the cell below).
swrapper -i cos_data -o cos_products -x
The -i parameter is the input directory (i.e, where the FITS files are located), while -o indicates the directory that will contain the newly created co-added products. -x tells the program to keep the intermediate products.
Make sure that you are in the hasp-env conda environment that we created at the beginning of the notebook.
! swrapper -i cos_data -o cos_products -x
HASP version 1.2.0
Ullyses version 4.1.0
Creating list of unique modes from these files:
cos_data/lbnm02a2q_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/lbnm02a4q_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/lbnm02a6q_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/lbnm02arq_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/lbnm02auq_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/lbnm02awq_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/lbnm02ayq_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/lbnm02b0q_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/lbnm02b2q_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/lbnm02b4q_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/lbnm02b6q_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/lbnm02b8q_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/lbnm02baq_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/lbnm02bcq_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/lbnm02zmq_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/lbnm02zsq_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/lbnm02zvq_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/lbnm02zxq_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/lbnm02zzq_x1d.fits WD-0308-565 COS FUV G130M PSA 1 12426 (12426, '02')
cos_data/ldcv22wrq_x1d.fits WD0308-565 COS FUV G130M PSA 4 14854 (14854, '22')
cos_data/ldcv22x1q_x1d.fits WD0308-565 COS FUV G130M PSA 4 14854 (14854, '22')
cos_data/ldel01oyq_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '01')
cos_data/ldel01p0q_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '01')
cos_data/ldel01p2q_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '01')
cos_data/ldel01p4q_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '01')
cos_data/ldel01peq_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '01')
cos_data/ldel01pgq_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '01')
cos_data/ldel01piq_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '01')
cos_data/ldel01pkq_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '01')
cos_data/ldel02ctq_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '02')
cos_data/ldel02cvq_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '02')
cos_data/ldel02cxq_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '02')
cos_data/ldel02czq_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '02')
cos_data/ldel02d1q_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '02')
cos_data/ldel02d3q_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '02')
cos_data/ldel02d5q_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '02')
cos_data/ldel02d7q_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '02')
cos_data/ldel02d9q_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '02')
cos_data/ldel02dbq_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '02')
cos_data/ldel02ddq_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '02')
cos_data/ldel02dfq_x1d.fits WD0308-565 COS FUV G130M PSA 4 14910 (14910, '02')
cos_data/ldqj01moq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15384 (15384, '01')
cos_data/ldqj01ncq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15384 (15384, '01')
cos_data/ldqj03hyq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15384 (15384, '03')
cos_data/ldqj03igq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15384 (15384, '03')
cos_data/ldqj05xwq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15384 (15384, '05')
cos_data/ldqj05yoq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15384 (15384, '05')
cos_data/ldqj07xvq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15384 (15384, '07')
cos_data/ldqj07y7q_x1d.fits WD0308-565 COS FUV G130M PSA 4 15384 (15384, '07')
cos_data/ldqj08izq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15384 (15384, '08')
cos_data/ldqj08jdq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15384 (15384, '08')
cos_data/ldqj10dgq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15384 (15384, '10')
cos_data/ldqj10dsq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15384 (15384, '10')
cos_data/ldqj55xkq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15384 (15384, '55')
cos_data/ldqj55xwq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15384 (15384, '55')
cos_data/ldv001ixq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15535 (15535, '01')
cos_data/ldv001kaq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15535 (15535, '01')
cos_data/ldv003ddq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15535 (15535, '03')
cos_data/ldv005g2q_x1d.fits WD0308-565 COS FUV G130M PSA 4 15535 (15535, '05')
cos_data/ldv005gjq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15535 (15535, '05')
cos_data/ldv007p8q_x1d.fits WD0308-565 COS FUV G130M PSA 4 15535 (15535, '07')
cos_data/ldv007pmq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15535 (15535, '07')
cos_data/ldv008orq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15535 (15535, '08')
cos_data/ldv010etq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15535 (15535, '10')
cos_data/ldv010fvq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15535 (15535, '10')
cos_data/ldv053mwq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15535 (15535, '53')
cos_data/ldv053naq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15535 (15535, '53')
cos_data/ldv057a9q_x1d.fits WD0308-565 COS FUV G130M PSA 4 15535 (15535, '57')
cos_data/ldv057ysq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15535 (15535, '57')
cos_data/ldv058b2q_x1d.fits WD0308-565 COS FUV G130M PSA 4 15535 (15535, '58')
cos_data/ldv058cbq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15535 (15535, '58')
cos_data/ldv060dbq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15535 (15535, '60')
cos_data/ldv060e2q_x1d.fits WD0308-565 COS FUV G130M PSA 4 15535 (15535, '60')
cos_data/le5g01f4q_x1d.fits WD0308-565 COS FUV G130M PSA 4 15773 (15773, '01')
cos_data/le5g01foq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15773 (15773, '01')
cos_data/le5g05ppq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15773 (15773, '05')
cos_data/le5g05r4q_x1d.fits WD0308-565 COS FUV G130M PSA 4 15773 (15773, '05')
cos_data/le5g07mlq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15773 (15773, '07')
cos_data/le5g07naq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15773 (15773, '07')
cos_data/le5g08lyq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15773 (15773, '08')
cos_data/le5g10k3q_x1d.fits WD0308-565 COS FUV G130M PSA 4 15773 (15773, '10')
cos_data/le5g10l5q_x1d.fits WD0308-565 COS FUV G130M PSA 4 15773 (15773, '10')
cos_data/le5g53bxq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15773 (15773, '53')
cos_data/le5g53deq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15773 (15773, '53')
cos_data/le5g57ljq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15773 (15773, '57')
cos_data/le5g58bcq_x1d.fits WD0308-565 COS FUV G130M PSA 4 15773 (15773, '58')
cos_data/lefe01poq_x1d.fits WD0308-565 COS FUV G130M PSA 4 16324 (16324, '01')
cos_data/lefe01q3q_x1d.fits WD0308-565 COS FUV G130M PSA 4 16324 (16324, '01')
cos_data/lefe03goq_x1d.fits WD0308-565 COS FUV G130M PSA 4 16324 (16324, '03')
cos_data/lefe05o0q_x1d.fits WD0308-565 COS FUV G130M PSA 4 16324 (16324, '05')
cos_data/lefe05piq_x1d.fits WD0308-565 COS FUV G130M PSA 4 16324 (16324, '05')
cos_data/lefe07lnq_x1d.fits WD0308-565 COS FUV G130M PSA 4 16324 (16324, '07')
cos_data/lefe07m3q_x1d.fits WD0308-565 COS FUV G130M PSA 4 16324 (16324, '07')
cos_data/lefe08oyq_x1d.fits WD0308-565 COS FUV G130M PSA 4 16324 (16324, '08')
cos_data/lefe08pdq_x1d.fits WD0308-565 COS FUV G130M PSA 4 16324 (16324, '08')
cos_data/lefe53edq_x1d.fits WD0308-565 COS FUV G130M PSA 4 16324 (16324, '53')
cos_data/lefe53erq_x1d.fits WD0308-565 COS FUV G130M PSA 4 16324 (16324, '53')
cos_data/ler107a7q_x1d.fits WD0308-565 COS FUV G130M PSA 4 16830 (16830, '07')
cos_data/ler15bhaq_x1d.fits WD0308-565 COS FUV G130M PSA 4 16830 (16830, '5b')
[('COS', 'G130M', 'FUV', 1), ('COS', 'G130M', 'FUV', 4)]
[('COS', 'G130M', 'FUV')]
Creating cross-program products for target cos_data
Processing grating COS/G130M at lifetime position 1
Importing files ['cos_data/lbnm02a2q_x1d.fits', 'cos_data/lbnm02a4q_x1d.fits', 'cos_data/lbnm02a6q_x1d.fits', 'cos_data/lbnm02arq_x1d.fits', 'cos_data/lbnm02auq_x1d.fits', 'cos_data/lbnm02awq_x1d.fits', 'cos_data/lbnm02ayq_x1d.fits', 'cos_data/lbnm02b0q_x1d.fits', 'cos_data/lbnm02b2q_x1d.fits', 'cos_data/lbnm02b4q_x1d.fits', 'cos_data/lbnm02b6q_x1d.fits', 'cos_data/lbnm02b8q_x1d.fits', 'cos_data/lbnm02baq_x1d.fits', 'cos_data/lbnm02bcq_x1d.fits', 'cos_data/lbnm02zmq_x1d.fits', 'cos_data/lbnm02zsq_x1d.fits', 'cos_data/lbnm02zvq_x1d.fits', 'cos_data/lbnm02zxq_x1d.fits', 'cos_data/lbnm02zzq_x1d.fits']
Processing file cos_data/lbnm02a2q_x1d.fits
Processing file cos_data/lbnm02a4q_x1d.fits
Processing file cos_data/lbnm02a6q_x1d.fits
Processing file cos_data/lbnm02arq_x1d.fits
Processing file cos_data/lbnm02auq_x1d.fits
Processing file cos_data/lbnm02awq_x1d.fits
Processing file cos_data/lbnm02ayq_x1d.fits
Processing file cos_data/lbnm02b0q_x1d.fits
Processing file cos_data/lbnm02b2q_x1d.fits
Processing file cos_data/lbnm02b4q_x1d.fits
Processing file cos_data/lbnm02b6q_x1d.fits
Processing file cos_data/lbnm02b8q_x1d.fits
Processing file cos_data/lbnm02baq_x1d.fits
Processing file cos_data/lbnm02bcq_x1d.fits
Processing file cos_data/lbnm02zmq_x1d.fits
Processing file cos_data/lbnm02zsq_x1d.fits
Processing file cos_data/lbnm02zvq_x1d.fits
Processing file cos_data/lbnm02zxq_x1d.fits
Processing file cos_data/lbnm02zzq_x1d.fits
/home/runner/micromamba/envs/hstcal/lib/python3.12/site-packages/ullyses/coadd.py:563: RuntimeWarning: invalid value encountered in divide
thru_nans = segment.data['net'] / segment.data['flux']
Using a maximum SNR of 20.0 in flux-based filtering
WARNING: VerifyWarning: Card is too long, comment will be truncated. [astropy.io.fits.card]
Wrote cos_products/hst_cos_cos-data_g130m_lp01_cspec.fits
Processing grating COS/G130M at lifetime position 4
Importing files ['cos_data/ldcv22wrq_x1d.fits', 'cos_data/ldcv22x1q_x1d.fits', 'cos_data/ldel01oyq_x1d.fits', 'cos_data/ldel01p0q_x1d.fits', 'cos_data/ldel01p2q_x1d.fits', 'cos_data/ldel01p4q_x1d.fits', 'cos_data/ldel01peq_x1d.fits', 'cos_data/ldel01pgq_x1d.fits', 'cos_data/ldel01piq_x1d.fits', 'cos_data/ldel01pkq_x1d.fits', 'cos_data/ldel02ctq_x1d.fits', 'cos_data/ldel02cvq_x1d.fits', 'cos_data/ldel02cxq_x1d.fits', 'cos_data/ldel02czq_x1d.fits', 'cos_data/ldel02d1q_x1d.fits', 'cos_data/ldel02d3q_x1d.fits', 'cos_data/ldel02d5q_x1d.fits', 'cos_data/ldel02d7q_x1d.fits', 'cos_data/ldel02d9q_x1d.fits', 'cos_data/ldel02dbq_x1d.fits', 'cos_data/ldel02ddq_x1d.fits', 'cos_data/ldel02dfq_x1d.fits', 'cos_data/ldqj01moq_x1d.fits', 'cos_data/ldqj01ncq_x1d.fits', 'cos_data/ldqj03hyq_x1d.fits', 'cos_data/ldqj03igq_x1d.fits', 'cos_data/ldqj05xwq_x1d.fits', 'cos_data/ldqj05yoq_x1d.fits', 'cos_data/ldqj07xvq_x1d.fits', 'cos_data/ldqj07y7q_x1d.fits', 'cos_data/ldqj08izq_x1d.fits', 'cos_data/ldqj08jdq_x1d.fits', 'cos_data/ldqj10dgq_x1d.fits', 'cos_data/ldqj10dsq_x1d.fits', 'cos_data/ldqj55xkq_x1d.fits', 'cos_data/ldqj55xwq_x1d.fits', 'cos_data/ldv001ixq_x1d.fits', 'cos_data/ldv001kaq_x1d.fits', 'cos_data/ldv003ddq_x1d.fits', 'cos_data/ldv005g2q_x1d.fits', 'cos_data/ldv005gjq_x1d.fits', 'cos_data/ldv007p8q_x1d.fits', 'cos_data/ldv007pmq_x1d.fits', 'cos_data/ldv008orq_x1d.fits', 'cos_data/ldv010etq_x1d.fits', 'cos_data/ldv010fvq_x1d.fits', 'cos_data/ldv053mwq_x1d.fits', 'cos_data/ldv053naq_x1d.fits', 'cos_data/ldv057a9q_x1d.fits', 'cos_data/ldv057ysq_x1d.fits', 'cos_data/ldv058b2q_x1d.fits', 'cos_data/ldv058cbq_x1d.fits', 'cos_data/ldv060dbq_x1d.fits', 'cos_data/ldv060e2q_x1d.fits', 'cos_data/le5g01f4q_x1d.fits', 'cos_data/le5g01foq_x1d.fits', 'cos_data/le5g05ppq_x1d.fits', 'cos_data/le5g05r4q_x1d.fits', 'cos_data/le5g07mlq_x1d.fits', 'cos_data/le5g07naq_x1d.fits', 'cos_data/le5g08lyq_x1d.fits', 'cos_data/le5g10k3q_x1d.fits', 'cos_data/le5g10l5q_x1d.fits', 'cos_data/le5g53bxq_x1d.fits', 'cos_data/le5g53deq_x1d.fits', 'cos_data/le5g57ljq_x1d.fits', 'cos_data/le5g58bcq_x1d.fits', 'cos_data/lefe01poq_x1d.fits', 'cos_data/lefe01q3q_x1d.fits', 'cos_data/lefe03goq_x1d.fits', 'cos_data/lefe05o0q_x1d.fits', 'cos_data/lefe05piq_x1d.fits', 'cos_data/lefe07lnq_x1d.fits', 'cos_data/lefe07m3q_x1d.fits', 'cos_data/lefe08oyq_x1d.fits', 'cos_data/lefe08pdq_x1d.fits', 'cos_data/lefe53edq_x1d.fits', 'cos_data/lefe53erq_x1d.fits', 'cos_data/ler107a7q_x1d.fits', 'cos_data/ler15bhaq_x1d.fits']
Processing file cos_data/ldcv22wrq_x1d.fits
Processing file cos_data/ldcv22x1q_x1d.fits
Processing file cos_data/ldel01oyq_x1d.fits
Processing file cos_data/ldel01p0q_x1d.fits
Processing file cos_data/ldel01p2q_x1d.fits
Processing file cos_data/ldel01p4q_x1d.fits
Processing file cos_data/ldel01peq_x1d.fits
Processing file cos_data/ldel01pgq_x1d.fits
Processing file cos_data/ldel01piq_x1d.fits
Processing file cos_data/ldel01pkq_x1d.fits
Processing file cos_data/ldel02ctq_x1d.fits
Processing file cos_data/ldel02cvq_x1d.fits
Processing file cos_data/ldel02cxq_x1d.fits
Processing file cos_data/ldel02czq_x1d.fits
Processing file cos_data/ldel02d1q_x1d.fits
Processing file cos_data/ldel02d3q_x1d.fits
Processing file cos_data/ldel02d5q_x1d.fits
Processing file cos_data/ldel02d7q_x1d.fits
Processing file cos_data/ldel02d9q_x1d.fits
Processing file cos_data/ldel02dbq_x1d.fits
Processing file cos_data/ldel02ddq_x1d.fits
Processing file cos_data/ldel02dfq_x1d.fits
Processing file cos_data/ldqj01moq_x1d.fits
Processing file cos_data/ldqj01ncq_x1d.fits
Processing file cos_data/ldqj03hyq_x1d.fits
Processing file cos_data/ldqj03igq_x1d.fits
Processing file cos_data/ldqj05xwq_x1d.fits
Processing file cos_data/ldqj05yoq_x1d.fits
Processing file cos_data/ldqj07xvq_x1d.fits
Processing file cos_data/ldqj07y7q_x1d.fits
Processing file cos_data/ldqj08izq_x1d.fits
Processing file cos_data/ldqj08jdq_x1d.fits
Processing file cos_data/ldqj10dgq_x1d.fits
Processing file cos_data/ldqj10dsq_x1d.fits
Processing file cos_data/ldqj55xkq_x1d.fits
Processing file cos_data/ldqj55xwq_x1d.fits
Processing file cos_data/ldv001ixq_x1d.fits
Processing file cos_data/ldv001kaq_x1d.fits
Processing file cos_data/ldv003ddq_x1d.fits
Processing file cos_data/ldv005g2q_x1d.fits
Processing file cos_data/ldv005gjq_x1d.fits
Processing file cos_data/ldv007p8q_x1d.fits
Processing file cos_data/ldv007pmq_x1d.fits
Processing file cos_data/ldv008orq_x1d.fits
Processing file cos_data/ldv010etq_x1d.fits
Processing file cos_data/ldv010fvq_x1d.fits
Processing file cos_data/ldv053mwq_x1d.fits
Processing file cos_data/ldv053naq_x1d.fits
Processing file cos_data/ldv057a9q_x1d.fits
Processing file cos_data/ldv057ysq_x1d.fits
Processing file cos_data/ldv058b2q_x1d.fits
Processing file cos_data/ldv058cbq_x1d.fits
Processing file cos_data/ldv060dbq_x1d.fits
Processing file cos_data/ldv060e2q_x1d.fits
Processing file cos_data/le5g01f4q_x1d.fits
Processing file cos_data/le5g01foq_x1d.fits
Processing file cos_data/le5g05ppq_x1d.fits
Processing file cos_data/le5g05r4q_x1d.fits
Processing file cos_data/le5g07mlq_x1d.fits
Processing file cos_data/le5g07naq_x1d.fits
Processing file cos_data/le5g08lyq_x1d.fits
Processing file cos_data/le5g10k3q_x1d.fits
Processing file cos_data/le5g10l5q_x1d.fits
Processing file cos_data/le5g53bxq_x1d.fits
Processing file cos_data/le5g53deq_x1d.fits
Processing file cos_data/le5g57ljq_x1d.fits
Processing file cos_data/le5g58bcq_x1d.fits
Processing file cos_data/lefe01poq_x1d.fits
Processing file cos_data/lefe01q3q_x1d.fits
Processing file cos_data/lefe03goq_x1d.fits
Processing file cos_data/lefe05o0q_x1d.fits
Processing file cos_data/lefe05piq_x1d.fits
Processing file cos_data/lefe07lnq_x1d.fits
Processing file cos_data/lefe07m3q_x1d.fits
Processing file cos_data/lefe08oyq_x1d.fits
Processing file cos_data/lefe08pdq_x1d.fits
Processing file cos_data/lefe53edq_x1d.fits
Processing file cos_data/lefe53erq_x1d.fits
Processing file cos_data/ler107a7q_x1d.fits
Processing file cos_data/ler15bhaq_x1d.fits
/home/runner/micromamba/envs/hstcal/lib/python3.12/site-packages/ullyses/coadd.py:563: RuntimeWarning: invalid value encountered in divide
thru_nans = segment.data['net'] / segment.data['flux']
Using a maximum SNR of 20.0 in flux-based filtering
Wrote cos_products/hst_cos_cos-data_g130m_lp04_cspec.fits
[('COS', 'G130M', 'FUV')]
[]
Creating cross-program products for target cos_data
Processing grating COS/G130M
Importing files ['cos_data/lbnm02a2q_x1d.fits', 'cos_data/lbnm02a4q_x1d.fits', 'cos_data/lbnm02a6q_x1d.fits', 'cos_data/lbnm02arq_x1d.fits', 'cos_data/lbnm02auq_x1d.fits', 'cos_data/lbnm02awq_x1d.fits', 'cos_data/lbnm02ayq_x1d.fits', 'cos_data/lbnm02b0q_x1d.fits', 'cos_data/lbnm02b2q_x1d.fits', 'cos_data/lbnm02b4q_x1d.fits', 'cos_data/lbnm02b6q_x1d.fits', 'cos_data/lbnm02b8q_x1d.fits', 'cos_data/lbnm02baq_x1d.fits', 'cos_data/lbnm02bcq_x1d.fits', 'cos_data/lbnm02zmq_x1d.fits', 'cos_data/lbnm02zsq_x1d.fits', 'cos_data/lbnm02zvq_x1d.fits', 'cos_data/lbnm02zxq_x1d.fits', 'cos_data/lbnm02zzq_x1d.fits', 'cos_data/ldcv22wrq_x1d.fits', 'cos_data/ldcv22x1q_x1d.fits', 'cos_data/ldel01oyq_x1d.fits', 'cos_data/ldel01p0q_x1d.fits', 'cos_data/ldel01p2q_x1d.fits', 'cos_data/ldel01p4q_x1d.fits', 'cos_data/ldel01peq_x1d.fits', 'cos_data/ldel01pgq_x1d.fits', 'cos_data/ldel01piq_x1d.fits', 'cos_data/ldel01pkq_x1d.fits', 'cos_data/ldel02ctq_x1d.fits', 'cos_data/ldel02cvq_x1d.fits', 'cos_data/ldel02cxq_x1d.fits', 'cos_data/ldel02czq_x1d.fits', 'cos_data/ldel02d1q_x1d.fits', 'cos_data/ldel02d3q_x1d.fits', 'cos_data/ldel02d5q_x1d.fits', 'cos_data/ldel02d7q_x1d.fits', 'cos_data/ldel02d9q_x1d.fits', 'cos_data/ldel02dbq_x1d.fits', 'cos_data/ldel02ddq_x1d.fits', 'cos_data/ldel02dfq_x1d.fits', 'cos_data/ldqj01moq_x1d.fits', 'cos_data/ldqj01ncq_x1d.fits', 'cos_data/ldqj03hyq_x1d.fits', 'cos_data/ldqj03igq_x1d.fits', 'cos_data/ldqj05xwq_x1d.fits', 'cos_data/ldqj05yoq_x1d.fits', 'cos_data/ldqj07xvq_x1d.fits', 'cos_data/ldqj07y7q_x1d.fits', 'cos_data/ldqj08izq_x1d.fits', 'cos_data/ldqj08jdq_x1d.fits', 'cos_data/ldqj10dgq_x1d.fits', 'cos_data/ldqj10dsq_x1d.fits', 'cos_data/ldqj55xkq_x1d.fits', 'cos_data/ldqj55xwq_x1d.fits', 'cos_data/ldv001ixq_x1d.fits', 'cos_data/ldv001kaq_x1d.fits', 'cos_data/ldv003ddq_x1d.fits', 'cos_data/ldv005g2q_x1d.fits', 'cos_data/ldv005gjq_x1d.fits', 'cos_data/ldv007p8q_x1d.fits', 'cos_data/ldv007pmq_x1d.fits', 'cos_data/ldv008orq_x1d.fits', 'cos_data/ldv010etq_x1d.fits', 'cos_data/ldv010fvq_x1d.fits', 'cos_data/ldv053mwq_x1d.fits', 'cos_data/ldv053naq_x1d.fits', 'cos_data/ldv057a9q_x1d.fits', 'cos_data/ldv057ysq_x1d.fits', 'cos_data/ldv058b2q_x1d.fits', 'cos_data/ldv058cbq_x1d.fits', 'cos_data/ldv060dbq_x1d.fits', 'cos_data/ldv060e2q_x1d.fits', 'cos_data/le5g01f4q_x1d.fits', 'cos_data/le5g01foq_x1d.fits', 'cos_data/le5g05ppq_x1d.fits', 'cos_data/le5g05r4q_x1d.fits', 'cos_data/le5g07mlq_x1d.fits', 'cos_data/le5g07naq_x1d.fits', 'cos_data/le5g08lyq_x1d.fits', 'cos_data/le5g10k3q_x1d.fits', 'cos_data/le5g10l5q_x1d.fits', 'cos_data/le5g53bxq_x1d.fits', 'cos_data/le5g53deq_x1d.fits', 'cos_data/le5g57ljq_x1d.fits', 'cos_data/le5g58bcq_x1d.fits', 'cos_data/lefe01poq_x1d.fits', 'cos_data/lefe01q3q_x1d.fits', 'cos_data/lefe03goq_x1d.fits', 'cos_data/lefe05o0q_x1d.fits', 'cos_data/lefe05piq_x1d.fits', 'cos_data/lefe07lnq_x1d.fits', 'cos_data/lefe07m3q_x1d.fits', 'cos_data/lefe08oyq_x1d.fits', 'cos_data/lefe08pdq_x1d.fits', 'cos_data/lefe53edq_x1d.fits', 'cos_data/lefe53erq_x1d.fits', 'cos_data/ler107a7q_x1d.fits', 'cos_data/ler15bhaq_x1d.fits']
Processing file cos_data/lbnm02a2q_x1d.fits
Processing file cos_data/lbnm02a4q_x1d.fits
Processing file cos_data/lbnm02a6q_x1d.fits
Processing file cos_data/lbnm02arq_x1d.fits
Processing file cos_data/lbnm02auq_x1d.fits
Processing file cos_data/lbnm02awq_x1d.fits
Processing file cos_data/lbnm02ayq_x1d.fits
Processing file cos_data/lbnm02b0q_x1d.fits
Processing file cos_data/lbnm02b2q_x1d.fits
Processing file cos_data/lbnm02b4q_x1d.fits
Processing file cos_data/lbnm02b6q_x1d.fits
Processing file cos_data/lbnm02b8q_x1d.fits
Processing file cos_data/lbnm02baq_x1d.fits
Processing file cos_data/lbnm02bcq_x1d.fits
Processing file cos_data/lbnm02zmq_x1d.fits
Processing file cos_data/lbnm02zsq_x1d.fits
Processing file cos_data/lbnm02zvq_x1d.fits
Processing file cos_data/lbnm02zxq_x1d.fits
Processing file cos_data/lbnm02zzq_x1d.fits
Processing file cos_data/ldcv22wrq_x1d.fits
Processing file cos_data/ldcv22x1q_x1d.fits
Processing file cos_data/ldel01oyq_x1d.fits
Processing file cos_data/ldel01p0q_x1d.fits
Processing file cos_data/ldel01p2q_x1d.fits
Processing file cos_data/ldel01p4q_x1d.fits
Processing file cos_data/ldel01peq_x1d.fits
Processing file cos_data/ldel01pgq_x1d.fits
Processing file cos_data/ldel01piq_x1d.fits
Processing file cos_data/ldel01pkq_x1d.fits
Processing file cos_data/ldel02ctq_x1d.fits
Processing file cos_data/ldel02cvq_x1d.fits
Processing file cos_data/ldel02cxq_x1d.fits
Processing file cos_data/ldel02czq_x1d.fits
Processing file cos_data/ldel02d1q_x1d.fits
Processing file cos_data/ldel02d3q_x1d.fits
Processing file cos_data/ldel02d5q_x1d.fits
Processing file cos_data/ldel02d7q_x1d.fits
Processing file cos_data/ldel02d9q_x1d.fits
Processing file cos_data/ldel02dbq_x1d.fits
Processing file cos_data/ldel02ddq_x1d.fits
Processing file cos_data/ldel02dfq_x1d.fits
Processing file cos_data/ldqj01moq_x1d.fits
Processing file cos_data/ldqj01ncq_x1d.fits
Processing file cos_data/ldqj03hyq_x1d.fits
Processing file cos_data/ldqj03igq_x1d.fits
Processing file cos_data/ldqj05xwq_x1d.fits
Processing file cos_data/ldqj05yoq_x1d.fits
Processing file cos_data/ldqj07xvq_x1d.fits
Processing file cos_data/ldqj07y7q_x1d.fits
Processing file cos_data/ldqj08izq_x1d.fits
Processing file cos_data/ldqj08jdq_x1d.fits
Processing file cos_data/ldqj10dgq_x1d.fits
Processing file cos_data/ldqj10dsq_x1d.fits
Processing file cos_data/ldqj55xkq_x1d.fits
Processing file cos_data/ldqj55xwq_x1d.fits
Processing file cos_data/ldv001ixq_x1d.fits
Processing file cos_data/ldv001kaq_x1d.fits
Processing file cos_data/ldv003ddq_x1d.fits
Processing file cos_data/ldv005g2q_x1d.fits
Processing file cos_data/ldv005gjq_x1d.fits
Processing file cos_data/ldv007p8q_x1d.fits
Processing file cos_data/ldv007pmq_x1d.fits
Processing file cos_data/ldv008orq_x1d.fits
Processing file cos_data/ldv010etq_x1d.fits
Processing file cos_data/ldv010fvq_x1d.fits
Processing file cos_data/ldv053mwq_x1d.fits
Processing file cos_data/ldv053naq_x1d.fits
Processing file cos_data/ldv057a9q_x1d.fits
Processing file cos_data/ldv057ysq_x1d.fits
Processing file cos_data/ldv058b2q_x1d.fits
Processing file cos_data/ldv058cbq_x1d.fits
Processing file cos_data/ldv060dbq_x1d.fits
Processing file cos_data/ldv060e2q_x1d.fits
Processing file cos_data/le5g01f4q_x1d.fits
Processing file cos_data/le5g01foq_x1d.fits
Processing file cos_data/le5g05ppq_x1d.fits
Processing file cos_data/le5g05r4q_x1d.fits
Processing file cos_data/le5g07mlq_x1d.fits
Processing file cos_data/le5g07naq_x1d.fits
Processing file cos_data/le5g08lyq_x1d.fits
Processing file cos_data/le5g10k3q_x1d.fits
Processing file cos_data/le5g10l5q_x1d.fits
Processing file cos_data/le5g53bxq_x1d.fits
Processing file cos_data/le5g53deq_x1d.fits
Processing file cos_data/le5g57ljq_x1d.fits
Processing file cos_data/le5g58bcq_x1d.fits
Processing file cos_data/lefe01poq_x1d.fits
Processing file cos_data/lefe01q3q_x1d.fits
Processing file cos_data/lefe03goq_x1d.fits
Processing file cos_data/lefe05o0q_x1d.fits
Processing file cos_data/lefe05piq_x1d.fits
Processing file cos_data/lefe07lnq_x1d.fits
Processing file cos_data/lefe07m3q_x1d.fits
Processing file cos_data/lefe08oyq_x1d.fits
Processing file cos_data/lefe08pdq_x1d.fits
Processing file cos_data/lefe53edq_x1d.fits
Processing file cos_data/lefe53erq_x1d.fits
Processing file cos_data/ler107a7q_x1d.fits
Processing file cos_data/ler15bhaq_x1d.fits
Using a maximum SNR of 20.0 in flux-based filtering
Making a product from these gratings
COS/G130M 900-1470 (Actual: 1132.2-1472.2)
Transition wavelengths tweaked
Starting at the short wavelength end with grating COS/G130M
Truncating current grating at 1470
Wrote cos_products/hst_cos-data_aspec.fits
# Read the combined spectra for each lifetime position.
tbdata = fits.getdata('cos_products/hst_cos_cos-data_g130m_lp01_cspec.fits')
lp1_wave = tbdata['wavelength'][0]
lp1_flux = tbdata['flux'][0]
lp1_exp = tbdata['eff_exptime'][0]
tbdata = fits.getdata('cos_products/hst_cos_cos-data_g130m_lp04_cspec.fits')
lp4_wave = tbdata['wavelength'][0]
lp4_flux = tbdata['flux'][0]
lp4_exp = tbdata['eff_exptime'][0]
# Plot the spectra.
f, ax = plt.subplots()
ax.plot(lp1_wave, lp1_flux, label='LP1')
ax.plot(lp4_wave, lp4_flux, label='LP4')
ax.legend()
ax.set_xlim(1333, 1338)
ax.set_ylim([0, 3e-13])
ax.set_xlabel('Wavelength ($\\mathrm{\\AA}$)')
ax.set_ylabel('Flux (erg cm$^{-2}$ s$^{-1}$ $\\mathrm{\\AA}^{-1}$)')
Text(0, 0.5, 'Flux (erg cm$^{-2}$ s$^{-1}$ $\\mathrm{\\AA}^{-1}$)')

4.2 Fit each combination of grating, LSF, and CENWAVE separately#
When dealing with spectra obtained using multiple instrument configurations, the most accurate results are produced, not by summing the spectra to maximize the S/N ratio, but by fitting each spectrum separately, using the LSF appropriate for that configuration. In this example, we could either fit our models to the LP1 and LP4 spectra separately and average the results or tweak our code to fit the two spectra simultaneously. In either case, we would use the LSF for CENWAVE 1339 (the average CENWAVE for the red modes) and the appropriate lifetime position.
4.3 Convolve the LP1 Spectrum to Match LP4#
Another approach is to reduce the resolution of the LP1 spectrum to match that of the LP4 spectrum. We use the LSFs of the two spectra to derive a Gaussian that converts the LSF for LP1 into that for LP2, then convolve the LP1 spectrum with this Gaussian.
# We are interested in lines near 1335 A, so let's read the corresponding LSFs.
lsf_lp1, res_lp1, fwhm_lp1 = get_lsf('LSF/aa_LSFTable_G130M_1309_LP1_cn.dat', 1333)
lsf_lp4, res_lp4, fwhm_lp4 = get_lsf('LSF/aa_LSFTable_G130M_1309_LP4_cn.dat', 1333)
lsf_wave = 0.01 * (np.arange(321) - 160)
f, ax = plt.subplots()
ax.plot(lsf_wave, lsf_lp1, label='LP1')
ax.plot(lsf_wave, lsf_lp4, label='LP4')
ax.legend()
ax.set_xlim(-0.3, 0.3)
(-0.3, 0.3)

# Construct an LSF object to hold the LP1 LSF, Then find the Gaussian that,
# when convolved with the LP1 LSF, best reproduces LP4.
s = LSF()
s.add_lsf(lsf_wave, lsf_lp1)
p0 = [1.]
popt, pcov = curve_fit(s.my_func, lsf_wave, lsf_lp4, p0=p0)
sigma = popt[0]
convolution = s.my_func(lsf_wave, sigma)
print('sigma = ', sigma)
sigma = 2.581628603998546
# In this plot, the curve labeled "Convolution" is the LP1 LSF convolved with a Gaussian to reproduce the LP4 LSF.
f, ax = plt.subplots()
ax.plot(lsf_wave, lsf_lp1, label='LP1')
ax.plot(lsf_wave, lsf_lp4, label='LP4')
ax.plot(lsf_wave, convolution, label='Convolution')
ax.legend()
ax.set_xlabel('Wavelength ($\\mathrm{\\AA}$)')
ax.set_xlim(-0.3, 0.3)
(-0.3, 0.3)

# Plot the residuals.
res = lsf_lp4 - convolution
f, ax = plt.subplots()
plt.plot(lsf_wave, res)
ax.set_xlim([-0.3, 0.3])
ax.set_xlabel('Wavelength ($\\mathrm{\\AA}$)')
r1 = res
# The largest deviation is about 8%.
# It may be possible to devise a kernel that does a better job, but this is fine for now.

# Now convolve the LP1 spectrum with our best-fit Gaussian.
gauss = get_gaussian(sigma)
out = convolve(lp1_flux, gauss)
# Plot the smoothed LP1 spectrum and the LP4 spectrum.
f, ax = plt.subplots()
plt.plot(lp1_wave, out, label='Smoothed LP1')
plt.plot(lp4_wave, lp4_flux, label='LP4')
ax.legend()
ax.set_xlim(1333, 1338)
ax.set_ylim([0, 3e-13])
ax.set_ylabel('Flux ($10^{-13}$ erg cm$^{-2}$ s$^{-1}$ $\\mathrm{\\AA}^{-1}$)')
ax.set_xlabel('Wavelength ($\\mathrm{\\AA}$)')
Text(0.5, 0, 'Wavelength ($\\mathrm{\\AA}$)')

The good thing about this approach is that, in the region of overlap, the tabulated LP4 LSF functions can be used without modification. The bad thing is that convolution by a Gaussian this broad smooths the data to an unacceptable degree. Also, when the data are smoothed, the pixel values are no longer independent, and the errors are correlated. Given these problems, this approach is not recommended.
4.4 Construct a bespoke LSF for this spectral combination#
The third option is to sum the two spectra and construct a new LSF to match. We already have the summed spectrum. It is the final product of the coadd script.
Note that this spectrum contains only LP1 and LP4 data taken in the standard modes (CENWAVE > 1250 A). A spectrum retrieved from MAST would contain data from all lifetime positions and central wavelengths.
tbdata = fits.getdata('cos_products/hst_cos-data_aspec.fits')
combo_wave = tbdata['wavelength'][0]
combo_flux = tbdata['flux'][0]
# Determine the exposure times for each lifetime position.
lp1_exptime = np.mean(lp1_exp[np.where((lp1_wave > 1333) & (lp1_wave < 1338))])
lp4_exptime = np.mean(lp4_exp[np.where((lp4_wave > 1333) & (lp4_wave < 1338))])
print('LP1 exposure time:', lp1_exptime)
print('LP4 exposure time:', lp4_exptime)
LP1 exposure time: 9155.763
LP4 exposure time: 26851.396
# Plot the individual and combined spectra.
f, ax = plt.subplots()
ax.plot(combo_wave, combo_flux, label='Combo')
ax.plot(lp1_wave, lp1_flux, label='LP1')
ax.plot(lp4_wave, lp4_flux, label='LP4')
ax.set_xlim(1333, 1338)
ax.set_ylim([0, 3e-13])
ax.set_ylabel('Flux ($10^{-13}$ erg cm$^{-2}$ s$^{-1}$ $\\mathrm{\\AA}^{-1}$)')
ax.set_xlabel('Wavelength ($\\mathrm{\\AA}$)')
ax.legend()
<matplotlib.legend.Legend at 0x7f2668bf0f50>

In this case, the exposure time of the LP4 spectrum is four times that of the LP1 spectrum, so the combined spectrum looks a lot like the (lower-resolution) LP4 spectrum, but you get the idea.
This approach maintains the full resolution of the LP1 spectrum and the statistical independence of each pixel. To construct an LSF for the combined spectrum, we scale and combine the LSFs, weighting by the exposure time.
lsf_combo = (lsf_lp1 * lp1_exptime + lsf_lp4 * lp4_exptime) / (lp1_exptime + lp4_exptime)
f, ax = plt.subplots()
plt.plot(lsf_wave, lsf_lp1, label='LP1')
plt.plot(lsf_wave, lsf_lp4, label='LP4')
plt.plot(lsf_wave, lsf_combo, label='Combo')
ax.legend()
ax.set_xlim([-0.3, 0.3])
ax.set_xlabel('Wavelength ($\\mathrm{\\AA}$)')
Text(0.5, 0, 'Wavelength ($\\mathrm{\\AA}$)')

If you have a synthetic spectrum, you can convolve it with the combined LSF to reproduce the features in the combined spectrum. Of course, this LSF is valid only for the region around 1335 A. You must construct separate LSFs for each spectral feature.
Congrats on completing the notebook!#
There are more tutorial notebooks in this notebooks repo. Check them out!#
About this Notebook#
Authors: Van Dixon (dixon@stsci.edu)
Editor: Anna Payne (apayne@stsci.edu
Updated on: May 2025
This tutorial was generated to be in compliance with the STScI style guides and would like to cite the Jupyter guide in particular.
Citations#
If you use astropy
, astroquery
, numpy
, or matplotlib
, for published research, please cite the authors. Follow these links for more information about citations:
