ASDF Example#
Use case: Create ASDF (Advanced Scientific Data Format) file from FITS file.
Data: CANDELS image of the COSMOS field.
Tools: asdf, gwcs, astrocut.
Cross-intrument: all instruments.
Documentation: This notebook is part of a STScI’s larger post-pipeline Data Analysis Tools Ecosystem.
Introduction#
JWST data files make use of the Advanced Scientific Data Format. The ASDF metadata are stored in a FITS extension. The JWST pipline software reads and writes these from the in-memory datamodels.
However, it is relatively straightforward to read and write a pure ASDF file, skipping FITS and datamodels entirely. This notebook illustrates some aspects of ASDF using a FITS file as a starting point.
Imports#
astrocut for getting the data via the astrocut service at MAST
the fits library from astropy for reading in the FITS file
the astropy coordinates
SkyCoord
object for dealing with celestial coordinatesmatplotlib for making plots
asdf and the
AsdfFile
objectthe astropy
Table
object for a notebook-friendly view of the headerItems from the modeling, coordinates and wcs libraries for an example of converting world coordinate system information from FITS keywords to a
gwcs
data structure.
from astrocut import fits_cut
from astropy.io import fits
from astropy.coordinates import SkyCoord
import matplotlib.pyplot as plt
import asdf
from asdf import AsdfFile
# For example 4
from astropy.table import Table
# For example 6
from astropy.modeling import models
from astropy import coordinates as coord
from astropy import units as u
from astropy.wcs import WCS
from gwcs.wcstools import wcs_from_fiducial
%matplotlib inline
Get the data#
We’ll grab a cutout from the CANDELS observations of COSMOS using astroquery.
url = "https://archive.stsci.edu/pub/hlsp/candels/cosmos/cos-tot/v1.0/"
input_files = [url + "hlsp_candels_hst_acs_cos-tot-sect23_f606w_v1.0_drz.fits"]
center_coord = SkyCoord("150.0946 2.38681", unit='deg')
cutout_size = [100, 100]
cutout_file = fits_cut(input_files, center_coord, cutout_size, single_outfile=True)
print(cutout_file)
./cutout_150.094600_2.386810_100-x-100_astrocut.fits
Read in the FITS file, look at its structure and display the data#
cutout_hdulist = fits.open(cutout_file)
cutout_hdulist.info()
Filename: ./cutout_150.094600_2.386810_100-x-100_astrocut.fits
No. Name Ver Type Cards Dimensions Format
0 PRIMARY 1 PrimaryHDU 11 ()
1 CUTOUT 1 ImageHDU 2769 (100, 100) float32
Pull apart the FITS components, for convenience later on.
data = cutout_hdulist[1].data
header0 = cutout_hdulist[0].header
header1 = cutout_hdulist[1].header
plt.imshow(data)
<matplotlib.image.AxesImage at 0x7ff2a936d9d0>
header1
XTENSION= 'IMAGE ' / Image extension
BITPIX = -32 / array data type
NAXIS = 2 / number of array dimensions
NAXIS1 = 100
NAXIS2 = 100
PCOUNT = 0 / number of parameters
GCOUNT = 1 / number of groups
OBJECT = 'COS_2EPOCH_ACS_F606W_030MAS_V1.0_SECT23_DRZ[1/1]'
ORIGIN = 'KPNO-IRAF' /
DATE = '2012-12-31T17:40:43'
IRAFNAME= 'cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / NAME OF IRAF IMA
IRAF-MAX= 0.000000E0 / DATA MAX
IRAF-MIN= 0.000000E0 / DATA MIN
IRAF-BPX= 32 / DATA BITS/PIXEL
IRAFTYPE= 'REAL ' / PIXEL TYPE
DATAMIN = 0.
DATAMAX = 0.
CRPIX1 = -2552.5 / Pixel coordinate of reference point
CRVAL1 = 150.1163213 / [deg] Coordinate value at reference point
CTYPE1 = 'RA---TAN' / Right ascension, gnomonic projection
CD1_1 = -8.333333E-6
CD2_1 = 0.
CRPIX2 = -22248.5 / Pixel coordinate of reference point
CRVAL2 = 2.200973097 / [deg] Coordinate value at reference point
CTYPE2 = 'DEC--TAN' / Declination, gnomonic projection
CD1_2 = 0.
CD2_2 = 8.333333E-6
ORIGIN = 'NOAO-IRAF FITS Image Kernel July 2003' / FITS file originator
DATE = '2012-05-19T15:15:35'
FILETYPE= 'SCI ' / type of data found in data file
TELESCOP= 'HST' / telescope used to acquire data
INSTRUME= 'ACS ' / identifier for instrument used to acquire data
EQUINOX = 2000.0 / [yr] Equinox of equatorial coordinates
/ DATA DESCRIPTION KEYWORDS
ROOTNAME= 'jboa28wmq ' / rootname of the observation set
IMAGETYP= 'EXT ' / type of exposure identifier
PRIMESI = 'WFC3 ' / instrument designated as prime
/ TARGET INFORMATION
TARGNAME= 'ANY ' / proposer's target name
RA_TARG = 1.501554086126E+02 / right ascension of the target (deg) (J2000)
DEC_TARG= 2.270881608073E+00 / declination of the target (deg) (J2000)
/ PROPOSAL INFORMATION
PROPOSID= 12440 / PEP proposal identifier
LINENUM = '28.002 ' / proposal logsheet line number
PR_INV_L= 'Faber ' / last name of principal investigator
PR_INV_F= 'Sandra ' / first name of principal investigator
PR_INV_M= 'M. ' / middle name / initial of principal investigat
/ EXPOSURE INFORMATION
SUNANGLE= 107.339531 / angle between sun and V1 axis
MOONANGL= 61.991249 / angle between moon and V1 axis
SUN_ALT = -32.338875 / altitude of the sun above Earth's limb
FGSLOCK = 'FINE ' / commanded FGS lock (FINE,COARSE,GYROS,UNKNOWN)
GYROMODE= 'T' / number of gyros scheduled, T=3+OBAD
REFFRAME= 'ICRS ' / guide star catalog version
MTFLAG = ' ' / moving target flag; T if it is a moving target
DATE-OBS= '2011-12-11' / ISO-8601 time of observation
TIME-OBS= '13:09:12' / UT time of start of observation (hh:mm:ss)
EXPSTART= 5.590654805854E+04 / exposure start time (Modified Julian Date)
EXPEND = 5.590655125326E+04 / exposure end time (Modified Julian Date)
EXPTIME = 36800. / exposure duration (seconds)--calculated
EXPFLAG = 'NORMAL ' / Exposure interruption indicator
QUALCOM1= ' '
QUALCOM2= ' '
QUALCOM3= ' '
QUALITY = ' '
/ POINTING INFORMATION
PA_V3 = 128.000000 / position angle of V3-axis of HST (deg)
/ TARGET OFFSETS (POSTARGS)
POSTARG1= 0.000000 / POSTARG in axis 1 direction
POSTARG2= 0.000000 / POSTARG in axis 2 direction
/ DIAGNOSTIC KEYWORDS
OPUS_VER= 'OPUS 2011_1h ' / OPUS software system version number
CAL_VER = '5.1.1 (27-Apr-2010)' / CALACS code version
PROCTIME= 5.590885636574E+04 / Pipeline processing time (MJD)
/ SCIENCE INSTRUMENT CONFIGURATION
OBSTYPE = 'IMAGING ' / observation type - imaging or spectroscopic
OBSMODE = 'ACCUM ' / operating mode
CTEIMAGE= 'NONE' / type of Charge Transfer Image, if applicable
SCLAMP = 'NONE ' / lamp status, NONE or name of lamp which is on
NRPTEXP = 1 / number of repeat exposures in set: default 1
SUBARRAY= F / data from a subarray (T) or full frame (F)
DETECTOR= 'WFC' / detector in use: WFC, HRC, or SBC
FILTER1 = 'F606W ' / element selected from filter wheel 1
FW1OFFST= 0 / computed filter wheel offset
FILTER2 = 'CLEAR2L ' / element selected from filter wheel 2
FW1ERROR= F / filter wheel position error flag
FW2OFFST= -4320 / computed filter wheel offset
FW2ERROR= T / filter wheel position error flag
FWSOFFST= 0 / computed filter wheel offset
FWSERROR= F / filter wheel position error flag
LRFWAVE = 0.000000 / proposed linear ramp filter wavelength
APERTURE= 'WFC ' / aperture name
PROPAPER= 'WFC ' / proposed aperture name
DIRIMAGE= 'NONE ' / direct image for grism or prism exposure
CTEDIR = 'NONE ' / CTE measurement direction: serial or parallel
CRSPLIT = 1 / number of cosmic ray split exposures
/ CALIBRATION SWITCHES: PERFORM, OMIT, COMPLETE
STATFLAG= F / Calculate statistics?
WRTERR = T / write out error array extension
DQICORR = 'COMPLETE' / data quality initialization
ATODCORR= 'OMIT ' / correct for A to D conversion errors
BLEVCORR= 'COMPLETE' / subtract bias level computed from overscan img
BIASCORR= 'COMPLETE' / Subtract bias image
FLSHCORR= 'OMIT ' / post flash correction
CRCORR = 'OMIT ' / combine observations to reject cosmic rays
EXPSCORR= 'COMPLETE' / process individual observations after cr-reject
SHADCORR= 'OMIT ' / apply shutter shading correction
DARKCORR= 'COMPLETE' / Subtract dark image
FLATCORR= 'COMPLETE' / flat field data
PHOTCORR= 'COMPLETE' / populate photometric header keywords
RPTCORR = 'OMIT ' / add individual repeat observations
DRIZCORR= 'PERFORM ' / drizzle processing
/ CALIBRATION REFERENCE FILES
BPIXTAB = 'jref$t3n1116nj_bpx.fits' / bad pixel table
CCDTAB = 'jref$uc82140bj_ccd.fits' / CCD calibration parameters
ATODTAB = 'jref$t3n1116mj_a2d.fits' / analog to digital correction file
OSCNTAB = 'jref$lch1459bj_osc.fits' / CCD overscan table
BIASFILE= 'jref$vbh1844rj_bia.fits' / bias image file name
FLSHFILE= 'N/A ' / post flash correction file name
CRREJTAB= 'jref$n4e12511j_crr.fits' / cosmic ray rejection parameters
SHADFILE= 'jref$kcb17349j_shd.fits' / shutter shading correction file
DARKFILE= 'jref$vbh18454j_drk.fits' / dark image file name
PFLTFILE= 'jref$qb12257sj_pfl.fits' / pixel to pixel flat field file name
DFLTFILE= 'N/A ' / delta flat field file name
LFLTFILE= 'N/A ' / low order flat
PHOTTAB = 'N/A ' / Photometric throughput table
GRAPHTAB= 'mtab$v9n1603mm_tmg.fits' / the HST graph table
COMPTAB = 'mtab$vb71653dm_tmc.fits' / the HST components table
IDCTAB = 'jref$v8q1444tj_idc.fits' / image distortion correction table
DGEOFILE= 'jref$qbu16424j_dxy.fits' / Distortion correction image
MDRIZTAB= 'jref$ub21537aj_mdz.fits' / MultiDrizzle parameter table
CFLTFILE= 'N/A ' / Coronagraphic spot image
SPOTTAB = 'N/A ' / Coronagraphic spot offset table
IMPHTTAB= 'jref$vbb18107j_imp.fits' / Image Photometry Table
/ COSMIC RAY REJECTION ALGORITHM PARAMETERS
MEANEXP = 0.000000 / reference exposure time for parameters
SCALENSE= 0.000000 / multiplicative scale factor applied to noise
INITGUES= ' ' / initial guess method (MIN or MED)
SKYSUB = ' ' / sky value subtracted (MODE or NONE)
SKYSUM = 0.0 / sky level from the sum of all constituent image
CRSIGMAS= ' ' / statistical rejection criteria
CRRADIUS= 0.000000 / rejection propagation radius (pixels)
CRTHRESH= 0.000000 / rejection propagation threshold
BADINPDQ= 0 / data quality flag bits to reject
REJ_RATE= 0.0 / rate at which pixels are affected by cosmic ray
CRMASK = F / flag CR-rejected pixels in input files (T/F)
MDRIZSKY= 32.08782958984375 / Sky value computed by MultiDrizzle
/ OTFR KEYWORDS
T_SGSTAR= 'N/A ' / OMS calculated guide star control
/ PATTERN KEYWORDS
PATTERN1= 'NONE ' / primary pattern type
P1_SHAPE= ' ' / primary pattern shape
P1_PURPS= ' ' / primary pattern purpose
P1_NPTS = 0 / number of points in primary pattern
P1_PSPAC= 0.000000 / point spacing for primary pattern (arc-sec)
P1_LSPAC= 0.000000 / line spacing for primary pattern (arc-sec)
P1_ANGLE= 0.000000 / angle between sides of parallelogram patt (deg)
P1_FRAME= ' ' / coordinate frame of primary pattern
P1_ORINT= 0.000000 / orientation of pattern to coordinate frame (deg
P1_CENTR= ' ' / center pattern relative to pointing (yes/no)
PATTSTEP= 0 / position number of this point in the pattern
/ POST FLASH PARAMETERS
FLASHDUR= 0.0 / Exposure time in seconds: 0.1 to 409.5
FLASHCUR= 'OFF ' / Post flash current: OFF, LOW, MED, HIGH
FLASHSTA= 'NOT PERFORMED ' / Status: SUCCESSFUL, ABORTED, NOT PERFORMED
SHUTRPOS= 'A ' / Shutter position: A or B
/ ENGINEERING PARAMETERS
CCDAMP = 'ABCD' / CCD Amplifier Readout Configuration
CCDGAIN = 2.0 / commanded gain of CCD
CCDOFSTA= 1 / commanded CCD bias offset for amplifier A
CCDOFSTB= 1 / commanded CCD bias offset for amplifier B
CCDOFSTC= 1 / commanded CCD bias offset for amplifier C
CCDOFSTD= 1 / commanded CCD bias offset for amplifier D
/ CALIBRATED ENGINEERING PARAMETERS
ATODGNA = 2.0200000E+00 / calibrated gain for amplifier A
ATODGNB = 1.8860000E+00 / calibrated gain for amplifier B
ATODGNC = 2.0170000E+00 / calibrated gain for amplifier C
ATODGND = 2.0109999E+00 / calibrated gain for amplifier D
READNSEA= 4.5700002E+00 / calibrated read noise for amplifier A
READNSEB= 3.9100001E+00 / calibrated read noise for amplifier B
READNSEC= 4.2500000E+00 / calibrated read noise for amplifier C
READNSED= 4.0400000E+00 / calibrated read noise for amplifier D
BIASLEVA= 2.0885564E+03 / bias level for amplifier A
BIASLEVB= 2.1405024E+03 / bias level for amplifier B
BIASLEVC= 2.2087419E+03 / bias level for amplifier C
BIASLEVD= 2.2967388E+03 / bias level for amplifier D
/ ASSOCIATION KEYWORDS
ASN_ID = 'JBOA28010 ' / unique identifier assigned to association
ASN_TAB = 'jboa28010_asn.fits ' / name of the association table
ASN_MTYP= 'EXP-DTH ' / Role of the Member in the Association
BSTRCORR= 'COMPLETE'
PCTEFILE= 'jref$pctefile_101109.fits'
PCTETAB = 'jref$pctetab_pcte_20110913113559.fits'
PCTECORR= 'COMPLETE'
PCTEFRAC= 1.289367530158845
DATE = '2012-04-10T16:39:27' / Date FITS file was generated
EXPNAME = 'jboa28wmq ' / exposure identifier
BUNIT = 'ELECTRONS' / brightness units
/ WFC CCD CHIP IDENTIFICATION
CCDCHIP = 1 / CCD chip (1 or 2)
/ World Coordinate System and Related Parameters
WCSAXES = 2 / Number of coordinate axes
LTV1 = 0.0000000E+00 / offset in X to subsection start
LTV2 = 0.0000000E+00 / offset in Y to subsection start
LTM1_1 = 1.0 / reciprocal of sampling rate in X
LTM2_2 = 1.0 / reciprocal of sampling rate in Y
ORIENTAT= -54.67632556350016 / position angle of image y axis (deg. e of n)
RA_APER = 1.501554086126E+02 / RA of aperture reference position
DEC_APER= 2.270881608073E+00 / Declination of aperture reference position
PA_APER = -54.4475 / Position Angle of reference aperture center (de
VAFACTOR= 1.000104465141E+00 / velocity aberration plate scale factor
/ READOUT DEFINITION PARAMETERS
CENTERA1= 2073 / subarray axis1 center pt in unbinned dect. pix
CENTERA2= 1035 / subarray axis2 center pt in unbinned dect. pix
SIZAXIS1= 4096 / subarray axis1 size in unbinned detector pixels
SIZAXIS2= 2048 / subarray axis2 size in unbinned detector pixels
BINAXIS1= 1 / axis1 data bin size in unbinned detector pixels
BINAXIS2= 1 / axis2 data bin size in unbinned detector pixels
/ PHOTOMETRY KEYWORDS
PHOTMODE= 'ACS WFC1 F606W MJD#55906.5481' / observation con
PHOTFLAM= 7.8624958E-20 / inverse sensitivity, ergs/cm2/Ang/electron
PHOTZPT = -2.1100000E+01 / ST magnitude zero point
PHOTPLAM= 5.9211147E+03 / Pivot wavelength (Angstroms)
PHOTBW = 6.7223627E+02 / RMS bandwidth of filter plus detector
/ REPEATED EXPOSURES INFO
NCOMBINE= 1 / number of image sets combined during CR rejecti
/ DATA PACKET INFORMATION
FILLCNT = 1 / number of segments containing fill
ERRCNT = 1 / number of segments containing errors
PODPSFF = F / podps fill present (T/F)
STDCFFF = T / science telemetry fill data present (T=1/F=0)
STDCFFP = '0x5569' / science telemetry fill pattern (hex)
/ ON-BOARD COMPRESSION INFORMATION
WFCMPRSD= F / was WFC data compressed? (T/F)
CBLKSIZ = 0 / size of compression block in 2-byte words
LOSTPIX = 0 / #pixels lost due to buffer overflow
COMPTYP = 'None ' / compression type performed (Partial/Full/None)
/ IMAGE STATISTICS AND DATA QUALITY FLAGS
NGOODPIX= 8097343 / number of good pixels
SDQFLAGS= 31743 / serious data quality flags
GOODMIN = -3.1759687E+01 / minimum value of good pixels
GOODMAX = 8.5606719E+04 / maximum value of good pixels
GOODMEAN= 3.5944370E+01 / mean value of good pixels
SOFTERRS= 0 / number of soft error pixels (DQF=1)
SNRMIN = -3.4609985E+00 / minimum signal to noise of good pixels
SNRMAX = 2.3393831E+02 / maximum signal to noise of good pixels
SNRMEAN = 5.9348207E+00 / mean value of signal to noise of good pixels
MEANDARK= 1.2713139E+00 / average of the dark values subtracted
MEANBLEV= 2.1145295E+03 / average of all bias levels subtracted
MEANFLSH= 0.000000 / Mean number of counts in post flash exposure
ONAXIS2 = 2048 / Axis length
ONAXIS1 = 4096 / Axis length
OORIENTA= -54.64776336099293 / position angle of image y axis (deg. e of n)
OCTYPE1 = 'RA---TAN' / the coordinate type for the first axis
OCTYPE2 = 'DEC--TAN' / the coordinate type for the second axis
WCSCDATE= '13:02:32 (10/04/2012)' / Time WCS keywords were copied.
A_0_2 = 2.26194120304176E-06
B_0_2 = -9.7985788387639E-06
A_1_1 = -7.5302905463753E-06
B_1_1 = 6.42569986264533E-06
A_2_0 = 8.51886870532632E-06
B_2_0 = -2.9658922285423E-06
A_0_3 = 6.51050854317125E-11
B_0_3 = -4.1421499542394E-10
A_1_2 = -5.2539201413375E-10
B_1_2 = -3.0354276197375E-11
A_2_1 = -1.0714004130419E-10
B_2_1 = -4.4034927976003E-10
A_3_0 = -4.6936360210189E-10
B_3_0 = 9.00334210115821E-11
A_0_4 = 1.35191449346299E-13
B_0_4 = -1.5248974790417E-13
A_1_3 = -1.4269338401366E-14
B_1_3 = 2.75911271664302E-14
A_2_2 = 9.70199603291834E-14
B_2_2 = -1.0403607372429E-13
A_3_1 = 3.80059786170717E-14
B_3_1 = -3.8363933112663E-14
A_4_0 = 1.83627862287182E-14
B_4_0 = -1.6913942054528E-14
A_ORDER = 4
B_ORDER = 4
IDCSCALE= 0.05
IDCV2REF= 261.1130981445312
IDCV3REF= 198.231201171875
IDCTHETA= 0.0
OCX10 = 0.002270935984783606
OCX11 = 0.04922343821974121
OCY10 = 0.0485839959198564
OCY11 = 0.00213603403929032
TDDALPHA= 0.2802605508521792
TDDBETA = -0.09075351695072641
SKYVAL = 32.5013968269
SKYRMS = 7.873235
QUADOFFA= 0.190616225
QUADOFFB= -0.660557125
QUADOFFC= 0.117621775
QUADOFFD= 0.352319125
NDRIZIM = 100 / Drizzle, number of images drizzled onto this ou
D001VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D001GEOM= 'Header WCS' / Drizzle, source of geometric information
D001DATA= 'cos01_28_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D001DEXP= 275. / Drizzle, input image exposure time (s)
D001OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D001OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D001OUCO= ' ' / Drizzle, output context image
D001MASK= 'cos01_28_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D001WTSC= 583770.1 / Drizzle, weighting factor for input image
D001KERN= 'square ' / Drizzle, form of weight distribution kernel
D001PIXF= 0.8 / Drizzle, linear size of drop
D001COEF= 'cos01_28_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D001XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D001YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D001LAM = 555. / Drizzle, wavelength applied for transformation
D001EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D001INUN= 'counts ' / Drizzle, units of input image - counts or cps
D001OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D001FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D001INXC= 2049. / Drizzle, reference center of input image (X)
D001INYC= 1025. / Drizzle, reference center of input image (Y)
D001OUXC= 7001. / Drizzle, reference center of output image (X)
D001OUYC= 7201. / Drizzle, reference center of output image (Y)
D001SECP= F / Drizzle, there are no secondary geometric param
D002VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D002GEOM= 'Header WCS' / Drizzle, source of geometric information
D002DATA= 'cos01_28_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D002DEXP= 707. / Drizzle, input image exposure time (s)
D002OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D002OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D002OUCO= ' ' / Drizzle, output context image
D002MASK= 'cos01_28_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D002WTSC= 3858213. / Drizzle, weighting factor for input image
D002KERN= 'square ' / Drizzle, form of weight distribution kernel
D002PIXF= 0.8 / Drizzle, linear size of drop
D002COEF= 'cos01_28_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D002XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D002YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D002LAM = 555. / Drizzle, wavelength applied for transformation
D002EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D002INUN= 'counts ' / Drizzle, units of input image - counts or cps
D002OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D002FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D002INXC= 2049. / Drizzle, reference center of input image (X)
D002INYC= 1025. / Drizzle, reference center of input image (Y)
D002OUXC= 7001. / Drizzle, reference center of output image (X)
D002OUYC= 7201. / Drizzle, reference center of output image (Y)
D002SECP= F / Drizzle, there are no secondary geometric param
D003VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D003GEOM= 'Header WCS' / Drizzle, source of geometric information
D003DATA= 'cos01_29_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D003DEXP= 275. / Drizzle, input image exposure time (s)
D003OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D003OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D003OUCO= ' ' / Drizzle, output context image
D003MASK= 'cos01_29_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D003WTSC= 583802.2 / Drizzle, weighting factor for input image
D003KERN= 'square ' / Drizzle, form of weight distribution kernel
D003PIXF= 0.8 / Drizzle, linear size of drop
D003COEF= 'cos01_29_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D003XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D003YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D003LAM = 555. / Drizzle, wavelength applied for transformation
D003EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D003INUN= 'counts ' / Drizzle, units of input image - counts or cps
D003OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D003FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D003INXC= 2049. / Drizzle, reference center of input image (X)
D003INYC= 1025. / Drizzle, reference center of input image (Y)
D003OUXC= 7001. / Drizzle, reference center of output image (X)
D003OUYC= 7201. / Drizzle, reference center of output image (Y)
D003SECP= F / Drizzle, there are no secondary geometric param
D004VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D004GEOM= 'Header WCS' / Drizzle, source of geometric information
D004DATA= 'cos01_29_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D004DEXP= 707. / Drizzle, input image exposure time (s)
D004OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D004OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D004OUCO= ' ' / Drizzle, output context image
D004MASK= 'cos01_29_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D004WTSC= 3858522. / Drizzle, weighting factor for input image
D004KERN= 'square ' / Drizzle, form of weight distribution kernel
D004PIXF= 0.8 / Drizzle, linear size of drop
D004COEF= 'cos01_29_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D004XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D004YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D004LAM = 555. / Drizzle, wavelength applied for transformation
D004EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D004INUN= 'counts ' / Drizzle, units of input image - counts or cps
D004OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D004FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D004INXC= 2049. / Drizzle, reference center of input image (X)
D004INYC= 1025. / Drizzle, reference center of input image (Y)
D004OUXC= 7001. / Drizzle, reference center of output image (X)
D004OUYC= 7201. / Drizzle, reference center of output image (Y)
D004SECP= F / Drizzle, there are no secondary geometric param
D005VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D005GEOM= 'Header WCS' / Drizzle, source of geometric information
D005DATA= 'cos01_30_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D005DEXP= 275. / Drizzle, input image exposure time (s)
D005OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D005OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D005OUCO= ' ' / Drizzle, output context image
D005MASK= 'cos01_30_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D005WTSC= 583802.4 / Drizzle, weighting factor for input image
D005KERN= 'square ' / Drizzle, form of weight distribution kernel
D005PIXF= 0.8 / Drizzle, linear size of drop
D005COEF= 'cos01_30_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D005XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D005YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D005LAM = 555. / Drizzle, wavelength applied for transformation
D005EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D005INUN= 'counts ' / Drizzle, units of input image - counts or cps
D005OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D005FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D005INXC= 2049. / Drizzle, reference center of input image (X)
D005INYC= 1025. / Drizzle, reference center of input image (Y)
D005OUXC= 7001. / Drizzle, reference center of output image (X)
D005OUYC= 7201. / Drizzle, reference center of output image (Y)
D005SECP= F / Drizzle, there are no secondary geometric param
D006VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D006GEOM= 'Header WCS' / Drizzle, source of geometric information
D006DATA= 'cos01_30_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D006DEXP= 707. / Drizzle, input image exposure time (s)
D006OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D006OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D006OUCO= ' ' / Drizzle, output context image
D006MASK= 'cos01_30_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D006WTSC= 3858522. / Drizzle, weighting factor for input image
D006KERN= 'square ' / Drizzle, form of weight distribution kernel
D006PIXF= 0.8 / Drizzle, linear size of drop
D006COEF= 'cos01_30_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D006XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D006YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D006LAM = 555. / Drizzle, wavelength applied for transformation
D006EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D006INUN= 'counts ' / Drizzle, units of input image - counts or cps
D006OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D006FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D006INXC= 2049. / Drizzle, reference center of input image (X)
D006INYC= 1025. / Drizzle, reference center of input image (Y)
D006OUXC= 7001. / Drizzle, reference center of output image (X)
D006OUYC= 7201. / Drizzle, reference center of output image (Y)
D006SECP= F / Drizzle, there are no secondary geometric param
D007VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D007GEOM= 'Header WCS' / Drizzle, source of geometric information
D007DATA= 'cos01_32_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D007DEXP= 275. / Drizzle, input image exposure time (s)
D007OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D007OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D007OUCO= ' ' / Drizzle, output context image
D007MASK= 'cos01_32_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D007WTSC= 583801.9 / Drizzle, weighting factor for input image
D007KERN= 'square ' / Drizzle, form of weight distribution kernel
D007PIXF= 0.8 / Drizzle, linear size of drop
D007COEF= 'cos01_32_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D007XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D007YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D007LAM = 555. / Drizzle, wavelength applied for transformation
D007EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D007INUN= 'counts ' / Drizzle, units of input image - counts or cps
D007OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D007FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D007INXC= 2049. / Drizzle, reference center of input image (X)
D007INYC= 1025. / Drizzle, reference center of input image (Y)
D007OUXC= 7001. / Drizzle, reference center of output image (X)
D007OUYC= 7201. / Drizzle, reference center of output image (Y)
D007SECP= F / Drizzle, there are no secondary geometric param
D008VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D008GEOM= 'Header WCS' / Drizzle, source of geometric information
D008DATA= 'cos01_32_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D008DEXP= 707. / Drizzle, input image exposure time (s)
D008OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D008OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D008OUCO= ' ' / Drizzle, output context image
D008MASK= 'cos01_32_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D008WTSC= 3858506. / Drizzle, weighting factor for input image
D008KERN= 'square ' / Drizzle, form of weight distribution kernel
D008PIXF= 0.8 / Drizzle, linear size of drop
D008COEF= 'cos01_32_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D008XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D008YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D008LAM = 555. / Drizzle, wavelength applied for transformation
D008EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D008INUN= 'counts ' / Drizzle, units of input image - counts or cps
D008OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D008FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D008INXC= 2049. / Drizzle, reference center of input image (X)
D008INYC= 1025. / Drizzle, reference center of input image (Y)
D008OUXC= 7001. / Drizzle, reference center of output image (X)
D008OUYC= 7201. / Drizzle, reference center of output image (Y)
D008SECP= F / Drizzle, there are no secondary geometric param
D009VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D009GEOM= 'Header WCS' / Drizzle, source of geometric information
D009DATA= 'cos01_33_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D009DEXP= 275. / Drizzle, input image exposure time (s)
D009OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D009OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D009OUCO= ' ' / Drizzle, output context image
D009MASK= 'cos01_33_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D009WTSC= 583803.6 / Drizzle, weighting factor for input image
D009KERN= 'square ' / Drizzle, form of weight distribution kernel
D009PIXF= 0.8 / Drizzle, linear size of drop
D009COEF= 'cos01_33_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D009XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D009YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D009LAM = 555. / Drizzle, wavelength applied for transformation
D009EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D009INUN= 'counts ' / Drizzle, units of input image - counts or cps
D009OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D009FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D009INXC= 2049. / Drizzle, reference center of input image (X)
D009INYC= 1025. / Drizzle, reference center of input image (Y)
D009OUXC= 7001. / Drizzle, reference center of output image (X)
D009OUYC= 7201. / Drizzle, reference center of output image (Y)
D009SECP= F / Drizzle, there are no secondary geometric param
D010VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D010GEOM= 'Header WCS' / Drizzle, source of geometric information
D010DATA= 'cos01_33_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D010DEXP= 275. / Drizzle, input image exposure time (s)
D010OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D010OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D010OUCO= ' ' / Drizzle, output context image
D010MASK= 'cos01_33_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D010WTSC= 583803.6 / Drizzle, weighting factor for input image
D010KERN= 'square ' / Drizzle, form of weight distribution kernel
D010PIXF= 0.8 / Drizzle, linear size of drop
D010COEF= 'cos01_33_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D010XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D010YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D010LAM = 555. / Drizzle, wavelength applied for transformation
D010EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D010INUN= 'counts ' / Drizzle, units of input image - counts or cps
D010OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D010FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D010INXC= 2049. / Drizzle, reference center of input image (X)
D010INYC= 1025. / Drizzle, reference center of input image (Y)
D010OUXC= 7001. / Drizzle, reference center of output image (X)
D010OUYC= 7201. / Drizzle, reference center of output image (Y)
D010SECP= F / Drizzle, there are no secondary geometric param
D011VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D011GEOM= 'Header WCS' / Drizzle, source of geometric information
D011DATA= 'cos01_33_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D011DEXP= 707. / Drizzle, input image exposure time (s)
D011OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D011OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D011OUCO= ' ' / Drizzle, output context image
D011MASK= 'cos01_33_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D011WTSC= 3858528. / Drizzle, weighting factor for input image
D011KERN= 'square ' / Drizzle, form of weight distribution kernel
D011PIXF= 0.8 / Drizzle, linear size of drop
D011COEF= 'cos01_33_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D011XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D011YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D011LAM = 555. / Drizzle, wavelength applied for transformation
D011EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D011INUN= 'counts ' / Drizzle, units of input image - counts or cps
D011OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D011FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D011INXC= 2049. / Drizzle, reference center of input image (X)
D011INYC= 1025. / Drizzle, reference center of input image (Y)
D011OUXC= 7001. / Drizzle, reference center of output image (X)
D011OUYC= 7201. / Drizzle, reference center of output image (Y)
D011SECP= F / Drizzle, there are no secondary geometric param
D012VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D012GEOM= 'Header WCS' / Drizzle, source of geometric information
D012DATA= 'cos01_33_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D012DEXP= 707. / Drizzle, input image exposure time (s)
D012OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D012OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D012OUCO= ' ' / Drizzle, output context image
D012MASK= 'cos01_33_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D012WTSC= 3858528. / Drizzle, weighting factor for input image
D012KERN= 'square ' / Drizzle, form of weight distribution kernel
D012PIXF= 0.8 / Drizzle, linear size of drop
D012COEF= 'cos01_33_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D012XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D012YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D012LAM = 555. / Drizzle, wavelength applied for transformation
D012EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D012INUN= 'counts ' / Drizzle, units of input image - counts or cps
D012OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D012FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D012INXC= 2049. / Drizzle, reference center of input image (X)
D012INYC= 1025. / Drizzle, reference center of input image (Y)
D012OUXC= 7001. / Drizzle, reference center of output image (X)
D012OUYC= 7201. / Drizzle, reference center of output image (Y)
D012SECP= F / Drizzle, there are no secondary geometric param
D013VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D013GEOM= 'Header WCS' / Drizzle, source of geometric information
D013DATA= 'cos01_34_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D013DEXP= 275. / Drizzle, input image exposure time (s)
D013OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D013OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D013OUCO= ' ' / Drizzle, output context image
D013MASK= 'cos01_34_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D013WTSC= 583803.6 / Drizzle, weighting factor for input image
D013KERN= 'square ' / Drizzle, form of weight distribution kernel
D013PIXF= 0.8 / Drizzle, linear size of drop
D013COEF= 'cos01_34_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D013XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D013YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D013LAM = 555. / Drizzle, wavelength applied for transformation
D013EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D013INUN= 'counts ' / Drizzle, units of input image - counts or cps
D013OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D013FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D013INXC= 2049. / Drizzle, reference center of input image (X)
D013INYC= 1025. / Drizzle, reference center of input image (Y)
D013OUXC= 7001. / Drizzle, reference center of output image (X)
D013OUYC= 7201. / Drizzle, reference center of output image (Y)
D013SECP= F / Drizzle, there are no secondary geometric param
D014VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D014GEOM= 'Header WCS' / Drizzle, source of geometric information
D014DATA= 'cos01_34_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D014DEXP= 275. / Drizzle, input image exposure time (s)
D014OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D014OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D014OUCO= ' ' / Drizzle, output context image
D014MASK= 'cos01_34_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D014WTSC= 583803.6 / Drizzle, weighting factor for input image
D014KERN= 'square ' / Drizzle, form of weight distribution kernel
D014PIXF= 0.8 / Drizzle, linear size of drop
D014COEF= 'cos01_34_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D014XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D014YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D014LAM = 555. / Drizzle, wavelength applied for transformation
D014EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D014INUN= 'counts ' / Drizzle, units of input image - counts or cps
D014OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D014FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D014INXC= 2049. / Drizzle, reference center of input image (X)
D014INYC= 1025. / Drizzle, reference center of input image (Y)
D014OUXC= 7001. / Drizzle, reference center of output image (X)
D014OUYC= 7201. / Drizzle, reference center of output image (Y)
D014SECP= F / Drizzle, there are no secondary geometric param
D015VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D015GEOM= 'Header WCS' / Drizzle, source of geometric information
D015DATA= 'cos01_34_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D015DEXP= 707. / Drizzle, input image exposure time (s)
D015OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D015OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D015OUCO= ' ' / Drizzle, output context image
D015MASK= 'cos01_34_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D015WTSC= 3858529. / Drizzle, weighting factor for input image
D015KERN= 'square ' / Drizzle, form of weight distribution kernel
D015PIXF= 0.8 / Drizzle, linear size of drop
D015COEF= 'cos01_34_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D015XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D015YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D015LAM = 555. / Drizzle, wavelength applied for transformation
D015EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D015INUN= 'counts ' / Drizzle, units of input image - counts or cps
D015OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D015FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D015INXC= 2049. / Drizzle, reference center of input image (X)
D015INYC= 1025. / Drizzle, reference center of input image (Y)
D015OUXC= 7001. / Drizzle, reference center of output image (X)
D015OUYC= 7201. / Drizzle, reference center of output image (Y)
D015SECP= F / Drizzle, there are no secondary geometric param
D016VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D016GEOM= 'Header WCS' / Drizzle, source of geometric information
D016DATA= 'cos01_34_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D016DEXP= 707. / Drizzle, input image exposure time (s)
D016OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D016OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D016OUCO= ' ' / Drizzle, output context image
D016MASK= 'cos01_34_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D016WTSC= 3858529. / Drizzle, weighting factor for input image
D016KERN= 'square ' / Drizzle, form of weight distribution kernel
D016PIXF= 0.8 / Drizzle, linear size of drop
D016COEF= 'cos01_34_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D016XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D016YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D016LAM = 555. / Drizzle, wavelength applied for transformation
D016EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D016INUN= 'counts ' / Drizzle, units of input image - counts or cps
D016OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D016FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D016INXC= 2049. / Drizzle, reference center of input image (X)
D016INYC= 1025. / Drizzle, reference center of input image (Y)
D016OUXC= 7001. / Drizzle, reference center of output image (X)
D016OUYC= 7201. / Drizzle, reference center of output image (Y)
D016SECP= F / Drizzle, there are no secondary geometric param
D017VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D017GEOM= 'Header WCS' / Drizzle, source of geometric information
D017DATA= 'cos01_36_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D017DEXP= 275. / Drizzle, input image exposure time (s)
D017OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D017OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D017OUCO= ' ' / Drizzle, output context image
D017MASK= 'cos01_36_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D017WTSC= 583804.3 / Drizzle, weighting factor for input image
D017KERN= 'square ' / Drizzle, form of weight distribution kernel
D017PIXF= 0.8 / Drizzle, linear size of drop
D017COEF= 'cos01_36_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D017XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D017YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D017LAM = 555. / Drizzle, wavelength applied for transformation
D017EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D017INUN= 'counts ' / Drizzle, units of input image - counts or cps
D017OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D017FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D017INXC= 2049. / Drizzle, reference center of input image (X)
D017INYC= 1025. / Drizzle, reference center of input image (Y)
D017OUXC= 7001. / Drizzle, reference center of output image (X)
D017OUYC= 7201. / Drizzle, reference center of output image (Y)
D017SECP= F / Drizzle, there are no secondary geometric param
D018VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D018GEOM= 'Header WCS' / Drizzle, source of geometric information
D018DATA= 'cos01_36_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D018DEXP= 707. / Drizzle, input image exposure time (s)
D018OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D018OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D018OUCO= ' ' / Drizzle, output context image
D018MASK= 'cos01_36_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D018WTSC= 3858532. / Drizzle, weighting factor for input image
D018KERN= 'square ' / Drizzle, form of weight distribution kernel
D018PIXF= 0.8 / Drizzle, linear size of drop
D018COEF= 'cos01_36_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D018XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D018YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D018LAM = 555. / Drizzle, wavelength applied for transformation
D018EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D018INUN= 'counts ' / Drizzle, units of input image - counts or cps
D018OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D018FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D018INXC= 2049. / Drizzle, reference center of input image (X)
D018INYC= 1025. / Drizzle, reference center of input image (Y)
D018OUXC= 7001. / Drizzle, reference center of output image (X)
D018OUYC= 7201. / Drizzle, reference center of output image (Y)
D018SECP= F / Drizzle, there are no secondary geometric param
D019VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D019GEOM= 'Header WCS' / Drizzle, source of geometric information
D019DATA= 'cos01_37_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D019DEXP= 275. / Drizzle, input image exposure time (s)
D019OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D019OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D019OUCO= ' ' / Drizzle, output context image
D019MASK= 'cos01_37_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D019WTSC= 583796.7 / Drizzle, weighting factor for input image
D019KERN= 'square ' / Drizzle, form of weight distribution kernel
D019PIXF= 0.8 / Drizzle, linear size of drop
D019COEF= 'cos01_37_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D019XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D019YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D019LAM = 555. / Drizzle, wavelength applied for transformation
D019EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D019INUN= 'counts ' / Drizzle, units of input image - counts or cps
D019OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D019FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D019INXC= 2049. / Drizzle, reference center of input image (X)
D019INYC= 1025. / Drizzle, reference center of input image (Y)
D019OUXC= 7001. / Drizzle, reference center of output image (X)
D019OUYC= 7201. / Drizzle, reference center of output image (Y)
D019SECP= F / Drizzle, there are no secondary geometric param
D020VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D020GEOM= 'Header WCS' / Drizzle, source of geometric information
D020DATA= 'cos01_37_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D020DEXP= 275. / Drizzle, input image exposure time (s)
D020OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D020OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D020OUCO= ' ' / Drizzle, output context image
D020MASK= 'cos01_37_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D020WTSC= 583796.7 / Drizzle, weighting factor for input image
D020KERN= 'square ' / Drizzle, form of weight distribution kernel
D020PIXF= 0.8 / Drizzle, linear size of drop
D020COEF= 'cos01_37_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D020XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D020YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D020LAM = 555. / Drizzle, wavelength applied for transformation
D020EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D020INUN= 'counts ' / Drizzle, units of input image - counts or cps
D020OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D020FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D020INXC= 2049. / Drizzle, reference center of input image (X)
D020INYC= 1025. / Drizzle, reference center of input image (Y)
D020OUXC= 7001. / Drizzle, reference center of output image (X)
D020OUYC= 7201. / Drizzle, reference center of output image (Y)
D020SECP= F / Drizzle, there are no secondary geometric param
D021VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D021GEOM= 'Header WCS' / Drizzle, source of geometric information
D021DATA= 'cos01_37_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D021DEXP= 707. / Drizzle, input image exposure time (s)
D021OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D021OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D021OUCO= ' ' / Drizzle, output context image
D021MASK= 'cos01_37_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D021WTSC= 3858427. / Drizzle, weighting factor for input image
D021KERN= 'square ' / Drizzle, form of weight distribution kernel
D021PIXF= 0.8 / Drizzle, linear size of drop
D021COEF= 'cos01_37_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D021XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D021YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D021LAM = 555. / Drizzle, wavelength applied for transformation
D021EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D021INUN= 'counts ' / Drizzle, units of input image - counts or cps
D021OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D021FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D021INXC= 2049. / Drizzle, reference center of input image (X)
D021INYC= 1025. / Drizzle, reference center of input image (Y)
D021OUXC= 7001. / Drizzle, reference center of output image (X)
D021OUYC= 7201. / Drizzle, reference center of output image (Y)
D021SECP= F / Drizzle, there are no secondary geometric param
D022VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D022GEOM= 'Header WCS' / Drizzle, source of geometric information
D022DATA= 'cos01_37_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D022DEXP= 707. / Drizzle, input image exposure time (s)
D022OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D022OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D022OUCO= ' ' / Drizzle, output context image
D022MASK= 'cos01_37_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D022WTSC= 3858427. / Drizzle, weighting factor for input image
D022KERN= 'square ' / Drizzle, form of weight distribution kernel
D022PIXF= 0.8 / Drizzle, linear size of drop
D022COEF= 'cos01_37_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D022XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D022YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D022LAM = 555. / Drizzle, wavelength applied for transformation
D022EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D022INUN= 'counts ' / Drizzle, units of input image - counts or cps
D022OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D022FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D022INXC= 2049. / Drizzle, reference center of input image (X)
D022INYC= 1025. / Drizzle, reference center of input image (Y)
D022OUXC= 7001. / Drizzle, reference center of output image (X)
D022OUYC= 7201. / Drizzle, reference center of output image (Y)
D022SECP= F / Drizzle, there are no secondary geometric param
D023VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D023GEOM= 'Header WCS' / Drizzle, source of geometric information
D023DATA= 'cos01_38_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D023DEXP= 275. / Drizzle, input image exposure time (s)
D023OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D023OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D023OUCO= ' ' / Drizzle, output context image
D023MASK= 'cos01_38_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D023WTSC= 583805.7 / Drizzle, weighting factor for input image
D023KERN= 'square ' / Drizzle, form of weight distribution kernel
D023PIXF= 0.8 / Drizzle, linear size of drop
D023COEF= 'cos01_38_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D023XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D023YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D023LAM = 555. / Drizzle, wavelength applied for transformation
D023EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D023INUN= 'counts ' / Drizzle, units of input image - counts or cps
D023OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D023FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D023INXC= 2049. / Drizzle, reference center of input image (X)
D023INYC= 1025. / Drizzle, reference center of input image (Y)
D023OUXC= 7001. / Drizzle, reference center of output image (X)
D023OUYC= 7201. / Drizzle, reference center of output image (Y)
D023SECP= F / Drizzle, there are no secondary geometric param
D024VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D024GEOM= 'Header WCS' / Drizzle, source of geometric information
D024DATA= 'cos01_38_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D024DEXP= 275. / Drizzle, input image exposure time (s)
D024OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D024OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D024OUCO= ' ' / Drizzle, output context image
D024MASK= 'cos01_38_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D024WTSC= 583805.7 / Drizzle, weighting factor for input image
D024KERN= 'square ' / Drizzle, form of weight distribution kernel
D024PIXF= 0.8 / Drizzle, linear size of drop
D024COEF= 'cos01_38_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D024XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D024YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D024LAM = 555. / Drizzle, wavelength applied for transformation
D024EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D024INUN= 'counts ' / Drizzle, units of input image - counts or cps
D024OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D024FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D024INXC= 2049. / Drizzle, reference center of input image (X)
D024INYC= 1025. / Drizzle, reference center of input image (Y)
D024OUXC= 7001. / Drizzle, reference center of output image (X)
D024OUYC= 7201. / Drizzle, reference center of output image (Y)
D024SECP= F / Drizzle, there are no secondary geometric param
D025VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D025GEOM= 'Header WCS' / Drizzle, source of geometric information
D025DATA= 'cos01_38_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D025DEXP= 707. / Drizzle, input image exposure time (s)
D025OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D025OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D025OUCO= ' ' / Drizzle, output context image
D025MASK= 'cos01_38_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D025WTSC= 3858539. / Drizzle, weighting factor for input image
D025KERN= 'square ' / Drizzle, form of weight distribution kernel
D025PIXF= 0.8 / Drizzle, linear size of drop
D025COEF= 'cos01_38_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D025XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D025YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D025LAM = 555. / Drizzle, wavelength applied for transformation
D025EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D025INUN= 'counts ' / Drizzle, units of input image - counts or cps
D025OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D025FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D025INXC= 2049. / Drizzle, reference center of input image (X)
D025INYC= 1025. / Drizzle, reference center of input image (Y)
D025OUXC= 7001. / Drizzle, reference center of output image (X)
D025OUYC= 7201. / Drizzle, reference center of output image (Y)
D025SECP= F / Drizzle, there are no secondary geometric param
D026VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D026GEOM= 'Header WCS' / Drizzle, source of geometric information
D026DATA= 'cos01_38_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D026DEXP= 707. / Drizzle, input image exposure time (s)
D026OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D026OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D026OUCO= ' ' / Drizzle, output context image
D026MASK= 'cos01_38_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D026WTSC= 3858539. / Drizzle, weighting factor for input image
D026KERN= 'square ' / Drizzle, form of weight distribution kernel
D026PIXF= 0.8 / Drizzle, linear size of drop
D026COEF= 'cos01_38_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D026XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D026YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D026LAM = 555. / Drizzle, wavelength applied for transformation
D026EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D026INUN= 'counts ' / Drizzle, units of input image - counts or cps
D026OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D026FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D026INXC= 2049. / Drizzle, reference center of input image (X)
D026INYC= 1025. / Drizzle, reference center of input image (Y)
D026OUXC= 7001. / Drizzle, reference center of output image (X)
D026OUYC= 7201. / Drizzle, reference center of output image (Y)
D026SECP= F / Drizzle, there are no secondary geometric param
D027VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D027GEOM= 'Header WCS' / Drizzle, source of geometric information
D027DATA= 'cos01_40_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D027DEXP= 225. / Drizzle, input image exposure time (s)
D027OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D027OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D027OUCO= ' ' / Drizzle, output context image
D027MASK= 'cos01_40_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D027WTSC= 390803.6 / Drizzle, weighting factor for input image
D027KERN= 'square ' / Drizzle, form of weight distribution kernel
D027PIXF= 0.8 / Drizzle, linear size of drop
D027COEF= 'cos01_40_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D027XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D027YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D027LAM = 555. / Drizzle, wavelength applied for transformation
D027EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D027INUN= 'counts ' / Drizzle, units of input image - counts or cps
D027OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D027FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D027INXC= 2049. / Drizzle, reference center of input image (X)
D027INYC= 1025. / Drizzle, reference center of input image (Y)
D027OUXC= 7001. / Drizzle, reference center of output image (X)
D027OUYC= 7201. / Drizzle, reference center of output image (Y)
D027SECP= F / Drizzle, there are no secondary geometric param
D028VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D028GEOM= 'Header WCS' / Drizzle, source of geometric information
D028DATA= 'cos01_40_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D028DEXP= 407. / Drizzle, input image exposure time (s)
D028OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D028OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D028OUCO= ' ' / Drizzle, output context image
D028MASK= 'cos01_40_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D028WTSC= 1278684. / Drizzle, weighting factor for input image
D028KERN= 'square ' / Drizzle, form of weight distribution kernel
D028PIXF= 0.8 / Drizzle, linear size of drop
D028COEF= 'cos01_40_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D028XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D028YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D028LAM = 555. / Drizzle, wavelength applied for transformation
D028EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D028INUN= 'counts ' / Drizzle, units of input image - counts or cps
D028OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D028FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D028INXC= 2049. / Drizzle, reference center of input image (X)
D028INYC= 1025. / Drizzle, reference center of input image (Y)
D028OUXC= 7001. / Drizzle, reference center of output image (X)
D028OUYC= 7201. / Drizzle, reference center of output image (Y)
D028SECP= F / Drizzle, there are no secondary geometric param
D029VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D029GEOM= 'Header WCS' / Drizzle, source of geometric information
D029DATA= 'cos01_41_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D029DEXP= 225. / Drizzle, input image exposure time (s)
D029OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D029OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D029OUCO= ' ' / Drizzle, output context image
D029MASK= 'cos01_41_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D029WTSC= 390813.4 / Drizzle, weighting factor for input image
D029KERN= 'square ' / Drizzle, form of weight distribution kernel
D029PIXF= 0.8 / Drizzle, linear size of drop
D029COEF= 'cos01_41_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D029XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D029YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D029LAM = 555. / Drizzle, wavelength applied for transformation
D029EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D029INUN= 'counts ' / Drizzle, units of input image - counts or cps
D029OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D029FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D029INXC= 2049. / Drizzle, reference center of input image (X)
D029INYC= 1025. / Drizzle, reference center of input image (Y)
D029OUXC= 7001. / Drizzle, reference center of output image (X)
D029OUYC= 7201. / Drizzle, reference center of output image (Y)
D029SECP= F / Drizzle, there are no secondary geometric param
D030VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D030GEOM= 'Header WCS' / Drizzle, source of geometric information
D030DATA= 'cos01_41_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D030DEXP= 225. / Drizzle, input image exposure time (s)
D030OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D030OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D030OUCO= ' ' / Drizzle, output context image
D030MASK= 'cos01_41_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D030WTSC= 390813.4 / Drizzle, weighting factor for input image
D030KERN= 'square ' / Drizzle, form of weight distribution kernel
D030PIXF= 0.8 / Drizzle, linear size of drop
D030COEF= 'cos01_41_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D030XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D030YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D030LAM = 555. / Drizzle, wavelength applied for transformation
D030EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D030INUN= 'counts ' / Drizzle, units of input image - counts or cps
D030OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D030FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D030INXC= 2049. / Drizzle, reference center of input image (X)
D030INYC= 1025. / Drizzle, reference center of input image (Y)
D030OUXC= 7001. / Drizzle, reference center of output image (X)
D030OUYC= 7201. / Drizzle, reference center of output image (Y)
D030SECP= F / Drizzle, there are no secondary geometric param
D031VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D031GEOM= 'Header WCS' / Drizzle, source of geometric information
D031DATA= 'cos01_41_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D031DEXP= 407. / Drizzle, input image exposure time (s)
D031OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D031OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D031OUCO= ' ' / Drizzle, output context image
D031MASK= 'cos01_41_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D031WTSC= 1278740. / Drizzle, weighting factor for input image
D031KERN= 'square ' / Drizzle, form of weight distribution kernel
D031PIXF= 0.8 / Drizzle, linear size of drop
D031COEF= 'cos01_41_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D031XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D031YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D031LAM = 555. / Drizzle, wavelength applied for transformation
D031EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D031INUN= 'counts ' / Drizzle, units of input image - counts or cps
D031OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D031FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D031INXC= 2049. / Drizzle, reference center of input image (X)
D031INYC= 1025. / Drizzle, reference center of input image (Y)
D031OUXC= 7001. / Drizzle, reference center of output image (X)
D031OUYC= 7201. / Drizzle, reference center of output image (Y)
D031SECP= F / Drizzle, there are no secondary geometric param
D032VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D032GEOM= 'Header WCS' / Drizzle, source of geometric information
D032DATA= 'cos01_41_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D032DEXP= 407. / Drizzle, input image exposure time (s)
D032OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D032OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D032OUCO= ' ' / Drizzle, output context image
D032MASK= 'cos01_41_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D032WTSC= 1278740. / Drizzle, weighting factor for input image
D032KERN= 'square ' / Drizzle, form of weight distribution kernel
D032PIXF= 0.8 / Drizzle, linear size of drop
D032COEF= 'cos01_41_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D032XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D032YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D032LAM = 555. / Drizzle, wavelength applied for transformation
D032EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D032INUN= 'counts ' / Drizzle, units of input image - counts or cps
D032OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D032FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D032INXC= 2049. / Drizzle, reference center of input image (X)
D032INYC= 1025. / Drizzle, reference center of input image (Y)
D032OUXC= 7001. / Drizzle, reference center of output image (X)
D032OUYC= 7201. / Drizzle, reference center of output image (Y)
D032SECP= F / Drizzle, there are no secondary geometric param
D033VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D033GEOM= 'Header WCS' / Drizzle, source of geometric information
D033DATA= 'cos01_42_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D033DEXP= 225. / Drizzle, input image exposure time (s)
D033OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D033OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D033OUCO= ' ' / Drizzle, output context image
D033MASK= 'cos01_42_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D033WTSC= 390813.7 / Drizzle, weighting factor for input image
D033KERN= 'square ' / Drizzle, form of weight distribution kernel
D033PIXF= 0.8 / Drizzle, linear size of drop
D033COEF= 'cos01_42_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D033XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D033YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D033LAM = 555. / Drizzle, wavelength applied for transformation
D033EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D033INUN= 'counts ' / Drizzle, units of input image - counts or cps
D033OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D033FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D033INXC= 2049. / Drizzle, reference center of input image (X)
D033INYC= 1025. / Drizzle, reference center of input image (Y)
D033OUXC= 7001. / Drizzle, reference center of output image (X)
D033OUYC= 7201. / Drizzle, reference center of output image (Y)
D033SECP= F / Drizzle, there are no secondary geometric param
D034VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D034GEOM= 'Header WCS' / Drizzle, source of geometric information
D034DATA= 'cos01_42_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D034DEXP= 225. / Drizzle, input image exposure time (s)
D034OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D034OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D034OUCO= ' ' / Drizzle, output context image
D034MASK= 'cos01_42_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D034WTSC= 390813.7 / Drizzle, weighting factor for input image
D034KERN= 'square ' / Drizzle, form of weight distribution kernel
D034PIXF= 0.8 / Drizzle, linear size of drop
D034COEF= 'cos01_42_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D034XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D034YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D034LAM = 555. / Drizzle, wavelength applied for transformation
D034EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D034INUN= 'counts ' / Drizzle, units of input image - counts or cps
D034OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D034FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D034INXC= 2049. / Drizzle, reference center of input image (X)
D034INYC= 1025. / Drizzle, reference center of input image (Y)
D034OUXC= 7001. / Drizzle, reference center of output image (X)
D034OUYC= 7201. / Drizzle, reference center of output image (Y)
D034SECP= F / Drizzle, there are no secondary geometric param
D035VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D035GEOM= 'Header WCS' / Drizzle, source of geometric information
D035DATA= 'cos01_42_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D035DEXP= 407. / Drizzle, input image exposure time (s)
D035OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D035OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D035OUCO= ' ' / Drizzle, output context image
D035MASK= 'cos01_42_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D035WTSC= 1278741. / Drizzle, weighting factor for input image
D035KERN= 'square ' / Drizzle, form of weight distribution kernel
D035PIXF= 0.8 / Drizzle, linear size of drop
D035COEF= 'cos01_42_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D035XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D035YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D035LAM = 555. / Drizzle, wavelength applied for transformation
D035EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D035INUN= 'counts ' / Drizzle, units of input image - counts or cps
D035OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D035FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D035INXC= 2049. / Drizzle, reference center of input image (X)
D035INYC= 1025. / Drizzle, reference center of input image (Y)
D035OUXC= 7001. / Drizzle, reference center of output image (X)
D035OUYC= 7201. / Drizzle, reference center of output image (Y)
D035SECP= F / Drizzle, there are no secondary geometric param
D036VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D036GEOM= 'Header WCS' / Drizzle, source of geometric information
D036DATA= 'cos01_42_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D036DEXP= 407. / Drizzle, input image exposure time (s)
D036OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D036OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D036OUCO= ' ' / Drizzle, output context image
D036MASK= 'cos01_42_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D036WTSC= 1278741. / Drizzle, weighting factor for input image
D036KERN= 'square ' / Drizzle, form of weight distribution kernel
D036PIXF= 0.8 / Drizzle, linear size of drop
D036COEF= 'cos01_42_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D036XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D036YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D036LAM = 555. / Drizzle, wavelength applied for transformation
D036EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D036INUN= 'counts ' / Drizzle, units of input image - counts or cps
D036OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D036FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D036INXC= 2049. / Drizzle, reference center of input image (X)
D036INYC= 1025. / Drizzle, reference center of input image (Y)
D036OUXC= 7001. / Drizzle, reference center of output image (X)
D036OUYC= 7201. / Drizzle, reference center of output image (Y)
D036SECP= F / Drizzle, there are no secondary geometric param
D037VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D037GEOM= 'Header WCS' / Drizzle, source of geometric information
D037DATA= 'cos01_45_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D037DEXP= 225. / Drizzle, input image exposure time (s)
D037OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D037OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D037OUCO= ' ' / Drizzle, output context image
D037MASK= 'cos01_45_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D037WTSC= 390814.3 / Drizzle, weighting factor for input image
D037KERN= 'square ' / Drizzle, form of weight distribution kernel
D037PIXF= 0.8 / Drizzle, linear size of drop
D037COEF= 'cos01_45_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D037XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D037YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D037LAM = 555. / Drizzle, wavelength applied for transformation
D037EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D037INUN= 'counts ' / Drizzle, units of input image - counts or cps
D037OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D037FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D037INXC= 2049. / Drizzle, reference center of input image (X)
D037INYC= 1025. / Drizzle, reference center of input image (Y)
D037OUXC= 7001. / Drizzle, reference center of output image (X)
D037OUYC= 7201. / Drizzle, reference center of output image (Y)
D037SECP= F / Drizzle, there are no secondary geometric param
D038VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D038GEOM= 'Header WCS' / Drizzle, source of geometric information
D038DATA= 'cos01_45_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D038DEXP= 225. / Drizzle, input image exposure time (s)
D038OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D038OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D038OUCO= ' ' / Drizzle, output context image
D038MASK= 'cos01_45_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D038WTSC= 390814.3 / Drizzle, weighting factor for input image
D038KERN= 'square ' / Drizzle, form of weight distribution kernel
D038PIXF= 0.8 / Drizzle, linear size of drop
D038COEF= 'cos01_45_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D038XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D038YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D038LAM = 555. / Drizzle, wavelength applied for transformation
D038EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D038INUN= 'counts ' / Drizzle, units of input image - counts or cps
D038OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D038FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D038INXC= 2049. / Drizzle, reference center of input image (X)
D038INYC= 1025. / Drizzle, reference center of input image (Y)
D038OUXC= 7001. / Drizzle, reference center of output image (X)
D038OUYC= 7201. / Drizzle, reference center of output image (Y)
D038SECP= F / Drizzle, there are no secondary geometric param
D039VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D039GEOM= 'Header WCS' / Drizzle, source of geometric information
D039DATA= 'cos01_45_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D039DEXP= 407. / Drizzle, input image exposure time (s)
D039OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D039OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D039OUCO= ' ' / Drizzle, output context image
D039MASK= 'cos01_45_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D039WTSC= 1278743. / Drizzle, weighting factor for input image
D039KERN= 'square ' / Drizzle, form of weight distribution kernel
D039PIXF= 0.8 / Drizzle, linear size of drop
D039COEF= 'cos01_45_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D039XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D039YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D039LAM = 555. / Drizzle, wavelength applied for transformation
D039EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D039INUN= 'counts ' / Drizzle, units of input image - counts or cps
D039OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D039FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D039INXC= 2049. / Drizzle, reference center of input image (X)
D039INYC= 1025. / Drizzle, reference center of input image (Y)
D039OUXC= 7001. / Drizzle, reference center of output image (X)
D039OUYC= 7201. / Drizzle, reference center of output image (Y)
D039SECP= F / Drizzle, there are no secondary geometric param
D040VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D040GEOM= 'Header WCS' / Drizzle, source of geometric information
D040DATA= 'cos01_45_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D040DEXP= 407. / Drizzle, input image exposure time (s)
D040OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D040OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D040OUCO= ' ' / Drizzle, output context image
D040MASK= 'cos01_45_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D040WTSC= 1278743. / Drizzle, weighting factor for input image
D040KERN= 'square ' / Drizzle, form of weight distribution kernel
D040PIXF= 0.8 / Drizzle, linear size of drop
D040COEF= 'cos01_45_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D040XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D040YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D040LAM = 555. / Drizzle, wavelength applied for transformation
D040EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D040INUN= 'counts ' / Drizzle, units of input image - counts or cps
D040OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D040FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D040INXC= 2049. / Drizzle, reference center of input image (X)
D040INYC= 1025. / Drizzle, reference center of input image (Y)
D040OUXC= 7001. / Drizzle, reference center of output image (X)
D040OUYC= 7201. / Drizzle, reference center of output image (Y)
D040SECP= F / Drizzle, there are no secondary geometric param
D041VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D041GEOM= 'Header WCS' / Drizzle, source of geometric information
D041DATA= 'cos01_46_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D041DEXP= 225. / Drizzle, input image exposure time (s)
D041OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D041OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D041OUCO= ' ' / Drizzle, output context image
D041MASK= 'cos01_46_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D041WTSC= 390814. / Drizzle, weighting factor for input image
D041KERN= 'square ' / Drizzle, form of weight distribution kernel
D041PIXF= 0.8 / Drizzle, linear size of drop
D041COEF= 'cos01_46_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D041XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D041YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D041LAM = 555. / Drizzle, wavelength applied for transformation
D041EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D041INUN= 'counts ' / Drizzle, units of input image - counts or cps
D041OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D041FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D041INXC= 2049. / Drizzle, reference center of input image (X)
D041INYC= 1025. / Drizzle, reference center of input image (Y)
D041OUXC= 7001. / Drizzle, reference center of output image (X)
D041OUYC= 7201. / Drizzle, reference center of output image (Y)
D041SECP= F / Drizzle, there are no secondary geometric param
D042VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D042GEOM= 'Header WCS' / Drizzle, source of geometric information
D042DATA= 'cos01_46_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D042DEXP= 225. / Drizzle, input image exposure time (s)
D042OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D042OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D042OUCO= ' ' / Drizzle, output context image
D042MASK= 'cos01_46_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D042WTSC= 390814. / Drizzle, weighting factor for input image
D042KERN= 'square ' / Drizzle, form of weight distribution kernel
D042PIXF= 0.8 / Drizzle, linear size of drop
D042COEF= 'cos01_46_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D042XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D042YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D042LAM = 555. / Drizzle, wavelength applied for transformation
D042EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D042INUN= 'counts ' / Drizzle, units of input image - counts or cps
D042OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D042FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D042INXC= 2049. / Drizzle, reference center of input image (X)
D042INYC= 1025. / Drizzle, reference center of input image (Y)
D042OUXC= 7001. / Drizzle, reference center of output image (X)
D042OUYC= 7201. / Drizzle, reference center of output image (Y)
D042SECP= F / Drizzle, there are no secondary geometric param
D043VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D043GEOM= 'Header WCS' / Drizzle, source of geometric information
D043DATA= 'cos01_46_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D043DEXP= 407. / Drizzle, input image exposure time (s)
D043OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D043OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D043OUCO= ' ' / Drizzle, output context image
D043MASK= 'cos01_46_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D043WTSC= 1278739. / Drizzle, weighting factor for input image
D043KERN= 'square ' / Drizzle, form of weight distribution kernel
D043PIXF= 0.8 / Drizzle, linear size of drop
D043COEF= 'cos01_46_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D043XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D043YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D043LAM = 555. / Drizzle, wavelength applied for transformation
D043EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D043INUN= 'counts ' / Drizzle, units of input image - counts or cps
D043OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D043FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D043INXC= 2049. / Drizzle, reference center of input image (X)
D043INYC= 1025. / Drizzle, reference center of input image (Y)
D043OUXC= 7001. / Drizzle, reference center of output image (X)
D043OUYC= 7201. / Drizzle, reference center of output image (Y)
D043SECP= F / Drizzle, there are no secondary geometric param
D044VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D044GEOM= 'Header WCS' / Drizzle, source of geometric information
D044DATA= 'cos01_46_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D044DEXP= 407. / Drizzle, input image exposure time (s)
D044OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D044OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D044OUCO= ' ' / Drizzle, output context image
D044MASK= 'cos01_46_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D044WTSC= 1278739. / Drizzle, weighting factor for input image
D044KERN= 'square ' / Drizzle, form of weight distribution kernel
D044PIXF= 0.8 / Drizzle, linear size of drop
D044COEF= 'cos01_46_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D044XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D044YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D044LAM = 555. / Drizzle, wavelength applied for transformation
D044EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D044INUN= 'counts ' / Drizzle, units of input image - counts or cps
D044OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D044FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D044INXC= 2049. / Drizzle, reference center of input image (X)
D044INYC= 1025. / Drizzle, reference center of input image (Y)
D044OUXC= 7001. / Drizzle, reference center of output image (X)
D044OUYC= 7201. / Drizzle, reference center of output image (Y)
D044SECP= F / Drizzle, there are no secondary geometric param
D045VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D045GEOM= 'Header WCS' / Drizzle, source of geometric information
D045DATA= 'cos01_49_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D045DEXP= 225. / Drizzle, input image exposure time (s)
D045OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D045OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D045OUCO= ' ' / Drizzle, output context image
D045MASK= 'cos01_49_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D045WTSC= 390814.1 / Drizzle, weighting factor for input image
D045KERN= 'square ' / Drizzle, form of weight distribution kernel
D045PIXF= 0.8 / Drizzle, linear size of drop
D045COEF= 'cos01_49_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D045XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D045YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D045LAM = 555. / Drizzle, wavelength applied for transformation
D045EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D045INUN= 'counts ' / Drizzle, units of input image - counts or cps
D045OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D045FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D045INXC= 2049. / Drizzle, reference center of input image (X)
D045INYC= 1025. / Drizzle, reference center of input image (Y)
D045OUXC= 7001. / Drizzle, reference center of output image (X)
D045OUYC= 7201. / Drizzle, reference center of output image (Y)
D045SECP= F / Drizzle, there are no secondary geometric param
D046VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D046GEOM= 'Header WCS' / Drizzle, source of geometric information
D046DATA= 'cos01_49_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D046DEXP= 407. / Drizzle, input image exposure time (s)
D046OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D046OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D046OUCO= ' ' / Drizzle, output context image
D046MASK= 'cos01_49_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D046WTSC= 1278740. / Drizzle, weighting factor for input image
D046KERN= 'square ' / Drizzle, form of weight distribution kernel
D046PIXF= 0.8 / Drizzle, linear size of drop
D046COEF= 'cos01_49_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D046XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D046YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D046LAM = 555. / Drizzle, wavelength applied for transformation
D046EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D046INUN= 'counts ' / Drizzle, units of input image - counts or cps
D046OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D046FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D046INXC= 2049. / Drizzle, reference center of input image (X)
D046INYC= 1025. / Drizzle, reference center of input image (Y)
D046OUXC= 7001. / Drizzle, reference center of output image (X)
D046OUYC= 7201. / Drizzle, reference center of output image (Y)
D046SECP= F / Drizzle, there are no secondary geometric param
D047VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D047GEOM= 'Header WCS' / Drizzle, source of geometric information
D047DATA= 'cos01_50_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D047DEXP= 225. / Drizzle, input image exposure time (s)
D047OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D047OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D047OUCO= ' ' / Drizzle, output context image
D047MASK= 'cos01_50_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D047WTSC= 390814.2 / Drizzle, weighting factor for input image
D047KERN= 'square ' / Drizzle, form of weight distribution kernel
D047PIXF= 0.8 / Drizzle, linear size of drop
D047COEF= 'cos01_50_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D047XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D047YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D047LAM = 555. / Drizzle, wavelength applied for transformation
D047EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D047INUN= 'counts ' / Drizzle, units of input image - counts or cps
D047OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D047FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D047INXC= 2049. / Drizzle, reference center of input image (X)
D047INYC= 1025. / Drizzle, reference center of input image (Y)
D047OUXC= 7001. / Drizzle, reference center of output image (X)
D047OUYC= 7201. / Drizzle, reference center of output image (Y)
D047SECP= F / Drizzle, there are no secondary geometric param
D048VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D048GEOM= 'Header WCS' / Drizzle, source of geometric information
D048DATA= 'cos01_50_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D048DEXP= 225. / Drizzle, input image exposure time (s)
D048OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D048OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D048OUCO= ' ' / Drizzle, output context image
D048MASK= 'cos01_50_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D048WTSC= 390814.2 / Drizzle, weighting factor for input image
D048KERN= 'square ' / Drizzle, form of weight distribution kernel
D048PIXF= 0.8 / Drizzle, linear size of drop
D048COEF= 'cos01_50_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D048XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D048YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D048LAM = 555. / Drizzle, wavelength applied for transformation
D048EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D048INUN= 'counts ' / Drizzle, units of input image - counts or cps
D048OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D048FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D048INXC= 2049. / Drizzle, reference center of input image (X)
D048INYC= 1025. / Drizzle, reference center of input image (Y)
D048OUXC= 7001. / Drizzle, reference center of output image (X)
D048OUYC= 7201. / Drizzle, reference center of output image (Y)
D048SECP= F / Drizzle, there are no secondary geometric param
D049VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D049GEOM= 'Header WCS' / Drizzle, source of geometric information
D049DATA= 'cos01_50_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D049DEXP= 407. / Drizzle, input image exposure time (s)
D049OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D049OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D049OUCO= ' ' / Drizzle, output context image
D049MASK= 'cos01_50_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D049WTSC= 1278740. / Drizzle, weighting factor for input image
D049KERN= 'square ' / Drizzle, form of weight distribution kernel
D049PIXF= 0.8 / Drizzle, linear size of drop
D049COEF= 'cos01_50_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D049XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D049YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D049LAM = 555. / Drizzle, wavelength applied for transformation
D049EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D049INUN= 'counts ' / Drizzle, units of input image - counts or cps
D049OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D049FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D049INXC= 2049. / Drizzle, reference center of input image (X)
D049INYC= 1025. / Drizzle, reference center of input image (Y)
D049OUXC= 7001. / Drizzle, reference center of output image (X)
D049OUYC= 7201. / Drizzle, reference center of output image (Y)
D049SECP= F / Drizzle, there are no secondary geometric param
D050VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D050GEOM= 'Header WCS' / Drizzle, source of geometric information
D050DATA= 'cos01_50_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D050DEXP= 407. / Drizzle, input image exposure time (s)
D050OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D050OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D050OUCO= ' ' / Drizzle, output context image
D050MASK= 'cos01_50_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D050WTSC= 1278740. / Drizzle, weighting factor for input image
D050KERN= 'square ' / Drizzle, form of weight distribution kernel
D050PIXF= 0.8 / Drizzle, linear size of drop
D050COEF= 'cos01_50_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D050XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D050YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D050LAM = 555. / Drizzle, wavelength applied for transformation
D050EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D050INUN= 'counts ' / Drizzle, units of input image - counts or cps
D050OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D050FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D050INXC= 2049. / Drizzle, reference center of input image (X)
D050INYC= 1025. / Drizzle, reference center of input image (Y)
D050OUXC= 7001. / Drizzle, reference center of output image (X)
D050OUYC= 7201. / Drizzle, reference center of output image (Y)
D050SECP= F / Drizzle, there are no secondary geometric param
D051VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D051GEOM= 'Header WCS' / Drizzle, source of geometric information
D051DATA= 'cos02_72_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D051DEXP= 275. / Drizzle, input image exposure time (s)
D051OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D051OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D051OUCO= ' ' / Drizzle, output context image
D051MASK= 'cos02_72_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D051WTSC= 583572.3 / Drizzle, weighting factor for input image
D051KERN= 'square ' / Drizzle, form of weight distribution kernel
D051PIXF= 0.8 / Drizzle, linear size of drop
D051COEF= 'cos02_72_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D051XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D051YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D051LAM = 555. / Drizzle, wavelength applied for transformation
D051EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D051INUN= 'counts ' / Drizzle, units of input image - counts or cps
D051OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D051FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D051INXC= 2049. / Drizzle, reference center of input image (X)
D051INYC= 1025. / Drizzle, reference center of input image (Y)
D051OUXC= 7001. / Drizzle, reference center of output image (X)
D051OUYC= 7201. / Drizzle, reference center of output image (Y)
D051SECP= F / Drizzle, there are no secondary geometric param
D052VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D052GEOM= 'Header WCS' / Drizzle, source of geometric information
D052DATA= 'cos02_72_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D052DEXP= 407. / Drizzle, input image exposure time (s)
D052OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D052OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D052OUCO= ' ' / Drizzle, output context image
D052MASK= 'cos02_72_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D052WTSC= 1278505. / Drizzle, weighting factor for input image
D052KERN= 'square ' / Drizzle, form of weight distribution kernel
D052PIXF= 0.8 / Drizzle, linear size of drop
D052COEF= 'cos02_72_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D052XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D052YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D052LAM = 555. / Drizzle, wavelength applied for transformation
D052EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D052INUN= 'counts ' / Drizzle, units of input image - counts or cps
D052OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D052FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D052INXC= 2049. / Drizzle, reference center of input image (X)
D052INYC= 1025. / Drizzle, reference center of input image (Y)
D052OUXC= 7001. / Drizzle, reference center of output image (X)
D052OUYC= 7201. / Drizzle, reference center of output image (Y)
D052SECP= F / Drizzle, there are no secondary geometric param
D053VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D053GEOM= 'Header WCS' / Drizzle, source of geometric information
D053DATA= 'cos02_73_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D053DEXP= 275. / Drizzle, input image exposure time (s)
D053OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D053OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D053OUCO= ' ' / Drizzle, output context image
D053MASK= 'cos02_73_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D053WTSC= 583662.8 / Drizzle, weighting factor for input image
D053KERN= 'square ' / Drizzle, form of weight distribution kernel
D053PIXF= 0.8 / Drizzle, linear size of drop
D053COEF= 'cos02_73_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D053XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D053YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D053LAM = 555. / Drizzle, wavelength applied for transformation
D053EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D053INUN= 'counts ' / Drizzle, units of input image - counts or cps
D053OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D053FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D053INXC= 2049. / Drizzle, reference center of input image (X)
D053INYC= 1025. / Drizzle, reference center of input image (Y)
D053OUXC= 7001. / Drizzle, reference center of output image (X)
D053OUYC= 7201. / Drizzle, reference center of output image (Y)
D053SECP= F / Drizzle, there are no secondary geometric param
D054VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D054GEOM= 'Header WCS' / Drizzle, source of geometric information
D054DATA= 'cos02_73_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D054DEXP= 407. / Drizzle, input image exposure time (s)
D054OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D054OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D054OUCO= ' ' / Drizzle, output context image
D054MASK= 'cos02_73_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D054WTSC= 1278391. / Drizzle, weighting factor for input image
D054KERN= 'square ' / Drizzle, form of weight distribution kernel
D054PIXF= 0.8 / Drizzle, linear size of drop
D054COEF= 'cos02_73_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D054XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D054YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D054LAM = 555. / Drizzle, wavelength applied for transformation
D054EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D054INUN= 'counts ' / Drizzle, units of input image - counts or cps
D054OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D054FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D054INXC= 2049. / Drizzle, reference center of input image (X)
D054INYC= 1025. / Drizzle, reference center of input image (Y)
D054OUXC= 7001. / Drizzle, reference center of output image (X)
D054OUYC= 7201. / Drizzle, reference center of output image (Y)
D054SECP= F / Drizzle, there are no secondary geometric param
D055VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D055GEOM= 'Header WCS' / Drizzle, source of geometric information
D055DATA= 'cos02_74_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D055DEXP= 275. / Drizzle, input image exposure time (s)
D055OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D055OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D055OUCO= ' ' / Drizzle, output context image
D055MASK= 'cos02_74_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D055WTSC= 583683.6 / Drizzle, weighting factor for input image
D055KERN= 'square ' / Drizzle, form of weight distribution kernel
D055PIXF= 0.8 / Drizzle, linear size of drop
D055COEF= 'cos02_74_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D055XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D055YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D055LAM = 555. / Drizzle, wavelength applied for transformation
D055EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D055INUN= 'counts ' / Drizzle, units of input image - counts or cps
D055OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D055FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D055INXC= 2049. / Drizzle, reference center of input image (X)
D055INYC= 1025. / Drizzle, reference center of input image (Y)
D055OUXC= 7001. / Drizzle, reference center of output image (X)
D055OUYC= 7201. / Drizzle, reference center of output image (Y)
D055SECP= F / Drizzle, there are no secondary geometric param
D056VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D056GEOM= 'Header WCS' / Drizzle, source of geometric information
D056DATA= 'cos02_74_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D056DEXP= 407. / Drizzle, input image exposure time (s)
D056OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D056OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D056OUCO= ' ' / Drizzle, output context image
D056MASK= 'cos02_74_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D056WTSC= 1278462. / Drizzle, weighting factor for input image
D056KERN= 'square ' / Drizzle, form of weight distribution kernel
D056PIXF= 0.8 / Drizzle, linear size of drop
D056COEF= 'cos02_74_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D056XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D056YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D056LAM = 555. / Drizzle, wavelength applied for transformation
D056EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D056INUN= 'counts ' / Drizzle, units of input image - counts or cps
D056OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D056FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D056INXC= 2049. / Drizzle, reference center of input image (X)
D056INYC= 1025. / Drizzle, reference center of input image (Y)
D056OUXC= 7001. / Drizzle, reference center of output image (X)
D056OUYC= 7201. / Drizzle, reference center of output image (Y)
D056SECP= F / Drizzle, there are no secondary geometric param
D057VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D057GEOM= 'Header WCS' / Drizzle, source of geometric information
D057DATA= 'cos02_76_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D057DEXP= 275. / Drizzle, input image exposure time (s)
D057OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D057OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D057OUCO= ' ' / Drizzle, output context image
D057MASK= 'cos02_76_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D057WTSC= 583685.8 / Drizzle, weighting factor for input image
D057KERN= 'square ' / Drizzle, form of weight distribution kernel
D057PIXF= 0.8 / Drizzle, linear size of drop
D057COEF= 'cos02_76_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D057XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D057YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D057LAM = 555. / Drizzle, wavelength applied for transformation
D057EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D057INUN= 'counts ' / Drizzle, units of input image - counts or cps
D057OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D057FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D057INXC= 2049. / Drizzle, reference center of input image (X)
D057INYC= 1025. / Drizzle, reference center of input image (Y)
D057OUXC= 7001. / Drizzle, reference center of output image (X)
D057OUYC= 7201. / Drizzle, reference center of output image (Y)
D057SECP= F / Drizzle, there are no secondary geometric param
D058VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D058GEOM= 'Header WCS' / Drizzle, source of geometric information
D058DATA= 'cos02_76_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D058DEXP= 407. / Drizzle, input image exposure time (s)
D058OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D058OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D058OUCO= ' ' / Drizzle, output context image
D058MASK= 'cos02_76_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D058WTSC= 1278469. / Drizzle, weighting factor for input image
D058KERN= 'square ' / Drizzle, form of weight distribution kernel
D058PIXF= 0.8 / Drizzle, linear size of drop
D058COEF= 'cos02_76_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D058XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D058YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D058LAM = 555. / Drizzle, wavelength applied for transformation
D058EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D058INUN= 'counts ' / Drizzle, units of input image - counts or cps
D058OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D058FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D058INXC= 2049. / Drizzle, reference center of input image (X)
D058INYC= 1025. / Drizzle, reference center of input image (Y)
D058OUXC= 7001. / Drizzle, reference center of output image (X)
D058OUYC= 7201. / Drizzle, reference center of output image (Y)
D058SECP= F / Drizzle, there are no secondary geometric param
D059VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D059GEOM= 'Header WCS' / Drizzle, source of geometric information
D059DATA= 'cos02_77_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D059DEXP= 275. / Drizzle, input image exposure time (s)
D059OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D059OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D059OUCO= ' ' / Drizzle, output context image
D059MASK= 'cos02_77_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D059WTSC= 583685.2 / Drizzle, weighting factor for input image
D059KERN= 'square ' / Drizzle, form of weight distribution kernel
D059PIXF= 0.8 / Drizzle, linear size of drop
D059COEF= 'cos02_77_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D059XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D059YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D059LAM = 555. / Drizzle, wavelength applied for transformation
D059EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D059INUN= 'counts ' / Drizzle, units of input image - counts or cps
D059OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D059FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D059INXC= 2049. / Drizzle, reference center of input image (X)
D059INYC= 1025. / Drizzle, reference center of input image (Y)
D059OUXC= 7001. / Drizzle, reference center of output image (X)
D059OUYC= 7201. / Drizzle, reference center of output image (Y)
D059SECP= F / Drizzle, there are no secondary geometric param
D060VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D060GEOM= 'Header WCS' / Drizzle, source of geometric information
D060DATA= 'cos02_77_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D060DEXP= 275. / Drizzle, input image exposure time (s)
D060OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D060OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D060OUCO= ' ' / Drizzle, output context image
D060MASK= 'cos02_77_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D060WTSC= 583685.2 / Drizzle, weighting factor for input image
D060KERN= 'square ' / Drizzle, form of weight distribution kernel
D060PIXF= 0.8 / Drizzle, linear size of drop
D060COEF= 'cos02_77_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D060XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D060YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D060LAM = 555. / Drizzle, wavelength applied for transformation
D060EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D060INUN= 'counts ' / Drizzle, units of input image - counts or cps
D060OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D060FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D060INXC= 2049. / Drizzle, reference center of input image (X)
D060INYC= 1025. / Drizzle, reference center of input image (Y)
D060OUXC= 7001. / Drizzle, reference center of output image (X)
D060OUYC= 7201. / Drizzle, reference center of output image (Y)
D060SECP= F / Drizzle, there are no secondary geometric param
D061VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D061GEOM= 'Header WCS' / Drizzle, source of geometric information
D061DATA= 'cos02_77_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D061DEXP= 407. / Drizzle, input image exposure time (s)
D061OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D061OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D061OUCO= ' ' / Drizzle, output context image
D061MASK= 'cos02_77_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D061WTSC= 1278466. / Drizzle, weighting factor for input image
D061KERN= 'square ' / Drizzle, form of weight distribution kernel
D061PIXF= 0.8 / Drizzle, linear size of drop
D061COEF= 'cos02_77_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D061XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D061YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D061LAM = 555. / Drizzle, wavelength applied for transformation
D061EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D061INUN= 'counts ' / Drizzle, units of input image - counts or cps
D061OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D061FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D061INXC= 2049. / Drizzle, reference center of input image (X)
D061INYC= 1025. / Drizzle, reference center of input image (Y)
D061OUXC= 7001. / Drizzle, reference center of output image (X)
D061OUYC= 7201. / Drizzle, reference center of output image (Y)
D061SECP= F / Drizzle, there are no secondary geometric param
D062VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D062GEOM= 'Header WCS' / Drizzle, source of geometric information
D062DATA= 'cos02_77_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D062DEXP= 407. / Drizzle, input image exposure time (s)
D062OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D062OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D062OUCO= ' ' / Drizzle, output context image
D062MASK= 'cos02_77_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D062WTSC= 1278466. / Drizzle, weighting factor for input image
D062KERN= 'square ' / Drizzle, form of weight distribution kernel
D062PIXF= 0.8 / Drizzle, linear size of drop
D062COEF= 'cos02_77_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D062XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D062YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D062LAM = 555. / Drizzle, wavelength applied for transformation
D062EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D062INUN= 'counts ' / Drizzle, units of input image - counts or cps
D062OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D062FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D062INXC= 2049. / Drizzle, reference center of input image (X)
D062INYC= 1025. / Drizzle, reference center of input image (Y)
D062OUXC= 7001. / Drizzle, reference center of output image (X)
D062OUYC= 7201. / Drizzle, reference center of output image (Y)
D062SECP= F / Drizzle, there are no secondary geometric param
D063VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D063GEOM= 'Header WCS' / Drizzle, source of geometric information
D063DATA= 'cos02_78_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D063DEXP= 275. / Drizzle, input image exposure time (s)
D063OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D063OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D063OUCO= ' ' / Drizzle, output context image
D063MASK= 'cos02_78_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D063WTSC= 583685.3 / Drizzle, weighting factor for input image
D063KERN= 'square ' / Drizzle, form of weight distribution kernel
D063PIXF= 0.8 / Drizzle, linear size of drop
D063COEF= 'cos02_78_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D063XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D063YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D063LAM = 555. / Drizzle, wavelength applied for transformation
D063EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D063INUN= 'counts ' / Drizzle, units of input image - counts or cps
D063OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D063FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D063INXC= 2049. / Drizzle, reference center of input image (X)
D063INYC= 1025. / Drizzle, reference center of input image (Y)
D063OUXC= 7001. / Drizzle, reference center of output image (X)
D063OUYC= 7201. / Drizzle, reference center of output image (Y)
D063SECP= F / Drizzle, there are no secondary geometric param
D064VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D064GEOM= 'Header WCS' / Drizzle, source of geometric information
D064DATA= 'cos02_78_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D064DEXP= 275. / Drizzle, input image exposure time (s)
D064OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D064OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D064OUCO= ' ' / Drizzle, output context image
D064MASK= 'cos02_78_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D064WTSC= 583685.3 / Drizzle, weighting factor for input image
D064KERN= 'square ' / Drizzle, form of weight distribution kernel
D064PIXF= 0.8 / Drizzle, linear size of drop
D064COEF= 'cos02_78_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D064XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D064YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D064LAM = 555. / Drizzle, wavelength applied for transformation
D064EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D064INUN= 'counts ' / Drizzle, units of input image - counts or cps
D064OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D064FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D064INXC= 2049. / Drizzle, reference center of input image (X)
D064INYC= 1025. / Drizzle, reference center of input image (Y)
D064OUXC= 7001. / Drizzle, reference center of output image (X)
D064OUYC= 7201. / Drizzle, reference center of output image (Y)
D064SECP= F / Drizzle, there are no secondary geometric param
D065VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D065GEOM= 'Header WCS' / Drizzle, source of geometric information
D065DATA= 'cos02_78_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D065DEXP= 407. / Drizzle, input image exposure time (s)
D065OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D065OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D065OUCO= ' ' / Drizzle, output context image
D065MASK= 'cos02_78_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D065WTSC= 1278466. / Drizzle, weighting factor for input image
D065KERN= 'square ' / Drizzle, form of weight distribution kernel
D065PIXF= 0.8 / Drizzle, linear size of drop
D065COEF= 'cos02_78_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D065XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D065YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D065LAM = 555. / Drizzle, wavelength applied for transformation
D065EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D065INUN= 'counts ' / Drizzle, units of input image - counts or cps
D065OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D065FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D065INXC= 2049. / Drizzle, reference center of input image (X)
D065INYC= 1025. / Drizzle, reference center of input image (Y)
D065OUXC= 7001. / Drizzle, reference center of output image (X)
D065OUYC= 7201. / Drizzle, reference center of output image (Y)
D065SECP= F / Drizzle, there are no secondary geometric param
D066VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D066GEOM= 'Header WCS' / Drizzle, source of geometric information
D066DATA= 'cos02_78_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D066DEXP= 407. / Drizzle, input image exposure time (s)
D066OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D066OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D066OUCO= ' ' / Drizzle, output context image
D066MASK= 'cos02_78_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D066WTSC= 1278466. / Drizzle, weighting factor for input image
D066KERN= 'square ' / Drizzle, form of weight distribution kernel
D066PIXF= 0.8 / Drizzle, linear size of drop
D066COEF= 'cos02_78_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D066XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D066YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D066LAM = 555. / Drizzle, wavelength applied for transformation
D066EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D066INUN= 'counts ' / Drizzle, units of input image - counts or cps
D066OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D066FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D066INXC= 2049. / Drizzle, reference center of input image (X)
D066INYC= 1025. / Drizzle, reference center of input image (Y)
D066OUXC= 7001. / Drizzle, reference center of output image (X)
D066OUYC= 7201. / Drizzle, reference center of output image (Y)
D066SECP= F / Drizzle, there are no secondary geometric param
D067VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D067GEOM= 'Header WCS' / Drizzle, source of geometric information
D067DATA= 'cos02_80_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D067DEXP= 275. / Drizzle, input image exposure time (s)
D067OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D067OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D067OUCO= ' ' / Drizzle, output context image
D067MASK= 'cos02_80_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D067WTSC= 583685.9 / Drizzle, weighting factor for input image
D067KERN= 'square ' / Drizzle, form of weight distribution kernel
D067PIXF= 0.8 / Drizzle, linear size of drop
D067COEF= 'cos02_80_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D067XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D067YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D067LAM = 555. / Drizzle, wavelength applied for transformation
D067EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D067INUN= 'counts ' / Drizzle, units of input image - counts or cps
D067OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D067FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D067INXC= 2049. / Drizzle, reference center of input image (X)
D067INYC= 1025. / Drizzle, reference center of input image (Y)
D067OUXC= 7001. / Drizzle, reference center of output image (X)
D067OUYC= 7201. / Drizzle, reference center of output image (Y)
D067SECP= F / Drizzle, there are no secondary geometric param
D068VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D068GEOM= 'Header WCS' / Drizzle, source of geometric information
D068DATA= 'cos02_80_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D068DEXP= 407. / Drizzle, input image exposure time (s)
D068OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D068OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D068OUCO= ' ' / Drizzle, output context image
D068MASK= 'cos02_80_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D068WTSC= 1278468. / Drizzle, weighting factor for input image
D068KERN= 'square ' / Drizzle, form of weight distribution kernel
D068PIXF= 0.8 / Drizzle, linear size of drop
D068COEF= 'cos02_80_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D068XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D068YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D068LAM = 555. / Drizzle, wavelength applied for transformation
D068EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D068INUN= 'counts ' / Drizzle, units of input image - counts or cps
D068OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D068FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D068INXC= 2049. / Drizzle, reference center of input image (X)
D068INYC= 1025. / Drizzle, reference center of input image (Y)
D068OUXC= 7001. / Drizzle, reference center of output image (X)
D068OUYC= 7201. / Drizzle, reference center of output image (Y)
D068SECP= F / Drizzle, there are no secondary geometric param
D069VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D069GEOM= 'Header WCS' / Drizzle, source of geometric information
D069DATA= 'cos02_81_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D069DEXP= 275. / Drizzle, input image exposure time (s)
D069OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D069OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D069OUCO= ' ' / Drizzle, output context image
D069MASK= 'cos02_81_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D069WTSC= 583576.4 / Drizzle, weighting factor for input image
D069KERN= 'square ' / Drizzle, form of weight distribution kernel
D069PIXF= 0.8 / Drizzle, linear size of drop
D069COEF= 'cos02_81_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D069XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D069YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D069LAM = 555. / Drizzle, wavelength applied for transformation
D069EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D069INUN= 'counts ' / Drizzle, units of input image - counts or cps
D069OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D069FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D069INXC= 2049. / Drizzle, reference center of input image (X)
D069INYC= 1025. / Drizzle, reference center of input image (Y)
D069OUXC= 7001. / Drizzle, reference center of output image (X)
D069OUYC= 7201. / Drizzle, reference center of output image (Y)
D069SECP= F / Drizzle, there are no secondary geometric param
D070VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D070GEOM= 'Header WCS' / Drizzle, source of geometric information
D070DATA= 'cos02_81_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D070DEXP= 275. / Drizzle, input image exposure time (s)
D070OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D070OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D070OUCO= ' ' / Drizzle, output context image
D070MASK= 'cos02_81_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D070WTSC= 583576.4 / Drizzle, weighting factor for input image
D070KERN= 'square ' / Drizzle, form of weight distribution kernel
D070PIXF= 0.8 / Drizzle, linear size of drop
D070COEF= 'cos02_81_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D070XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D070YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D070LAM = 555. / Drizzle, wavelength applied for transformation
D070EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D070INUN= 'counts ' / Drizzle, units of input image - counts or cps
D070OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D070FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D070INXC= 2049. / Drizzle, reference center of input image (X)
D070INYC= 1025. / Drizzle, reference center of input image (Y)
D070OUXC= 7001. / Drizzle, reference center of output image (X)
D070OUYC= 7201. / Drizzle, reference center of output image (Y)
D070SECP= F / Drizzle, there are no secondary geometric param
D071VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D071GEOM= 'Header WCS' / Drizzle, source of geometric information
D071DATA= 'cos02_81_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D071DEXP= 407. / Drizzle, input image exposure time (s)
D071OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D071OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D071OUCO= ' ' / Drizzle, output context image
D071MASK= 'cos02_81_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D071WTSC= 1278511. / Drizzle, weighting factor for input image
D071KERN= 'square ' / Drizzle, form of weight distribution kernel
D071PIXF= 0.8 / Drizzle, linear size of drop
D071COEF= 'cos02_81_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D071XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D071YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D071LAM = 555. / Drizzle, wavelength applied for transformation
D071EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D071INUN= 'counts ' / Drizzle, units of input image - counts or cps
D071OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D071FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D071INXC= 2049. / Drizzle, reference center of input image (X)
D071INYC= 1025. / Drizzle, reference center of input image (Y)
D071OUXC= 7001. / Drizzle, reference center of output image (X)
D071OUYC= 7201. / Drizzle, reference center of output image (Y)
D071SECP= F / Drizzle, there are no secondary geometric param
D072VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D072GEOM= 'Header WCS' / Drizzle, source of geometric information
D072DATA= 'cos02_81_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D072DEXP= 407. / Drizzle, input image exposure time (s)
D072OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D072OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D072OUCO= ' ' / Drizzle, output context image
D072MASK= 'cos02_81_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D072WTSC= 1278511. / Drizzle, weighting factor for input image
D072KERN= 'square ' / Drizzle, form of weight distribution kernel
D072PIXF= 0.8 / Drizzle, linear size of drop
D072COEF= 'cos02_81_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D072XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D072YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D072LAM = 555. / Drizzle, wavelength applied for transformation
D072EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D072INUN= 'counts ' / Drizzle, units of input image - counts or cps
D072OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D072FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D072INXC= 2049. / Drizzle, reference center of input image (X)
D072INYC= 1025. / Drizzle, reference center of input image (Y)
D072OUXC= 7001. / Drizzle, reference center of output image (X)
D072OUYC= 7201. / Drizzle, reference center of output image (Y)
D072SECP= F / Drizzle, there are no secondary geometric param
D073VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D073GEOM= 'Header WCS' / Drizzle, source of geometric information
D073DATA= 'cos02_82_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D073DEXP= 275. / Drizzle, input image exposure time (s)
D073OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D073OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D073OUCO= ' ' / Drizzle, output context image
D073MASK= 'cos02_82_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D073WTSC= 583665.9 / Drizzle, weighting factor for input image
D073KERN= 'square ' / Drizzle, form of weight distribution kernel
D073PIXF= 0.8 / Drizzle, linear size of drop
D073COEF= 'cos02_82_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D073XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D073YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D073LAM = 555. / Drizzle, wavelength applied for transformation
D073EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D073INUN= 'counts ' / Drizzle, units of input image - counts or cps
D073OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D073FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D073INXC= 2049. / Drizzle, reference center of input image (X)
D073INYC= 1025. / Drizzle, reference center of input image (Y)
D073OUXC= 7001. / Drizzle, reference center of output image (X)
D073OUYC= 7201. / Drizzle, reference center of output image (Y)
D073SECP= F / Drizzle, there are no secondary geometric param
D074VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D074GEOM= 'Header WCS' / Drizzle, source of geometric information
D074DATA= 'cos02_82_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D074DEXP= 275. / Drizzle, input image exposure time (s)
D074OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D074OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D074OUCO= ' ' / Drizzle, output context image
D074MASK= 'cos02_82_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D074WTSC= 583665.9 / Drizzle, weighting factor for input image
D074KERN= 'square ' / Drizzle, form of weight distribution kernel
D074PIXF= 0.8 / Drizzle, linear size of drop
D074COEF= 'cos02_82_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D074XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D074YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D074LAM = 555. / Drizzle, wavelength applied for transformation
D074EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D074INUN= 'counts ' / Drizzle, units of input image - counts or cps
D074OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D074FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D074INXC= 2049. / Drizzle, reference center of input image (X)
D074INYC= 1025. / Drizzle, reference center of input image (Y)
D074OUXC= 7001. / Drizzle, reference center of output image (X)
D074OUYC= 7201. / Drizzle, reference center of output image (Y)
D074SECP= F / Drizzle, there are no secondary geometric param
D075VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D075GEOM= 'Header WCS' / Drizzle, source of geometric information
D075DATA= 'cos02_82_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D075DEXP= 407. / Drizzle, input image exposure time (s)
D075OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D075OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D075OUCO= ' ' / Drizzle, output context image
D075MASK= 'cos02_82_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D075WTSC= 1278398. / Drizzle, weighting factor for input image
D075KERN= 'square ' / Drizzle, form of weight distribution kernel
D075PIXF= 0.8 / Drizzle, linear size of drop
D075COEF= 'cos02_82_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D075XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D075YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D075LAM = 555. / Drizzle, wavelength applied for transformation
D075EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D075INUN= 'counts ' / Drizzle, units of input image - counts or cps
D075OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D075FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D075INXC= 2049. / Drizzle, reference center of input image (X)
D075INYC= 1025. / Drizzle, reference center of input image (Y)
D075OUXC= 7001. / Drizzle, reference center of output image (X)
D075OUYC= 7201. / Drizzle, reference center of output image (Y)
D075SECP= F / Drizzle, there are no secondary geometric param
D076VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D076GEOM= 'Header WCS' / Drizzle, source of geometric information
D076DATA= 'cos02_82_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D076DEXP= 407. / Drizzle, input image exposure time (s)
D076OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D076OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D076OUCO= ' ' / Drizzle, output context image
D076MASK= 'cos02_82_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D076WTSC= 1278398. / Drizzle, weighting factor for input image
D076KERN= 'square ' / Drizzle, form of weight distribution kernel
D076PIXF= 0.8 / Drizzle, linear size of drop
D076COEF= 'cos02_82_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D076XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D076YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D076LAM = 555. / Drizzle, wavelength applied for transformation
D076EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D076INUN= 'counts ' / Drizzle, units of input image - counts or cps
D076OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D076FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D076INXC= 2049. / Drizzle, reference center of input image (X)
D076INYC= 1025. / Drizzle, reference center of input image (Y)
D076OUXC= 7001. / Drizzle, reference center of output image (X)
D076OUYC= 7201. / Drizzle, reference center of output image (Y)
D076SECP= F / Drizzle, there are no secondary geometric param
D077VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D077GEOM= 'Header WCS' / Drizzle, source of geometric information
D077DATA= 'cos02_84_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D077DEXP= 225. / Drizzle, input image exposure time (s)
D077OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D077OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D077OUCO= ' ' / Drizzle, output context image
D077MASK= 'cos02_84_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D077WTSC= 390733.3 / Drizzle, weighting factor for input image
D077KERN= 'square ' / Drizzle, form of weight distribution kernel
D077PIXF= 0.8 / Drizzle, linear size of drop
D077COEF= 'cos02_84_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D077XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D077YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D077LAM = 555. / Drizzle, wavelength applied for transformation
D077EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D077INUN= 'counts ' / Drizzle, units of input image - counts or cps
D077OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D077FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D077INXC= 2049. / Drizzle, reference center of input image (X)
D077INYC= 1025. / Drizzle, reference center of input image (Y)
D077OUXC= 7001. / Drizzle, reference center of output image (X)
D077OUYC= 7201. / Drizzle, reference center of output image (Y)
D077SECP= F / Drizzle, there are no secondary geometric param
D078VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D078GEOM= 'Header WCS' / Drizzle, source of geometric information
D078DATA= 'cos02_84_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D078DEXP= 407. / Drizzle, input image exposure time (s)
D078OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D078OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D078OUCO= ' ' / Drizzle, output context image
D078MASK= 'cos02_84_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D078WTSC= 1278475. / Drizzle, weighting factor for input image
D078KERN= 'square ' / Drizzle, form of weight distribution kernel
D078PIXF= 0.8 / Drizzle, linear size of drop
D078COEF= 'cos02_84_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D078XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D078YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D078LAM = 555. / Drizzle, wavelength applied for transformation
D078EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D078INUN= 'counts ' / Drizzle, units of input image - counts or cps
D078OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D078FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D078INXC= 2049. / Drizzle, reference center of input image (X)
D078INYC= 1025. / Drizzle, reference center of input image (Y)
D078OUXC= 7001. / Drizzle, reference center of output image (X)
D078OUYC= 7201. / Drizzle, reference center of output image (Y)
D078SECP= F / Drizzle, there are no secondary geometric param
D079VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D079GEOM= 'Header WCS' / Drizzle, source of geometric information
D079DATA= 'cos02_85_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D079DEXP= 225. / Drizzle, input image exposure time (s)
D079OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D079OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D079OUCO= ' ' / Drizzle, output context image
D079MASK= 'cos02_85_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D079WTSC= 390734.6 / Drizzle, weighting factor for input image
D079KERN= 'square ' / Drizzle, form of weight distribution kernel
D079PIXF= 0.8 / Drizzle, linear size of drop
D079COEF= 'cos02_85_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D079XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D079YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D079LAM = 555. / Drizzle, wavelength applied for transformation
D079EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D079INUN= 'counts ' / Drizzle, units of input image - counts or cps
D079OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D079FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D079INXC= 2049. / Drizzle, reference center of input image (X)
D079INYC= 1025. / Drizzle, reference center of input image (Y)
D079OUXC= 7001. / Drizzle, reference center of output image (X)
D079OUYC= 7201. / Drizzle, reference center of output image (Y)
D079SECP= F / Drizzle, there are no secondary geometric param
D080VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D080GEOM= 'Header WCS' / Drizzle, source of geometric information
D080DATA= 'cos02_85_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D080DEXP= 225. / Drizzle, input image exposure time (s)
D080OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D080OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D080OUCO= ' ' / Drizzle, output context image
D080MASK= 'cos02_85_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D080WTSC= 390734.6 / Drizzle, weighting factor for input image
D080KERN= 'square ' / Drizzle, form of weight distribution kernel
D080PIXF= 0.8 / Drizzle, linear size of drop
D080COEF= 'cos02_85_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D080XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D080YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D080LAM = 555. / Drizzle, wavelength applied for transformation
D080EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D080INUN= 'counts ' / Drizzle, units of input image - counts or cps
D080OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D080FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D080INXC= 2049. / Drizzle, reference center of input image (X)
D080INYC= 1025. / Drizzle, reference center of input image (Y)
D080OUXC= 7001. / Drizzle, reference center of output image (X)
D080OUYC= 7201. / Drizzle, reference center of output image (Y)
D080SECP= F / Drizzle, there are no secondary geometric param
D081VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D081GEOM= 'Header WCS' / Drizzle, source of geometric information
D081DATA= 'cos02_85_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D081DEXP= 407. / Drizzle, input image exposure time (s)
D081OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D081OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D081OUCO= ' ' / Drizzle, output context image
D081MASK= 'cos02_85_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D081WTSC= 1278483. / Drizzle, weighting factor for input image
D081KERN= 'square ' / Drizzle, form of weight distribution kernel
D081PIXF= 0.8 / Drizzle, linear size of drop
D081COEF= 'cos02_85_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D081XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D081YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D081LAM = 555. / Drizzle, wavelength applied for transformation
D081EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D081INUN= 'counts ' / Drizzle, units of input image - counts or cps
D081OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D081FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D081INXC= 2049. / Drizzle, reference center of input image (X)
D081INYC= 1025. / Drizzle, reference center of input image (Y)
D081OUXC= 7001. / Drizzle, reference center of output image (X)
D081OUYC= 7201. / Drizzle, reference center of output image (Y)
D081SECP= F / Drizzle, there are no secondary geometric param
D082VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D082GEOM= 'Header WCS' / Drizzle, source of geometric information
D082DATA= 'cos02_85_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D082DEXP= 407. / Drizzle, input image exposure time (s)
D082OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D082OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D082OUCO= ' ' / Drizzle, output context image
D082MASK= 'cos02_85_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D082WTSC= 1278483. / Drizzle, weighting factor for input image
D082KERN= 'square ' / Drizzle, form of weight distribution kernel
D082PIXF= 0.8 / Drizzle, linear size of drop
D082COEF= 'cos02_85_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D082XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D082YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D082LAM = 555. / Drizzle, wavelength applied for transformation
D082EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D082INUN= 'counts ' / Drizzle, units of input image - counts or cps
D082OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D082FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D082INXC= 2049. / Drizzle, reference center of input image (X)
D082INYC= 1025. / Drizzle, reference center of input image (Y)
D082OUXC= 7001. / Drizzle, reference center of output image (X)
D082OUYC= 7201. / Drizzle, reference center of output image (Y)
D082SECP= F / Drizzle, there are no secondary geometric param
D083VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D083GEOM= 'Header WCS' / Drizzle, source of geometric information
D083DATA= 'cos02_86_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D083DEXP= 225. / Drizzle, input image exposure time (s)
D083OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D083OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D083OUCO= ' ' / Drizzle, output context image
D083MASK= 'cos02_86_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D083WTSC= 390660.8 / Drizzle, weighting factor for input image
D083KERN= 'square ' / Drizzle, form of weight distribution kernel
D083PIXF= 0.8 / Drizzle, linear size of drop
D083COEF= 'cos02_86_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D083XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D083YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D083LAM = 555. / Drizzle, wavelength applied for transformation
D083EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D083INUN= 'counts ' / Drizzle, units of input image - counts or cps
D083OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D083FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D083INXC= 2049. / Drizzle, reference center of input image (X)
D083INYC= 1025. / Drizzle, reference center of input image (Y)
D083OUXC= 7001. / Drizzle, reference center of output image (X)
D083OUYC= 7201. / Drizzle, reference center of output image (Y)
D083SECP= F / Drizzle, there are no secondary geometric param
D084VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D084GEOM= 'Header WCS' / Drizzle, source of geometric information
D084DATA= 'cos02_86_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D084DEXP= 225. / Drizzle, input image exposure time (s)
D084OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D084OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D084OUCO= ' ' / Drizzle, output context image
D084MASK= 'cos02_86_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D084WTSC= 390660.8 / Drizzle, weighting factor for input image
D084KERN= 'square ' / Drizzle, form of weight distribution kernel
D084PIXF= 0.8 / Drizzle, linear size of drop
D084COEF= 'cos02_86_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D084XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D084YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D084LAM = 555. / Drizzle, wavelength applied for transformation
D084EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D084INUN= 'counts ' / Drizzle, units of input image - counts or cps
D084OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D084FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D084INXC= 2049. / Drizzle, reference center of input image (X)
D084INYC= 1025. / Drizzle, reference center of input image (Y)
D084OUXC= 7001. / Drizzle, reference center of output image (X)
D084OUYC= 7201. / Drizzle, reference center of output image (Y)
D084SECP= F / Drizzle, there are no secondary geometric param
D085VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D085GEOM= 'Header WCS' / Drizzle, source of geometric information
D085DATA= 'cos02_86_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D085DEXP= 407. / Drizzle, input image exposure time (s)
D085OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D085OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D085OUCO= ' ' / Drizzle, output context image
D085MASK= 'cos02_86_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D085WTSC= 1278516. / Drizzle, weighting factor for input image
D085KERN= 'square ' / Drizzle, form of weight distribution kernel
D085PIXF= 0.8 / Drizzle, linear size of drop
D085COEF= 'cos02_86_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D085XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D085YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D085LAM = 555. / Drizzle, wavelength applied for transformation
D085EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D085INUN= 'counts ' / Drizzle, units of input image - counts or cps
D085OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D085FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D085INXC= 2049. / Drizzle, reference center of input image (X)
D085INYC= 1025. / Drizzle, reference center of input image (Y)
D085OUXC= 7001. / Drizzle, reference center of output image (X)
D085OUYC= 7201. / Drizzle, reference center of output image (Y)
D085SECP= F / Drizzle, there are no secondary geometric param
D086VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D086GEOM= 'Header WCS' / Drizzle, source of geometric information
D086DATA= 'cos02_86_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D086DEXP= 407. / Drizzle, input image exposure time (s)
D086OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D086OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D086OUCO= ' ' / Drizzle, output context image
D086MASK= 'cos02_86_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D086WTSC= 1278516. / Drizzle, weighting factor for input image
D086KERN= 'square ' / Drizzle, form of weight distribution kernel
D086PIXF= 0.8 / Drizzle, linear size of drop
D086COEF= 'cos02_86_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D086XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D086YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D086LAM = 555. / Drizzle, wavelength applied for transformation
D086EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D086INUN= 'counts ' / Drizzle, units of input image - counts or cps
D086OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D086FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D086INXC= 2049. / Drizzle, reference center of input image (X)
D086INYC= 1025. / Drizzle, reference center of input image (Y)
D086OUXC= 7001. / Drizzle, reference center of output image (X)
D086OUYC= 7201. / Drizzle, reference center of output image (Y)
D086SECP= F / Drizzle, there are no secondary geometric param
D087VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D087GEOM= 'Header WCS' / Drizzle, source of geometric information
D087DATA= 'cos02_89_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D087DEXP= 225. / Drizzle, input image exposure time (s)
D087OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D087OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D087OUCO= ' ' / Drizzle, output context image
D087MASK= 'cos02_89_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D087WTSC= 390736.4 / Drizzle, weighting factor for input image
D087KERN= 'square ' / Drizzle, form of weight distribution kernel
D087PIXF= 0.8 / Drizzle, linear size of drop
D087COEF= 'cos02_89_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D087XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D087YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D087LAM = 555. / Drizzle, wavelength applied for transformation
D087EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D087INUN= 'counts ' / Drizzle, units of input image - counts or cps
D087OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D087FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D087INXC= 2049. / Drizzle, reference center of input image (X)
D087INYC= 1025. / Drizzle, reference center of input image (Y)
D087OUXC= 7001. / Drizzle, reference center of output image (X)
D087OUYC= 7201. / Drizzle, reference center of output image (Y)
D087SECP= F / Drizzle, there are no secondary geometric param
D088VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D088GEOM= 'Header WCS' / Drizzle, source of geometric information
D088DATA= 'cos02_89_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D088DEXP= 225. / Drizzle, input image exposure time (s)
D088OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D088OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D088OUCO= ' ' / Drizzle, output context image
D088MASK= 'cos02_89_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D088WTSC= 390736.4 / Drizzle, weighting factor for input image
D088KERN= 'square ' / Drizzle, form of weight distribution kernel
D088PIXF= 0.8 / Drizzle, linear size of drop
D088COEF= 'cos02_89_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D088XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D088YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D088LAM = 555. / Drizzle, wavelength applied for transformation
D088EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D088INUN= 'counts ' / Drizzle, units of input image - counts or cps
D088OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D088FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D088INXC= 2049. / Drizzle, reference center of input image (X)
D088INYC= 1025. / Drizzle, reference center of input image (Y)
D088OUXC= 7001. / Drizzle, reference center of output image (X)
D088OUYC= 7201. / Drizzle, reference center of output image (Y)
D088SECP= F / Drizzle, there are no secondary geometric param
D089VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D089GEOM= 'Header WCS' / Drizzle, source of geometric information
D089DATA= 'cos02_89_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D089DEXP= 407. / Drizzle, input image exposure time (s)
D089OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D089OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D089OUCO= ' ' / Drizzle, output context image
D089MASK= 'cos02_89_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D089WTSC= 1278490. / Drizzle, weighting factor for input image
D089KERN= 'square ' / Drizzle, form of weight distribution kernel
D089PIXF= 0.8 / Drizzle, linear size of drop
D089COEF= 'cos02_89_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D089XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D089YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D089LAM = 555. / Drizzle, wavelength applied for transformation
D089EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D089INUN= 'counts ' / Drizzle, units of input image - counts or cps
D089OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D089FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D089INXC= 2049. / Drizzle, reference center of input image (X)
D089INYC= 1025. / Drizzle, reference center of input image (Y)
D089OUXC= 7001. / Drizzle, reference center of output image (X)
D089OUYC= 7201. / Drizzle, reference center of output image (Y)
D089SECP= F / Drizzle, there are no secondary geometric param
D090VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D090GEOM= 'Header WCS' / Drizzle, source of geometric information
D090DATA= 'cos02_89_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D090DEXP= 407. / Drizzle, input image exposure time (s)
D090OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D090OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D090OUCO= ' ' / Drizzle, output context image
D090MASK= 'cos02_89_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D090WTSC= 1278490. / Drizzle, weighting factor for input image
D090KERN= 'square ' / Drizzle, form of weight distribution kernel
D090PIXF= 0.8 / Drizzle, linear size of drop
D090COEF= 'cos02_89_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D090XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D090YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D090LAM = 555. / Drizzle, wavelength applied for transformation
D090EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D090INUN= 'counts ' / Drizzle, units of input image - counts or cps
D090OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D090FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D090INXC= 2049. / Drizzle, reference center of input image (X)
D090INYC= 1025. / Drizzle, reference center of input image (Y)
D090OUXC= 7001. / Drizzle, reference center of output image (X)
D090OUYC= 7201. / Drizzle, reference center of output image (Y)
D090SECP= F / Drizzle, there are no secondary geometric param
D091VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D091GEOM= 'Header WCS' / Drizzle, source of geometric information
D091DATA= 'cos02_90_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D091DEXP= 225. / Drizzle, input image exposure time (s)
D091OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D091OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D091OUCO= ' ' / Drizzle, output context image
D091MASK= 'cos02_90_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D091WTSC= 390736.1 / Drizzle, weighting factor for input image
D091KERN= 'square ' / Drizzle, form of weight distribution kernel
D091PIXF= 0.8 / Drizzle, linear size of drop
D091COEF= 'cos02_90_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D091XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D091YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D091LAM = 555. / Drizzle, wavelength applied for transformation
D091EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D091INUN= 'counts ' / Drizzle, units of input image - counts or cps
D091OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D091FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D091INXC= 2049. / Drizzle, reference center of input image (X)
D091INYC= 1025. / Drizzle, reference center of input image (Y)
D091OUXC= 7001. / Drizzle, reference center of output image (X)
D091OUYC= 7201. / Drizzle, reference center of output image (Y)
D091SECP= F / Drizzle, there are no secondary geometric param
D092VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D092GEOM= 'Header WCS' / Drizzle, source of geometric information
D092DATA= 'cos02_90_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D092DEXP= 225. / Drizzle, input image exposure time (s)
D092OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D092OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D092OUCO= ' ' / Drizzle, output context image
D092MASK= 'cos02_90_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D092WTSC= 390736.1 / Drizzle, weighting factor for input image
D092KERN= 'square ' / Drizzle, form of weight distribution kernel
D092PIXF= 0.8 / Drizzle, linear size of drop
D092COEF= 'cos02_90_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D092XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D092YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D092LAM = 555. / Drizzle, wavelength applied for transformation
D092EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D092INUN= 'counts ' / Drizzle, units of input image - counts or cps
D092OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D092FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D092INXC= 2049. / Drizzle, reference center of input image (X)
D092INYC= 1025. / Drizzle, reference center of input image (Y)
D092OUXC= 7001. / Drizzle, reference center of output image (X)
D092OUYC= 7201. / Drizzle, reference center of output image (Y)
D092SECP= F / Drizzle, there are no secondary geometric param
D093VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D093GEOM= 'Header WCS' / Drizzle, source of geometric information
D093DATA= 'cos02_90_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D093DEXP= 407. / Drizzle, input image exposure time (s)
D093OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D093OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D093OUCO= ' ' / Drizzle, output context image
D093MASK= 'cos02_90_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D093WTSC= 1278487. / Drizzle, weighting factor for input image
D093KERN= 'square ' / Drizzle, form of weight distribution kernel
D093PIXF= 0.8 / Drizzle, linear size of drop
D093COEF= 'cos02_90_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D093XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D093YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D093LAM = 555. / Drizzle, wavelength applied for transformation
D093EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D093INUN= 'counts ' / Drizzle, units of input image - counts or cps
D093OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D093FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D093INXC= 2049. / Drizzle, reference center of input image (X)
D093INYC= 1025. / Drizzle, reference center of input image (Y)
D093OUXC= 7001. / Drizzle, reference center of output image (X)
D093OUYC= 7201. / Drizzle, reference center of output image (Y)
D093SECP= F / Drizzle, there are no secondary geometric param
D094VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D094GEOM= 'Header WCS' / Drizzle, source of geometric information
D094DATA= 'cos02_90_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D094DEXP= 407. / Drizzle, input image exposure time (s)
D094OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D094OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D094OUCO= ' ' / Drizzle, output context image
D094MASK= 'cos02_90_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D094WTSC= 1278487. / Drizzle, weighting factor for input image
D094KERN= 'square ' / Drizzle, form of weight distribution kernel
D094PIXF= 0.8 / Drizzle, linear size of drop
D094COEF= 'cos02_90_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D094XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D094YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D094LAM = 555. / Drizzle, wavelength applied for transformation
D094EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D094INUN= 'counts ' / Drizzle, units of input image - counts or cps
D094OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D094FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D094INXC= 2049. / Drizzle, reference center of input image (X)
D094INYC= 1025. / Drizzle, reference center of input image (Y)
D094OUXC= 7001. / Drizzle, reference center of output image (X)
D094OUYC= 7201. / Drizzle, reference center of output image (Y)
D094SECP= F / Drizzle, there are no secondary geometric param
D095VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D095GEOM= 'Header WCS' / Drizzle, source of geometric information
D095DATA= 'cos02_93_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D095DEXP= 225. / Drizzle, input image exposure time (s)
D095OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D095OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D095OUCO= ' ' / Drizzle, output context image
D095MASK= 'cos02_93_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D095WTSC= 390736. / Drizzle, weighting factor for input image
D095KERN= 'square ' / Drizzle, form of weight distribution kernel
D095PIXF= 0.8 / Drizzle, linear size of drop
D095COEF= 'cos02_93_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D095XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D095YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D095LAM = 555. / Drizzle, wavelength applied for transformation
D095EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D095INUN= 'counts ' / Drizzle, units of input image - counts or cps
D095OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D095FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D095INXC= 2049. / Drizzle, reference center of input image (X)
D095INYC= 1025. / Drizzle, reference center of input image (Y)
D095OUXC= 7001. / Drizzle, reference center of output image (X)
D095OUYC= 7201. / Drizzle, reference center of output image (Y)
D095SECP= F / Drizzle, there are no secondary geometric param
D096VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D096GEOM= 'Header WCS' / Drizzle, source of geometric information
D096DATA= 'cos02_93_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D096DEXP= 407. / Drizzle, input image exposure time (s)
D096OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D096OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D096OUCO= ' ' / Drizzle, output context image
D096MASK= 'cos02_93_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D096WTSC= 1278483. / Drizzle, weighting factor for input image
D096KERN= 'square ' / Drizzle, form of weight distribution kernel
D096PIXF= 0.8 / Drizzle, linear size of drop
D096COEF= 'cos02_93_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D096XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D096YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D096LAM = 555. / Drizzle, wavelength applied for transformation
D096EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D096INUN= 'counts ' / Drizzle, units of input image - counts or cps
D096OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D096FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D096INXC= 2049. / Drizzle, reference center of input image (X)
D096INYC= 1025. / Drizzle, reference center of input image (Y)
D096OUXC= 7001. / Drizzle, reference center of output image (X)
D096OUYC= 7201. / Drizzle, reference center of output image (Y)
D096SECP= F / Drizzle, there are no secondary geometric param
D097VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D097GEOM= 'Header WCS' / Drizzle, source of geometric information
D097DATA= 'cos02_94_f606w_1_flt_sci1_final.fits' / Drizzle, input data image
D097DEXP= 225. / Drizzle, input image exposure time (s)
D097OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D097OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D097OUCO= ' ' / Drizzle, output context image
D097MASK= 'cos02_94_f606w_1_flt_wht1_final.fits' / Drizzle, input weighting imag
D097WTSC= 390737.1 / Drizzle, weighting factor for input image
D097KERN= 'square ' / Drizzle, form of weight distribution kernel
D097PIXF= 0.8 / Drizzle, linear size of drop
D097COEF= 'cos02_94_f606w_1_flt_coeffs2.dat' / Drizzle, coefficients file name
D097XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D097YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D097LAM = 555. / Drizzle, wavelength applied for transformation
D097EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D097INUN= 'counts ' / Drizzle, units of input image - counts or cps
D097OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D097FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D097INXC= 2049. / Drizzle, reference center of input image (X)
D097INYC= 1025. / Drizzle, reference center of input image (Y)
D097OUXC= 7001. / Drizzle, reference center of output image (X)
D097OUYC= 7201. / Drizzle, reference center of output image (Y)
D097SECP= F / Drizzle, there are no secondary geometric param
D098VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D098GEOM= 'Header WCS' / Drizzle, source of geometric information
D098DATA= 'cos02_94_f606w_1_flt_sci2_final.fits' / Drizzle, input data image
D098DEXP= 225. / Drizzle, input image exposure time (s)
D098OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D098OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D098OUCO= ' ' / Drizzle, output context image
D098MASK= 'cos02_94_f606w_1_flt_wht2_final.fits' / Drizzle, input weighting imag
D098WTSC= 390737.1 / Drizzle, weighting factor for input image
D098KERN= 'square ' / Drizzle, form of weight distribution kernel
D098PIXF= 0.8 / Drizzle, linear size of drop
D098COEF= 'cos02_94_f606w_1_flt_coeffs1.dat' / Drizzle, coefficients file name
D098XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D098YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D098LAM = 555. / Drizzle, wavelength applied for transformation
D098EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D098INUN= 'counts ' / Drizzle, units of input image - counts or cps
D098OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D098FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D098INXC= 2049. / Drizzle, reference center of input image (X)
D098INYC= 1025. / Drizzle, reference center of input image (Y)
D098OUXC= 7001. / Drizzle, reference center of output image (X)
D098OUYC= 7201. / Drizzle, reference center of output image (Y)
D098SECP= F / Drizzle, there are no secondary geometric param
D099VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D099GEOM= 'Header WCS' / Drizzle, source of geometric information
D099DATA= 'cos02_94_f606w_2_flt_sci1_final.fits' / Drizzle, input data image
D099DEXP= 407. / Drizzle, input image exposure time (s)
D099OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D099OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D099OUCO= ' ' / Drizzle, output context image
D099MASK= 'cos02_94_f606w_2_flt_wht1_final.fits' / Drizzle, input weighting imag
D099WTSC= 1278491. / Drizzle, weighting factor for input image
D099KERN= 'square ' / Drizzle, form of weight distribution kernel
D099PIXF= 0.8 / Drizzle, linear size of drop
D099COEF= 'cos02_94_f606w_2_flt_coeffs2.dat' / Drizzle, coefficients file name
D099XGIM= 'jref$qbu16424j_dxy.fits[DX,1]' / Drizzle, X distortion image name
D099YGIM= 'jref$qbu16424j_dxy.fits[DY,1]' / Drizzle, Y distortion image name
D099LAM = 555. / Drizzle, wavelength applied for transformation
D099EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D099INUN= 'counts ' / Drizzle, units of input image - counts or cps
D099OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D099FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D099INXC= 2049. / Drizzle, reference center of input image (X)
D099INYC= 1025. / Drizzle, reference center of input image (Y)
D099OUXC= 7001. / Drizzle, reference center of output image (X)
D099OUYC= 7201. / Drizzle, reference center of output image (Y)
D099SECP= F / Drizzle, there are no secondary geometric param
D100VER = 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)' / Drizzle, task version
D100GEOM= 'Header WCS' / Drizzle, source of geometric information
D100DATA= 'cos02_94_f606w_2_flt_sci2_final.fits' / Drizzle, input data image
D100DEXP= 407. / Drizzle, input image exposure time (s)
D100OUDA= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh' / Drizzle,
D100OUWE= 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh' / Drizzle,
D100OUCO= ' ' / Drizzle, output context image
D100MASK= 'cos02_94_f606w_2_flt_wht2_final.fits' / Drizzle, input weighting imag
D100WTSC= 1278491. / Drizzle, weighting factor for input image
D100KERN= 'square ' / Drizzle, form of weight distribution kernel
D100PIXF= 0.8 / Drizzle, linear size of drop
D100COEF= 'cos02_94_f606w_2_flt_coeffs1.dat' / Drizzle, coefficients file name
D100XGIM= 'jref$qbu16424j_dxy.fits[DX,2]' / Drizzle, X distortion image name
D100YGIM= 'jref$qbu16424j_dxy.fits[DY,2]' / Drizzle, Y distortion image name
D100LAM = 555. / Drizzle, wavelength applied for transformation
D100EXKY= 'exptime ' / Drizzle, exposure keyword name in input image
D100INUN= 'counts ' / Drizzle, units of input image - counts or cps
D100OUUN= 'cps ' / Drizzle, units of output image - counts or cps
D100FVAL= 'INDEF ' / Drizzle, fill value for zero weight output pixe
D100INXC= 2049. / Drizzle, reference center of input image (X)
D100INYC= 1025. / Drizzle, reference center of input image (Y)
D100OUXC= 7001. / Drizzle, reference center of output image (X)
D100OUYC= 7201. / Drizzle, reference center of output image (Y)
D100SECP= F / Drizzle, there are no secondary geometric param
PC1_1 = -8.333333E-06 / Coordinate transformation matrix element
PC2_2 = 8.333333E-06 / Coordinate transformation matrix element
CDELT1 = 1.0 / [deg] Coordinate increment at reference point
CDELT2 = 1.0 / [deg] Coordinate increment at reference point
CUNIT1 = 'deg' / Units of coordinate increment and value
CUNIT2 = 'deg' / Units of coordinate increment and value
LONPOLE = 180.0 / [deg] Native longitude of celestial pole
LATPOLE = 2.200973097 / [deg] Native latitude of celestial pole
MJDREF = 0.0 / [d] MJD of fiducial time
MJD-OBS = 55906.0 / [d] MJD of observation
RADESYS = 'FK5' / Equatorial coordinate system
O_EXT_NM= / Original extension name.
EXTNAME = 'CUTOUT '
ORIG_FLE= 'hlsp_candels_hst_hst_candels-v1.0_acs_f606w_drz.fits' / Original imag
ORIG_EXT= 0 / Extension in original file.
CHECKSUM= 'OTIdPRGZORGbORGZ' / HDU checksum updated 2023-12-20T17:59:45
DATASUM = '3549639627' / data unit checksum updated 2023-12-20T17:59:45
Example 1: Store just the key-value pairs of the metadata in ASDF#
The basic asdf data structure is a dictionary. The astropy FITS header object acts like a python dictionary. We can copy it into a pure dictionary, which will be useful when we want to add the data.
tree1 = {**header1}
One more line of code to turn it into asdf.
myfile = AsdfFile(tree1)
We won’t save this to a file yet. First, let’s inspect the tree.
myfile.tree
{'XTENSION': 'IMAGE',
'BITPIX': -32,
'NAXIS': 2,
'NAXIS1': 100,
'NAXIS2': 100,
'PCOUNT': 0,
'GCOUNT': 1,
'OBJECT': 'COS_2EPOCH_ACS_F606W_030MAS_V1.0_SECT23_DRZ[1/1]',
'ORIGIN': 'KPNO-IRAF',
'DATE': '2012-12-31T17:40:43',
'IRAFNAME': 'cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'IRAF-MAX': 0.0,
'IRAF-MIN': 0.0,
'IRAF-BPX': 32,
'IRAFTYPE': 'REAL',
'DATAMIN': 0.0,
'DATAMAX': 0.0,
'CRPIX1': -2552.5,
'CRVAL1': 150.1163213,
'CTYPE1': 'RA---TAN',
'CD1_1': -8.333333e-06,
'CD2_1': 0.0,
'CRPIX2': -22248.5,
'CRVAL2': 2.200973097,
'CTYPE2': 'DEC--TAN',
'CD1_2': 0.0,
'CD2_2': 8.333333e-06,
'FILETYPE': 'SCI',
'':
/ DATA DESCRIPTION KEYWORDS
/ TARGET INFORMATION
/ PROPOSAL INFORMATION
/ EXPOSURE INFORMATION
/ POINTING INFORMATION
/ TARGET OFFSETS (POSTARGS)
/ DIAGNOSTIC KEYWORDS
/ SCIENCE INSTRUMENT CONFIGURATION
/ CALIBRATION SWITCHES: PERFORM, OMIT, COMPLETE
/ CALIBRATION REFERENCE FILES
/ COSMIC RAY REJECTION ALGORITHM PARAMETERS
/ OTFR KEYWORDS
/ PATTERN KEYWORDS
/ POST FLASH PARAMETERS
/ ENGINEERING PARAMETERS
/ CALIBRATED ENGINEERING PARAMETERS
/ ASSOCIATION KEYWORDS
/ WFC CCD CHIP IDENTIFICATION
/ World Coordinate System and Related Parameters
/ READOUT DEFINITION PARAMETERS
/ PHOTOMETRY KEYWORDS
/ REPEATED EXPOSURES INFO
/ DATA PACKET INFORMATION
/ ON-BOARD COMPRESSION INFORMATION
/ IMAGE STATISTICS AND DATA QUALITY FLAGS,
'TELESCOP': 'HST',
'INSTRUME': 'ACS',
'EQUINOX': 2000.0,
'ROOTNAME': 'jboa28wmq',
'IMAGETYP': 'EXT',
'PRIMESI': 'WFC3',
'TARGNAME': 'ANY',
'RA_TARG': 150.1554086126,
'DEC_TARG': 2.270881608073,
'PROPOSID': 12440,
'LINENUM': '28.002',
'PR_INV_L': 'Faber',
'PR_INV_F': 'Sandra',
'PR_INV_M': 'M.',
'SUNANGLE': 107.339531,
'MOONANGL': 61.991249,
'SUN_ALT': -32.338875,
'FGSLOCK': 'FINE',
'GYROMODE': 'T',
'REFFRAME': 'ICRS',
'MTFLAG': '',
'DATE-OBS': '2011-12-11',
'TIME-OBS': '13:09:12',
'EXPSTART': 55906.54805854,
'EXPEND': 55906.55125326,
'EXPTIME': 36800.0,
'EXPFLAG': 'NORMAL',
'QUALCOM1': '',
'QUALCOM2': '',
'QUALCOM3': '',
'QUALITY': '',
'PA_V3': 128.0,
'POSTARG1': 0.0,
'POSTARG2': 0.0,
'OPUS_VER': 'OPUS 2011_1h',
'CAL_VER': '5.1.1 (27-Apr-2010)',
'PROCTIME': 55908.85636574,
'OBSTYPE': 'IMAGING',
'OBSMODE': 'ACCUM',
'CTEIMAGE': 'NONE',
'SCLAMP': 'NONE',
'NRPTEXP': 1,
'SUBARRAY': False,
'DETECTOR': 'WFC',
'FILTER1': 'F606W',
'FW1OFFST': 0,
'FILTER2': 'CLEAR2L',
'FW1ERROR': False,
'FW2OFFST': -4320,
'FW2ERROR': True,
'FWSOFFST': 0,
'FWSERROR': False,
'LRFWAVE': 0.0,
'APERTURE': 'WFC',
'PROPAPER': 'WFC',
'DIRIMAGE': 'NONE',
'CTEDIR': 'NONE',
'CRSPLIT': 1,
'STATFLAG': False,
'WRTERR': True,
'DQICORR': 'COMPLETE',
'ATODCORR': 'OMIT',
'BLEVCORR': 'COMPLETE',
'BIASCORR': 'COMPLETE',
'FLSHCORR': 'OMIT',
'CRCORR': 'OMIT',
'EXPSCORR': 'COMPLETE',
'SHADCORR': 'OMIT',
'DARKCORR': 'COMPLETE',
'FLATCORR': 'COMPLETE',
'PHOTCORR': 'COMPLETE',
'RPTCORR': 'OMIT',
'DRIZCORR': 'PERFORM',
'BPIXTAB': 'jref$t3n1116nj_bpx.fits',
'CCDTAB': 'jref$uc82140bj_ccd.fits',
'ATODTAB': 'jref$t3n1116mj_a2d.fits',
'OSCNTAB': 'jref$lch1459bj_osc.fits',
'BIASFILE': 'jref$vbh1844rj_bia.fits',
'FLSHFILE': 'N/A',
'CRREJTAB': 'jref$n4e12511j_crr.fits',
'SHADFILE': 'jref$kcb17349j_shd.fits',
'DARKFILE': 'jref$vbh18454j_drk.fits',
'PFLTFILE': 'jref$qb12257sj_pfl.fits',
'DFLTFILE': 'N/A',
'LFLTFILE': 'N/A',
'PHOTTAB': 'N/A',
'GRAPHTAB': 'mtab$v9n1603mm_tmg.fits',
'COMPTAB': 'mtab$vb71653dm_tmc.fits',
'IDCTAB': 'jref$v8q1444tj_idc.fits',
'DGEOFILE': 'jref$qbu16424j_dxy.fits',
'MDRIZTAB': 'jref$ub21537aj_mdz.fits',
'CFLTFILE': 'N/A',
'SPOTTAB': 'N/A',
'IMPHTTAB': 'jref$vbb18107j_imp.fits',
'MEANEXP': 0.0,
'SCALENSE': 0.0,
'INITGUES': '',
'SKYSUB': '',
'SKYSUM': 0.0,
'CRSIGMAS': '',
'CRRADIUS': 0.0,
'CRTHRESH': 0.0,
'BADINPDQ': 0,
'REJ_RATE': 0.0,
'CRMASK': False,
'MDRIZSKY': 32.08782958984375,
'T_SGSTAR': 'N/A',
'PATTERN1': 'NONE',
'P1_SHAPE': '',
'P1_PURPS': '',
'P1_NPTS': 0,
'P1_PSPAC': 0.0,
'P1_LSPAC': 0.0,
'P1_ANGLE': 0.0,
'P1_FRAME': '',
'P1_ORINT': 0.0,
'P1_CENTR': '',
'PATTSTEP': 0,
'FLASHDUR': 0.0,
'FLASHCUR': 'OFF',
'FLASHSTA': 'NOT PERFORMED',
'SHUTRPOS': 'A',
'CCDAMP': 'ABCD',
'CCDGAIN': 2.0,
'CCDOFSTA': 1,
'CCDOFSTB': 1,
'CCDOFSTC': 1,
'CCDOFSTD': 1,
'ATODGNA': 2.02,
'ATODGNB': 1.886,
'ATODGNC': 2.017,
'ATODGND': 2.0109999,
'READNSEA': 4.5700002,
'READNSEB': 3.9100001,
'READNSEC': 4.25,
'READNSED': 4.04,
'BIASLEVA': 2088.5564,
'BIASLEVB': 2140.5024,
'BIASLEVC': 2208.7419,
'BIASLEVD': 2296.7388,
'ASN_ID': 'JBOA28010',
'ASN_TAB': 'jboa28010_asn.fits',
'ASN_MTYP': 'EXP-DTH',
'BSTRCORR': 'COMPLETE',
'PCTEFILE': 'jref$pctefile_101109.fits',
'PCTETAB': 'jref$pctetab_pcte_20110913113559.fits',
'PCTECORR': 'COMPLETE',
'PCTEFRAC': 1.289367530158845,
'EXPNAME': 'jboa28wmq',
'BUNIT': 'ELECTRONS',
'CCDCHIP': 1,
'WCSAXES': 2,
'LTV1': 0.0,
'LTV2': 0.0,
'LTM1_1': 1.0,
'LTM2_2': 1.0,
'ORIENTAT': -54.67632556350016,
'RA_APER': 150.1554086126,
'DEC_APER': 2.270881608073,
'PA_APER': -54.4475,
'VAFACTOR': 1.000104465141,
'CENTERA1': 2073,
'CENTERA2': 1035,
'SIZAXIS1': 4096,
'SIZAXIS2': 2048,
'BINAXIS1': 1,
'BINAXIS2': 1,
'PHOTMODE': 'ACS WFC1 F606W MJD#55906.5481',
'PHOTFLAM': 7.8624958e-20,
'PHOTZPT': -21.1,
'PHOTPLAM': 5921.1147,
'PHOTBW': 672.23627,
'NCOMBINE': 1,
'FILLCNT': 1,
'ERRCNT': 1,
'PODPSFF': False,
'STDCFFF': True,
'STDCFFP': '0x5569',
'WFCMPRSD': False,
'CBLKSIZ': 0,
'LOSTPIX': 0,
'COMPTYP': 'None',
'NGOODPIX': 8097343,
'SDQFLAGS': 31743,
'GOODMIN': -31.759687,
'GOODMAX': 85606.719,
'GOODMEAN': 35.94437,
'SOFTERRS': 0,
'SNRMIN': -3.4609985,
'SNRMAX': 233.93831,
'SNRMEAN': 5.9348207,
'MEANDARK': 1.2713139,
'MEANBLEV': 2114.5295,
'MEANFLSH': 0.0,
'ONAXIS2': 2048,
'ONAXIS1': 4096,
'OORIENTA': -54.64776336099293,
'OCTYPE1': 'RA---TAN',
'OCTYPE2': 'DEC--TAN',
'WCSCDATE': '13:02:32 (10/04/2012)',
'A_0_2': 2.26194120304176e-06,
'B_0_2': -9.7985788387639e-06,
'A_1_1': -7.5302905463753e-06,
'B_1_1': 6.42569986264533e-06,
'A_2_0': 8.51886870532632e-06,
'B_2_0': -2.9658922285423e-06,
'A_0_3': 6.51050854317125e-11,
'B_0_3': -4.1421499542394e-10,
'A_1_2': -5.2539201413375e-10,
'B_1_2': -3.0354276197375e-11,
'A_2_1': -1.0714004130419e-10,
'B_2_1': -4.4034927976003e-10,
'A_3_0': -4.6936360210189e-10,
'B_3_0': 9.00334210115821e-11,
'A_0_4': 1.35191449346299e-13,
'B_0_4': -1.5248974790417e-13,
'A_1_3': -1.4269338401366e-14,
'B_1_3': 2.75911271664302e-14,
'A_2_2': 9.70199603291834e-14,
'B_2_2': -1.0403607372429e-13,
'A_3_1': 3.80059786170717e-14,
'B_3_1': -3.8363933112663e-14,
'A_4_0': 1.83627862287182e-14,
'B_4_0': -1.6913942054528e-14,
'A_ORDER': 4,
'B_ORDER': 4,
'IDCSCALE': 0.05,
'IDCV2REF': 261.1130981445312,
'IDCV3REF': 198.231201171875,
'IDCTHETA': 0.0,
'OCX10': 0.002270935984783606,
'OCX11': 0.04922343821974121,
'OCY10': 0.0485839959198564,
'OCY11': 0.00213603403929032,
'TDDALPHA': 0.2802605508521792,
'TDDBETA': -0.0907535169507264,
'SKYVAL': 32.5013968269,
'SKYRMS': 7.873235,
'QUADOFFA': 0.190616225,
'QUADOFFB': -0.660557125,
'QUADOFFC': 0.117621775,
'QUADOFFD': 0.352319125,
'NDRIZIM': 100,
'D001VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D001GEOM': 'Header WCS',
'D001DATA': 'cos01_28_f606w_1_flt_sci2_final.fits',
'D001DEXP': 275.0,
'D001OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D001OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D001OUCO': '',
'D001MASK': 'cos01_28_f606w_1_flt_wht2_final.fits',
'D001WTSC': 583770.1,
'D001KERN': 'square',
'D001PIXF': 0.8,
'D001COEF': 'cos01_28_f606w_1_flt_coeffs1.dat',
'D001XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D001YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D001LAM': 555.0,
'D001EXKY': 'exptime',
'D001INUN': 'counts',
'D001OUUN': 'cps',
'D001FVAL': 'INDEF',
'D001INXC': 2049.0,
'D001INYC': 1025.0,
'D001OUXC': 7001.0,
'D001OUYC': 7201.0,
'D001SECP': False,
'D002VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D002GEOM': 'Header WCS',
'D002DATA': 'cos01_28_f606w_2_flt_sci2_final.fits',
'D002DEXP': 707.0,
'D002OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D002OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D002OUCO': '',
'D002MASK': 'cos01_28_f606w_2_flt_wht2_final.fits',
'D002WTSC': 3858213.0,
'D002KERN': 'square',
'D002PIXF': 0.8,
'D002COEF': 'cos01_28_f606w_2_flt_coeffs1.dat',
'D002XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D002YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D002LAM': 555.0,
'D002EXKY': 'exptime',
'D002INUN': 'counts',
'D002OUUN': 'cps',
'D002FVAL': 'INDEF',
'D002INXC': 2049.0,
'D002INYC': 1025.0,
'D002OUXC': 7001.0,
'D002OUYC': 7201.0,
'D002SECP': False,
'D003VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D003GEOM': 'Header WCS',
'D003DATA': 'cos01_29_f606w_1_flt_sci2_final.fits',
'D003DEXP': 275.0,
'D003OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D003OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D003OUCO': '',
'D003MASK': 'cos01_29_f606w_1_flt_wht2_final.fits',
'D003WTSC': 583802.2,
'D003KERN': 'square',
'D003PIXF': 0.8,
'D003COEF': 'cos01_29_f606w_1_flt_coeffs1.dat',
'D003XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D003YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D003LAM': 555.0,
'D003EXKY': 'exptime',
'D003INUN': 'counts',
'D003OUUN': 'cps',
'D003FVAL': 'INDEF',
'D003INXC': 2049.0,
'D003INYC': 1025.0,
'D003OUXC': 7001.0,
'D003OUYC': 7201.0,
'D003SECP': False,
'D004VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D004GEOM': 'Header WCS',
'D004DATA': 'cos01_29_f606w_2_flt_sci2_final.fits',
'D004DEXP': 707.0,
'D004OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D004OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D004OUCO': '',
'D004MASK': 'cos01_29_f606w_2_flt_wht2_final.fits',
'D004WTSC': 3858522.0,
'D004KERN': 'square',
'D004PIXF': 0.8,
'D004COEF': 'cos01_29_f606w_2_flt_coeffs1.dat',
'D004XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D004YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D004LAM': 555.0,
'D004EXKY': 'exptime',
'D004INUN': 'counts',
'D004OUUN': 'cps',
'D004FVAL': 'INDEF',
'D004INXC': 2049.0,
'D004INYC': 1025.0,
'D004OUXC': 7001.0,
'D004OUYC': 7201.0,
'D004SECP': False,
'D005VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D005GEOM': 'Header WCS',
'D005DATA': 'cos01_30_f606w_1_flt_sci2_final.fits',
'D005DEXP': 275.0,
'D005OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D005OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D005OUCO': '',
'D005MASK': 'cos01_30_f606w_1_flt_wht2_final.fits',
'D005WTSC': 583802.4,
'D005KERN': 'square',
'D005PIXF': 0.8,
'D005COEF': 'cos01_30_f606w_1_flt_coeffs1.dat',
'D005XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D005YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D005LAM': 555.0,
'D005EXKY': 'exptime',
'D005INUN': 'counts',
'D005OUUN': 'cps',
'D005FVAL': 'INDEF',
'D005INXC': 2049.0,
'D005INYC': 1025.0,
'D005OUXC': 7001.0,
'D005OUYC': 7201.0,
'D005SECP': False,
'D006VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D006GEOM': 'Header WCS',
'D006DATA': 'cos01_30_f606w_2_flt_sci2_final.fits',
'D006DEXP': 707.0,
'D006OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D006OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D006OUCO': '',
'D006MASK': 'cos01_30_f606w_2_flt_wht2_final.fits',
'D006WTSC': 3858522.0,
'D006KERN': 'square',
'D006PIXF': 0.8,
'D006COEF': 'cos01_30_f606w_2_flt_coeffs1.dat',
'D006XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D006YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D006LAM': 555.0,
'D006EXKY': 'exptime',
'D006INUN': 'counts',
'D006OUUN': 'cps',
'D006FVAL': 'INDEF',
'D006INXC': 2049.0,
'D006INYC': 1025.0,
'D006OUXC': 7001.0,
'D006OUYC': 7201.0,
'D006SECP': False,
'D007VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D007GEOM': 'Header WCS',
'D007DATA': 'cos01_32_f606w_1_flt_sci2_final.fits',
'D007DEXP': 275.0,
'D007OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D007OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D007OUCO': '',
'D007MASK': 'cos01_32_f606w_1_flt_wht2_final.fits',
'D007WTSC': 583801.9,
'D007KERN': 'square',
'D007PIXF': 0.8,
'D007COEF': 'cos01_32_f606w_1_flt_coeffs1.dat',
'D007XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D007YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D007LAM': 555.0,
'D007EXKY': 'exptime',
'D007INUN': 'counts',
'D007OUUN': 'cps',
'D007FVAL': 'INDEF',
'D007INXC': 2049.0,
'D007INYC': 1025.0,
'D007OUXC': 7001.0,
'D007OUYC': 7201.0,
'D007SECP': False,
'D008VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D008GEOM': 'Header WCS',
'D008DATA': 'cos01_32_f606w_2_flt_sci2_final.fits',
'D008DEXP': 707.0,
'D008OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D008OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D008OUCO': '',
'D008MASK': 'cos01_32_f606w_2_flt_wht2_final.fits',
'D008WTSC': 3858506.0,
'D008KERN': 'square',
'D008PIXF': 0.8,
'D008COEF': 'cos01_32_f606w_2_flt_coeffs1.dat',
'D008XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D008YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D008LAM': 555.0,
'D008EXKY': 'exptime',
'D008INUN': 'counts',
'D008OUUN': 'cps',
'D008FVAL': 'INDEF',
'D008INXC': 2049.0,
'D008INYC': 1025.0,
'D008OUXC': 7001.0,
'D008OUYC': 7201.0,
'D008SECP': False,
'D009VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D009GEOM': 'Header WCS',
'D009DATA': 'cos01_33_f606w_1_flt_sci1_final.fits',
'D009DEXP': 275.0,
'D009OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D009OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D009OUCO': '',
'D009MASK': 'cos01_33_f606w_1_flt_wht1_final.fits',
'D009WTSC': 583803.6,
'D009KERN': 'square',
'D009PIXF': 0.8,
'D009COEF': 'cos01_33_f606w_1_flt_coeffs2.dat',
'D009XGIM': 'jref$qbu16424j_dxy.fits[DX,1]',
'D009YGIM': 'jref$qbu16424j_dxy.fits[DY,1]',
'D009LAM': 555.0,
'D009EXKY': 'exptime',
'D009INUN': 'counts',
'D009OUUN': 'cps',
'D009FVAL': 'INDEF',
'D009INXC': 2049.0,
'D009INYC': 1025.0,
'D009OUXC': 7001.0,
'D009OUYC': 7201.0,
'D009SECP': False,
'D010VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D010GEOM': 'Header WCS',
'D010DATA': 'cos01_33_f606w_1_flt_sci2_final.fits',
'D010DEXP': 275.0,
'D010OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D010OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D010OUCO': '',
'D010MASK': 'cos01_33_f606w_1_flt_wht2_final.fits',
'D010WTSC': 583803.6,
'D010KERN': 'square',
'D010PIXF': 0.8,
'D010COEF': 'cos01_33_f606w_1_flt_coeffs1.dat',
'D010XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D010YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D010LAM': 555.0,
'D010EXKY': 'exptime',
'D010INUN': 'counts',
'D010OUUN': 'cps',
'D010FVAL': 'INDEF',
'D010INXC': 2049.0,
'D010INYC': 1025.0,
'D010OUXC': 7001.0,
'D010OUYC': 7201.0,
'D010SECP': False,
'D011VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D011GEOM': 'Header WCS',
'D011DATA': 'cos01_33_f606w_2_flt_sci1_final.fits',
'D011DEXP': 707.0,
'D011OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D011OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D011OUCO': '',
'D011MASK': 'cos01_33_f606w_2_flt_wht1_final.fits',
'D011WTSC': 3858528.0,
'D011KERN': 'square',
'D011PIXF': 0.8,
'D011COEF': 'cos01_33_f606w_2_flt_coeffs2.dat',
'D011XGIM': 'jref$qbu16424j_dxy.fits[DX,1]',
'D011YGIM': 'jref$qbu16424j_dxy.fits[DY,1]',
'D011LAM': 555.0,
'D011EXKY': 'exptime',
'D011INUN': 'counts',
'D011OUUN': 'cps',
'D011FVAL': 'INDEF',
'D011INXC': 2049.0,
'D011INYC': 1025.0,
'D011OUXC': 7001.0,
'D011OUYC': 7201.0,
'D011SECP': False,
'D012VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D012GEOM': 'Header WCS',
'D012DATA': 'cos01_33_f606w_2_flt_sci2_final.fits',
'D012DEXP': 707.0,
'D012OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D012OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D012OUCO': '',
'D012MASK': 'cos01_33_f606w_2_flt_wht2_final.fits',
'D012WTSC': 3858528.0,
'D012KERN': 'square',
'D012PIXF': 0.8,
'D012COEF': 'cos01_33_f606w_2_flt_coeffs1.dat',
'D012XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D012YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D012LAM': 555.0,
'D012EXKY': 'exptime',
'D012INUN': 'counts',
'D012OUUN': 'cps',
'D012FVAL': 'INDEF',
'D012INXC': 2049.0,
'D012INYC': 1025.0,
'D012OUXC': 7001.0,
'D012OUYC': 7201.0,
'D012SECP': False,
'D013VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D013GEOM': 'Header WCS',
'D013DATA': 'cos01_34_f606w_1_flt_sci1_final.fits',
'D013DEXP': 275.0,
'D013OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D013OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D013OUCO': '',
'D013MASK': 'cos01_34_f606w_1_flt_wht1_final.fits',
'D013WTSC': 583803.6,
'D013KERN': 'square',
'D013PIXF': 0.8,
'D013COEF': 'cos01_34_f606w_1_flt_coeffs2.dat',
'D013XGIM': 'jref$qbu16424j_dxy.fits[DX,1]',
'D013YGIM': 'jref$qbu16424j_dxy.fits[DY,1]',
'D013LAM': 555.0,
'D013EXKY': 'exptime',
'D013INUN': 'counts',
'D013OUUN': 'cps',
'D013FVAL': 'INDEF',
'D013INXC': 2049.0,
'D013INYC': 1025.0,
'D013OUXC': 7001.0,
'D013OUYC': 7201.0,
'D013SECP': False,
'D014VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D014GEOM': 'Header WCS',
'D014DATA': 'cos01_34_f606w_1_flt_sci2_final.fits',
'D014DEXP': 275.0,
'D014OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D014OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D014OUCO': '',
'D014MASK': 'cos01_34_f606w_1_flt_wht2_final.fits',
'D014WTSC': 583803.6,
'D014KERN': 'square',
'D014PIXF': 0.8,
'D014COEF': 'cos01_34_f606w_1_flt_coeffs1.dat',
'D014XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D014YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D014LAM': 555.0,
'D014EXKY': 'exptime',
'D014INUN': 'counts',
'D014OUUN': 'cps',
'D014FVAL': 'INDEF',
'D014INXC': 2049.0,
'D014INYC': 1025.0,
'D014OUXC': 7001.0,
'D014OUYC': 7201.0,
'D014SECP': False,
'D015VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D015GEOM': 'Header WCS',
'D015DATA': 'cos01_34_f606w_2_flt_sci1_final.fits',
'D015DEXP': 707.0,
'D015OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D015OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D015OUCO': '',
'D015MASK': 'cos01_34_f606w_2_flt_wht1_final.fits',
'D015WTSC': 3858529.0,
'D015KERN': 'square',
'D015PIXF': 0.8,
'D015COEF': 'cos01_34_f606w_2_flt_coeffs2.dat',
'D015XGIM': 'jref$qbu16424j_dxy.fits[DX,1]',
'D015YGIM': 'jref$qbu16424j_dxy.fits[DY,1]',
'D015LAM': 555.0,
'D015EXKY': 'exptime',
'D015INUN': 'counts',
'D015OUUN': 'cps',
'D015FVAL': 'INDEF',
'D015INXC': 2049.0,
'D015INYC': 1025.0,
'D015OUXC': 7001.0,
'D015OUYC': 7201.0,
'D015SECP': False,
'D016VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D016GEOM': 'Header WCS',
'D016DATA': 'cos01_34_f606w_2_flt_sci2_final.fits',
'D016DEXP': 707.0,
'D016OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D016OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D016OUCO': '',
'D016MASK': 'cos01_34_f606w_2_flt_wht2_final.fits',
'D016WTSC': 3858529.0,
'D016KERN': 'square',
'D016PIXF': 0.8,
'D016COEF': 'cos01_34_f606w_2_flt_coeffs1.dat',
'D016XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D016YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D016LAM': 555.0,
'D016EXKY': 'exptime',
'D016INUN': 'counts',
'D016OUUN': 'cps',
'D016FVAL': 'INDEF',
'D016INXC': 2049.0,
'D016INYC': 1025.0,
'D016OUXC': 7001.0,
'D016OUYC': 7201.0,
'D016SECP': False,
'D017VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D017GEOM': 'Header WCS',
'D017DATA': 'cos01_36_f606w_1_flt_sci2_final.fits',
'D017DEXP': 275.0,
'D017OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D017OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D017OUCO': '',
'D017MASK': 'cos01_36_f606w_1_flt_wht2_final.fits',
'D017WTSC': 583804.3,
'D017KERN': 'square',
'D017PIXF': 0.8,
'D017COEF': 'cos01_36_f606w_1_flt_coeffs1.dat',
'D017XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D017YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D017LAM': 555.0,
'D017EXKY': 'exptime',
'D017INUN': 'counts',
'D017OUUN': 'cps',
'D017FVAL': 'INDEF',
'D017INXC': 2049.0,
'D017INYC': 1025.0,
'D017OUXC': 7001.0,
'D017OUYC': 7201.0,
'D017SECP': False,
'D018VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D018GEOM': 'Header WCS',
'D018DATA': 'cos01_36_f606w_2_flt_sci2_final.fits',
'D018DEXP': 707.0,
'D018OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D018OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D018OUCO': '',
'D018MASK': 'cos01_36_f606w_2_flt_wht2_final.fits',
'D018WTSC': 3858532.0,
'D018KERN': 'square',
'D018PIXF': 0.8,
'D018COEF': 'cos01_36_f606w_2_flt_coeffs1.dat',
'D018XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D018YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D018LAM': 555.0,
'D018EXKY': 'exptime',
'D018INUN': 'counts',
'D018OUUN': 'cps',
'D018FVAL': 'INDEF',
'D018INXC': 2049.0,
'D018INYC': 1025.0,
'D018OUXC': 7001.0,
'D018OUYC': 7201.0,
'D018SECP': False,
'D019VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D019GEOM': 'Header WCS',
'D019DATA': 'cos01_37_f606w_1_flt_sci1_final.fits',
'D019DEXP': 275.0,
'D019OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D019OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D019OUCO': '',
'D019MASK': 'cos01_37_f606w_1_flt_wht1_final.fits',
'D019WTSC': 583796.7,
'D019KERN': 'square',
'D019PIXF': 0.8,
'D019COEF': 'cos01_37_f606w_1_flt_coeffs2.dat',
'D019XGIM': 'jref$qbu16424j_dxy.fits[DX,1]',
'D019YGIM': 'jref$qbu16424j_dxy.fits[DY,1]',
'D019LAM': 555.0,
'D019EXKY': 'exptime',
'D019INUN': 'counts',
'D019OUUN': 'cps',
'D019FVAL': 'INDEF',
'D019INXC': 2049.0,
'D019INYC': 1025.0,
'D019OUXC': 7001.0,
'D019OUYC': 7201.0,
'D019SECP': False,
'D020VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D020GEOM': 'Header WCS',
'D020DATA': 'cos01_37_f606w_1_flt_sci2_final.fits',
'D020DEXP': 275.0,
'D020OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D020OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D020OUCO': '',
'D020MASK': 'cos01_37_f606w_1_flt_wht2_final.fits',
'D020WTSC': 583796.7,
'D020KERN': 'square',
'D020PIXF': 0.8,
'D020COEF': 'cos01_37_f606w_1_flt_coeffs1.dat',
'D020XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D020YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D020LAM': 555.0,
'D020EXKY': 'exptime',
'D020INUN': 'counts',
'D020OUUN': 'cps',
'D020FVAL': 'INDEF',
'D020INXC': 2049.0,
'D020INYC': 1025.0,
'D020OUXC': 7001.0,
'D020OUYC': 7201.0,
'D020SECP': False,
'D021VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D021GEOM': 'Header WCS',
'D021DATA': 'cos01_37_f606w_2_flt_sci1_final.fits',
'D021DEXP': 707.0,
'D021OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D021OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D021OUCO': '',
'D021MASK': 'cos01_37_f606w_2_flt_wht1_final.fits',
'D021WTSC': 3858427.0,
'D021KERN': 'square',
'D021PIXF': 0.8,
'D021COEF': 'cos01_37_f606w_2_flt_coeffs2.dat',
'D021XGIM': 'jref$qbu16424j_dxy.fits[DX,1]',
'D021YGIM': 'jref$qbu16424j_dxy.fits[DY,1]',
'D021LAM': 555.0,
'D021EXKY': 'exptime',
'D021INUN': 'counts',
'D021OUUN': 'cps',
'D021FVAL': 'INDEF',
'D021INXC': 2049.0,
'D021INYC': 1025.0,
'D021OUXC': 7001.0,
'D021OUYC': 7201.0,
'D021SECP': False,
'D022VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D022GEOM': 'Header WCS',
'D022DATA': 'cos01_37_f606w_2_flt_sci2_final.fits',
'D022DEXP': 707.0,
'D022OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D022OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D022OUCO': '',
'D022MASK': 'cos01_37_f606w_2_flt_wht2_final.fits',
'D022WTSC': 3858427.0,
'D022KERN': 'square',
'D022PIXF': 0.8,
'D022COEF': 'cos01_37_f606w_2_flt_coeffs1.dat',
'D022XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D022YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D022LAM': 555.0,
'D022EXKY': 'exptime',
'D022INUN': 'counts',
'D022OUUN': 'cps',
'D022FVAL': 'INDEF',
'D022INXC': 2049.0,
'D022INYC': 1025.0,
'D022OUXC': 7001.0,
'D022OUYC': 7201.0,
'D022SECP': False,
'D023VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D023GEOM': 'Header WCS',
'D023DATA': 'cos01_38_f606w_1_flt_sci1_final.fits',
'D023DEXP': 275.0,
'D023OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D023OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D023OUCO': '',
'D023MASK': 'cos01_38_f606w_1_flt_wht1_final.fits',
'D023WTSC': 583805.7,
'D023KERN': 'square',
'D023PIXF': 0.8,
'D023COEF': 'cos01_38_f606w_1_flt_coeffs2.dat',
'D023XGIM': 'jref$qbu16424j_dxy.fits[DX,1]',
'D023YGIM': 'jref$qbu16424j_dxy.fits[DY,1]',
'D023LAM': 555.0,
'D023EXKY': 'exptime',
'D023INUN': 'counts',
'D023OUUN': 'cps',
'D023FVAL': 'INDEF',
'D023INXC': 2049.0,
'D023INYC': 1025.0,
'D023OUXC': 7001.0,
'D023OUYC': 7201.0,
'D023SECP': False,
'D024VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D024GEOM': 'Header WCS',
'D024DATA': 'cos01_38_f606w_1_flt_sci2_final.fits',
'D024DEXP': 275.0,
'D024OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D024OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D024OUCO': '',
'D024MASK': 'cos01_38_f606w_1_flt_wht2_final.fits',
'D024WTSC': 583805.7,
'D024KERN': 'square',
'D024PIXF': 0.8,
'D024COEF': 'cos01_38_f606w_1_flt_coeffs1.dat',
'D024XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D024YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D024LAM': 555.0,
'D024EXKY': 'exptime',
'D024INUN': 'counts',
'D024OUUN': 'cps',
'D024FVAL': 'INDEF',
'D024INXC': 2049.0,
'D024INYC': 1025.0,
'D024OUXC': 7001.0,
'D024OUYC': 7201.0,
'D024SECP': False,
'D025VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D025GEOM': 'Header WCS',
'D025DATA': 'cos01_38_f606w_2_flt_sci1_final.fits',
'D025DEXP': 707.0,
'D025OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D025OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D025OUCO': '',
'D025MASK': 'cos01_38_f606w_2_flt_wht1_final.fits',
'D025WTSC': 3858539.0,
'D025KERN': 'square',
'D025PIXF': 0.8,
'D025COEF': 'cos01_38_f606w_2_flt_coeffs2.dat',
'D025XGIM': 'jref$qbu16424j_dxy.fits[DX,1]',
'D025YGIM': 'jref$qbu16424j_dxy.fits[DY,1]',
'D025LAM': 555.0,
'D025EXKY': 'exptime',
'D025INUN': 'counts',
'D025OUUN': 'cps',
'D025FVAL': 'INDEF',
'D025INXC': 2049.0,
'D025INYC': 1025.0,
'D025OUXC': 7001.0,
'D025OUYC': 7201.0,
'D025SECP': False,
'D026VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D026GEOM': 'Header WCS',
'D026DATA': 'cos01_38_f606w_2_flt_sci2_final.fits',
'D026DEXP': 707.0,
'D026OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D026OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D026OUCO': '',
'D026MASK': 'cos01_38_f606w_2_flt_wht2_final.fits',
'D026WTSC': 3858539.0,
'D026KERN': 'square',
'D026PIXF': 0.8,
'D026COEF': 'cos01_38_f606w_2_flt_coeffs1.dat',
'D026XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D026YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D026LAM': 555.0,
'D026EXKY': 'exptime',
'D026INUN': 'counts',
'D026OUUN': 'cps',
'D026FVAL': 'INDEF',
'D026INXC': 2049.0,
'D026INYC': 1025.0,
'D026OUXC': 7001.0,
'D026OUYC': 7201.0,
'D026SECP': False,
'D027VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D027GEOM': 'Header WCS',
'D027DATA': 'cos01_40_f606w_1_flt_sci2_final.fits',
'D027DEXP': 225.0,
'D027OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D027OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D027OUCO': '',
'D027MASK': 'cos01_40_f606w_1_flt_wht2_final.fits',
'D027WTSC': 390803.6,
'D027KERN': 'square',
'D027PIXF': 0.8,
'D027COEF': 'cos01_40_f606w_1_flt_coeffs1.dat',
'D027XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D027YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D027LAM': 555.0,
'D027EXKY': 'exptime',
'D027INUN': 'counts',
'D027OUUN': 'cps',
'D027FVAL': 'INDEF',
'D027INXC': 2049.0,
'D027INYC': 1025.0,
'D027OUXC': 7001.0,
'D027OUYC': 7201.0,
'D027SECP': False,
'D028VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D028GEOM': 'Header WCS',
'D028DATA': 'cos01_40_f606w_2_flt_sci2_final.fits',
'D028DEXP': 407.0,
'D028OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D028OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D028OUCO': '',
'D028MASK': 'cos01_40_f606w_2_flt_wht2_final.fits',
'D028WTSC': 1278684.0,
'D028KERN': 'square',
'D028PIXF': 0.8,
'D028COEF': 'cos01_40_f606w_2_flt_coeffs1.dat',
'D028XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D028YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D028LAM': 555.0,
'D028EXKY': 'exptime',
'D028INUN': 'counts',
'D028OUUN': 'cps',
'D028FVAL': 'INDEF',
'D028INXC': 2049.0,
'D028INYC': 1025.0,
'D028OUXC': 7001.0,
'D028OUYC': 7201.0,
'D028SECP': False,
'D029VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D029GEOM': 'Header WCS',
'D029DATA': 'cos01_41_f606w_1_flt_sci1_final.fits',
'D029DEXP': 225.0,
'D029OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D029OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D029OUCO': '',
'D029MASK': 'cos01_41_f606w_1_flt_wht1_final.fits',
'D029WTSC': 390813.4,
'D029KERN': 'square',
'D029PIXF': 0.8,
'D029COEF': 'cos01_41_f606w_1_flt_coeffs2.dat',
'D029XGIM': 'jref$qbu16424j_dxy.fits[DX,1]',
'D029YGIM': 'jref$qbu16424j_dxy.fits[DY,1]',
'D029LAM': 555.0,
'D029EXKY': 'exptime',
'D029INUN': 'counts',
'D029OUUN': 'cps',
'D029FVAL': 'INDEF',
'D029INXC': 2049.0,
'D029INYC': 1025.0,
'D029OUXC': 7001.0,
'D029OUYC': 7201.0,
'D029SECP': False,
'D030VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D030GEOM': 'Header WCS',
'D030DATA': 'cos01_41_f606w_1_flt_sci2_final.fits',
'D030DEXP': 225.0,
'D030OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D030OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D030OUCO': '',
'D030MASK': 'cos01_41_f606w_1_flt_wht2_final.fits',
'D030WTSC': 390813.4,
'D030KERN': 'square',
'D030PIXF': 0.8,
'D030COEF': 'cos01_41_f606w_1_flt_coeffs1.dat',
'D030XGIM': 'jref$qbu16424j_dxy.fits[DX,2]',
'D030YGIM': 'jref$qbu16424j_dxy.fits[DY,2]',
'D030LAM': 555.0,
'D030EXKY': 'exptime',
'D030INUN': 'counts',
'D030OUUN': 'cps',
'D030FVAL': 'INDEF',
'D030INXC': 2049.0,
'D030INYC': 1025.0,
'D030OUXC': 7001.0,
'D030OUYC': 7201.0,
'D030SECP': False,
'D031VER': 'WDRIZZLE Version 3.4.2 (Jul 3rd 2006)',
'D031GEOM': 'Header WCS',
'D031DATA': 'cos01_41_f606w_2_flt_sci1_final.fits',
'D031DEXP': 407.0,
'D031OUDA': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'D031OUWE': 'tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'D031OUCO': '',
'D031MASK': 'cos01_41_f606w_2_flt_wht1_final.fits',
...}
Example 2: Save the FITS header annotations#
The fits header includes comments for many of the keywords. It’s a bit clunky, but we can save those by storing a tuple instead of just the value in the dictionary. While we’re at it, let’s toss some of the FITS keywords that aren’t useful.
toss_these = ['XTENSION', 'BITPIX', 'NAXIS', 'NAXIS1', 'NAXIS2', 'CHECKSUM',
'DATASUM', 'EXTNAME', 'FILETYPE', 'PCOUNT', 'GCOUNT',
'IRAF-BPX', 'IRAF-MIN', 'IRAF-MAX', 'IRAFNAME', 'IRAFTYPE']
annotated_tree = {}
for card in header1.cards:
if card[0] not in toss_these:
annotated_tree[card[0]] = (card[1], card[2])
myfile = AsdfFile(annotated_tree)
myfile.tree
{'OBJECT': ('COS_2EPOCH_ACS_F606W_030MAS_V1.0_SECT23_DRZ[1/1]', ''),
'ORIGIN': ('NOAO-IRAF FITS Image Kernel July 2003', 'FITS file originator'),
'DATE': ('2012-04-10T16:39:27', 'Date FITS file was generated'),
'DATAMIN': (0.0, ''),
'DATAMAX': (0.0, ''),
'CRPIX1': (-2552.5, 'Pixel coordinate of reference point'),
'CRVAL1': (150.1163213, '[deg] Coordinate value at reference point'),
'CTYPE1': ('RA---TAN', 'Right ascension, gnomonic projection'),
'CD1_1': (-8.333333e-06, ''),
'CD2_1': (0.0, ''),
'CRPIX2': (-22248.5, 'Pixel coordinate of reference point'),
'CRVAL2': (2.200973097, '[deg] Coordinate value at reference point'),
'CTYPE2': ('DEC--TAN', 'Declination, gnomonic projection'),
'CD1_2': (0.0, ''),
'CD2_2': (8.333333e-06, ''),
'': ('', ''),
'TELESCOP': ('HST', 'telescope used to acquire data'),
'INSTRUME': ('ACS', 'identifier for instrument used to acquire data'),
'EQUINOX': (2000.0, '[yr] Equinox of equatorial coordinates'),
'ROOTNAME': ('jboa28wmq', 'rootname of the observation set'),
'IMAGETYP': ('EXT', 'type of exposure identifier'),
'PRIMESI': ('WFC3', 'instrument designated as prime'),
'TARGNAME': ('ANY', "proposer's target name"),
'RA_TARG': (150.1554086126, 'right ascension of the target (deg) (J2000)'),
'DEC_TARG': (2.270881608073, 'declination of the target (deg) (J2000)'),
'PROPOSID': (12440, 'PEP proposal identifier'),
'LINENUM': ('28.002', 'proposal logsheet line number'),
'PR_INV_L': ('Faber', 'last name of principal investigator'),
'PR_INV_F': ('Sandra', 'first name of principal investigator'),
'PR_INV_M': ('M.', 'middle name / initial of principal investigat'),
'SUNANGLE': (107.339531, 'angle between sun and V1 axis'),
'MOONANGL': (61.991249, 'angle between moon and V1 axis'),
'SUN_ALT': (-32.338875, "altitude of the sun above Earth's limb"),
'FGSLOCK': ('FINE', 'commanded FGS lock (FINE,COARSE,GYROS,UNKNOWN)'),
'GYROMODE': ('T', 'number of gyros scheduled, T=3+OBAD'),
'REFFRAME': ('ICRS', 'guide star catalog version'),
'MTFLAG': ('', 'moving target flag; T if it is a moving target'),
'DATE-OBS': ('2011-12-11', 'ISO-8601 time of observation'),
'TIME-OBS': ('13:09:12', 'UT time of start of observation (hh:mm:ss)'),
'EXPSTART': (55906.54805854, 'exposure start time (Modified Julian Date)'),
'EXPEND': (55906.55125326, 'exposure end time (Modified Julian Date)'),
'EXPTIME': (36800.0, 'exposure duration (seconds)--calculated'),
'EXPFLAG': ('NORMAL', 'Exposure interruption indicator'),
'QUALCOM1': ('', ''),
'QUALCOM2': ('', ''),
'QUALCOM3': ('', ''),
'QUALITY': ('', ''),
'PA_V3': (128.0, 'position angle of V3-axis of HST (deg)'),
'POSTARG1': (0.0, 'POSTARG in axis 1 direction'),
'POSTARG2': (0.0, 'POSTARG in axis 2 direction'),
'OPUS_VER': ('OPUS 2011_1h', 'OPUS software system version number'),
'CAL_VER': ('5.1.1 (27-Apr-2010)', 'CALACS code version'),
'PROCTIME': (55908.85636574, 'Pipeline processing time (MJD)'),
'OBSTYPE': ('IMAGING', 'observation type - imaging or spectroscopic'),
'OBSMODE': ('ACCUM', 'operating mode'),
'CTEIMAGE': ('NONE', 'type of Charge Transfer Image, if applicable'),
'SCLAMP': ('NONE', 'lamp status, NONE or name of lamp which is on'),
'NRPTEXP': (1, 'number of repeat exposures in set: default 1'),
'SUBARRAY': (False, 'data from a subarray (T) or full frame (F)'),
'DETECTOR': ('WFC', 'detector in use: WFC, HRC, or SBC'),
'FILTER1': ('F606W', 'element selected from filter wheel 1'),
'FW1OFFST': (0, 'computed filter wheel offset'),
'FILTER2': ('CLEAR2L', 'element selected from filter wheel 2'),
'FW1ERROR': (False, 'filter wheel position error flag'),
'FW2OFFST': (-4320, 'computed filter wheel offset'),
'FW2ERROR': (True, 'filter wheel position error flag'),
'FWSOFFST': (0, 'computed filter wheel offset'),
'FWSERROR': (False, 'filter wheel position error flag'),
'LRFWAVE': (0.0, 'proposed linear ramp filter wavelength'),
'APERTURE': ('WFC', 'aperture name'),
'PROPAPER': ('WFC', 'proposed aperture name'),
'DIRIMAGE': ('NONE', 'direct image for grism or prism exposure'),
'CTEDIR': ('NONE', 'CTE measurement direction: serial or parallel'),
'CRSPLIT': (1, 'number of cosmic ray split exposures'),
'STATFLAG': (False, 'Calculate statistics?'),
'WRTERR': (True, 'write out error array extension'),
'DQICORR': ('COMPLETE', 'data quality initialization'),
'ATODCORR': ('OMIT', 'correct for A to D conversion errors'),
'BLEVCORR': ('COMPLETE', 'subtract bias level computed from overscan img'),
'BIASCORR': ('COMPLETE', 'Subtract bias image'),
'FLSHCORR': ('OMIT', 'post flash correction'),
'CRCORR': ('OMIT', 'combine observations to reject cosmic rays'),
'EXPSCORR': ('COMPLETE', 'process individual observations after cr-reject'),
'SHADCORR': ('OMIT', 'apply shutter shading correction'),
'DARKCORR': ('COMPLETE', 'Subtract dark image'),
'FLATCORR': ('COMPLETE', 'flat field data'),
'PHOTCORR': ('COMPLETE', 'populate photometric header keywords'),
'RPTCORR': ('OMIT', 'add individual repeat observations'),
'DRIZCORR': ('PERFORM', 'drizzle processing'),
'BPIXTAB': ('jref$t3n1116nj_bpx.fits', 'bad pixel table'),
'CCDTAB': ('jref$uc82140bj_ccd.fits', 'CCD calibration parameters'),
'ATODTAB': ('jref$t3n1116mj_a2d.fits', 'analog to digital correction file'),
'OSCNTAB': ('jref$lch1459bj_osc.fits', 'CCD overscan table'),
'BIASFILE': ('jref$vbh1844rj_bia.fits', 'bias image file name'),
'FLSHFILE': ('N/A', 'post flash correction file name'),
'CRREJTAB': ('jref$n4e12511j_crr.fits', 'cosmic ray rejection parameters'),
'SHADFILE': ('jref$kcb17349j_shd.fits', 'shutter shading correction file'),
'DARKFILE': ('jref$vbh18454j_drk.fits', 'dark image file name'),
'PFLTFILE': ('jref$qb12257sj_pfl.fits',
'pixel to pixel flat field file name'),
'DFLTFILE': ('N/A', 'delta flat field file name'),
'LFLTFILE': ('N/A', 'low order flat'),
'PHOTTAB': ('N/A', 'Photometric throughput table'),
'GRAPHTAB': ('mtab$v9n1603mm_tmg.fits', 'the HST graph table'),
'COMPTAB': ('mtab$vb71653dm_tmc.fits', 'the HST components table'),
'IDCTAB': ('jref$v8q1444tj_idc.fits', 'image distortion correction table'),
'DGEOFILE': ('jref$qbu16424j_dxy.fits', 'Distortion correction image'),
'MDRIZTAB': ('jref$ub21537aj_mdz.fits', 'MultiDrizzle parameter table'),
'CFLTFILE': ('N/A', 'Coronagraphic spot image'),
'SPOTTAB': ('N/A', 'Coronagraphic spot offset table'),
'IMPHTTAB': ('jref$vbb18107j_imp.fits', 'Image Photometry Table'),
'MEANEXP': (0.0, 'reference exposure time for parameters'),
'SCALENSE': (0.0, 'multiplicative scale factor applied to noise'),
'INITGUES': ('', 'initial guess method (MIN or MED)'),
'SKYSUB': ('', 'sky value subtracted (MODE or NONE)'),
'SKYSUM': (0.0, 'sky level from the sum of all constituent image'),
'CRSIGMAS': ('', 'statistical rejection criteria'),
'CRRADIUS': (0.0, 'rejection propagation radius (pixels)'),
'CRTHRESH': (0.0, 'rejection propagation threshold'),
'BADINPDQ': (0, 'data quality flag bits to reject'),
'REJ_RATE': (0.0, 'rate at which pixels are affected by cosmic ray'),
'CRMASK': (False, 'flag CR-rejected pixels in input files (T/F)'),
'MDRIZSKY': (32.08782958984375, 'Sky value computed by MultiDrizzle'),
'T_SGSTAR': ('N/A', 'OMS calculated guide star control'),
'PATTERN1': ('NONE', 'primary pattern type'),
'P1_SHAPE': ('', 'primary pattern shape'),
'P1_PURPS': ('', 'primary pattern purpose'),
'P1_NPTS': (0, 'number of points in primary pattern'),
'P1_PSPAC': (0.0, 'point spacing for primary pattern (arc-sec)'),
'P1_LSPAC': (0.0, 'line spacing for primary pattern (arc-sec)'),
'P1_ANGLE': (0.0, 'angle between sides of parallelogram patt (deg)'),
'P1_FRAME': ('', 'coordinate frame of primary pattern'),
'P1_ORINT': (0.0, 'orientation of pattern to coordinate frame (deg'),
'P1_CENTR': ('', 'center pattern relative to pointing (yes/no)'),
'PATTSTEP': (0, 'position number of this point in the pattern'),
'FLASHDUR': (0.0, 'Exposure time in seconds: 0.1 to 409.5'),
'FLASHCUR': ('OFF', 'Post flash current: OFF, LOW, MED, HIGH'),
'FLASHSTA': ('NOT PERFORMED', 'Status: SUCCESSFUL, ABORTED, NOT PERFORMED'),
'SHUTRPOS': ('A', 'Shutter position: A or B'),
'CCDAMP': ('ABCD', 'CCD Amplifier Readout Configuration'),
'CCDGAIN': (2.0, 'commanded gain of CCD'),
'CCDOFSTA': (1, 'commanded CCD bias offset for amplifier A'),
'CCDOFSTB': (1, 'commanded CCD bias offset for amplifier B'),
'CCDOFSTC': (1, 'commanded CCD bias offset for amplifier C'),
'CCDOFSTD': (1, 'commanded CCD bias offset for amplifier D'),
'ATODGNA': (2.02, 'calibrated gain for amplifier A'),
'ATODGNB': (1.886, 'calibrated gain for amplifier B'),
'ATODGNC': (2.017, 'calibrated gain for amplifier C'),
'ATODGND': (2.0109999, 'calibrated gain for amplifier D'),
'READNSEA': (4.5700002, 'calibrated read noise for amplifier A'),
'READNSEB': (3.9100001, 'calibrated read noise for amplifier B'),
'READNSEC': (4.25, 'calibrated read noise for amplifier C'),
'READNSED': (4.04, 'calibrated read noise for amplifier D'),
'BIASLEVA': (2088.5564, 'bias level for amplifier A'),
'BIASLEVB': (2140.5024, 'bias level for amplifier B'),
'BIASLEVC': (2208.7419, 'bias level for amplifier C'),
'BIASLEVD': (2296.7388, 'bias level for amplifier D'),
'ASN_ID': ('JBOA28010', 'unique identifier assigned to association'),
'ASN_TAB': ('jboa28010_asn.fits', 'name of the association table'),
'ASN_MTYP': ('EXP-DTH', 'Role of the Member in the Association'),
'BSTRCORR': ('COMPLETE', ''),
'PCTEFILE': ('jref$pctefile_101109.fits', ''),
'PCTETAB': ('jref$pctetab_pcte_20110913113559.fits', ''),
'PCTECORR': ('COMPLETE', ''),
'PCTEFRAC': (1.289367530158845, ''),
'EXPNAME': ('jboa28wmq', 'exposure identifier'),
'BUNIT': ('ELECTRONS', 'brightness units'),
'CCDCHIP': (1, 'CCD chip (1 or 2)'),
'WCSAXES': (2, 'Number of coordinate axes'),
'LTV1': (0.0, 'offset in X to subsection start'),
'LTV2': (0.0, 'offset in Y to subsection start'),
'LTM1_1': (1.0, 'reciprocal of sampling rate in X'),
'LTM2_2': (1.0, 'reciprocal of sampling rate in Y'),
'ORIENTAT': (-54.67632556350016,
'position angle of image y axis (deg. e of n)'),
'RA_APER': (150.1554086126, 'RA of aperture reference position'),
'DEC_APER': (2.270881608073, 'Declination of aperture reference position'),
'PA_APER': (-54.4475, 'Position Angle of reference aperture center (de'),
'VAFACTOR': (1.000104465141, 'velocity aberration plate scale factor'),
'CENTERA1': (2073, 'subarray axis1 center pt in unbinned dect. pix'),
'CENTERA2': (1035, 'subarray axis2 center pt in unbinned dect. pix'),
'SIZAXIS1': (4096, 'subarray axis1 size in unbinned detector pixels'),
'SIZAXIS2': (2048, 'subarray axis2 size in unbinned detector pixels'),
'BINAXIS1': (1, 'axis1 data bin size in unbinned detector pixels'),
'BINAXIS2': (1, 'axis2 data bin size in unbinned detector pixels'),
'PHOTMODE': ('ACS WFC1 F606W MJD#55906.5481', 'observation con'),
'PHOTFLAM': (7.8624958e-20, 'inverse sensitivity, ergs/cm2/Ang/electron'),
'PHOTZPT': (-21.1, 'ST magnitude zero point'),
'PHOTPLAM': (5921.1147, 'Pivot wavelength (Angstroms)'),
'PHOTBW': (672.23627, 'RMS bandwidth of filter plus detector'),
'NCOMBINE': (1, 'number of image sets combined during CR rejecti'),
'FILLCNT': (1, 'number of segments containing fill'),
'ERRCNT': (1, 'number of segments containing errors'),
'PODPSFF': (False, 'podps fill present (T/F)'),
'STDCFFF': (True, 'science telemetry fill data present (T=1/F=0)'),
'STDCFFP': ('0x5569', 'science telemetry fill pattern (hex)'),
'WFCMPRSD': (False, 'was WFC data compressed? (T/F)'),
'CBLKSIZ': (0, 'size of compression block in 2-byte words'),
'LOSTPIX': (0, '#pixels lost due to buffer overflow'),
'COMPTYP': ('None', 'compression type performed (Partial/Full/None)'),
'NGOODPIX': (8097343, 'number of good pixels'),
'SDQFLAGS': (31743, 'serious data quality flags'),
'GOODMIN': (-31.759687, 'minimum value of good pixels'),
'GOODMAX': (85606.719, 'maximum value of good pixels'),
'GOODMEAN': (35.94437, 'mean value of good pixels'),
'SOFTERRS': (0, 'number of soft error pixels (DQF=1)'),
'SNRMIN': (-3.4609985, 'minimum signal to noise of good pixels'),
'SNRMAX': (233.93831, 'maximum signal to noise of good pixels'),
'SNRMEAN': (5.9348207, 'mean value of signal to noise of good pixels'),
'MEANDARK': (1.2713139, 'average of the dark values subtracted'),
'MEANBLEV': (2114.5295, 'average of all bias levels subtracted'),
'MEANFLSH': (0.0, 'Mean number of counts in post flash exposure'),
'ONAXIS2': (2048, 'Axis length'),
'ONAXIS1': (4096, 'Axis length'),
'OORIENTA': (-54.64776336099293,
'position angle of image y axis (deg. e of n)'),
'OCTYPE1': ('RA---TAN', 'the coordinate type for the first axis'),
'OCTYPE2': ('DEC--TAN', 'the coordinate type for the second axis'),
'WCSCDATE': ('13:02:32 (10/04/2012)', 'Time WCS keywords were copied.'),
'A_0_2': (2.26194120304176e-06, ''),
'B_0_2': (-9.7985788387639e-06, ''),
'A_1_1': (-7.5302905463753e-06, ''),
'B_1_1': (6.42569986264533e-06, ''),
'A_2_0': (8.51886870532632e-06, ''),
'B_2_0': (-2.9658922285423e-06, ''),
'A_0_3': (6.51050854317125e-11, ''),
'B_0_3': (-4.1421499542394e-10, ''),
'A_1_2': (-5.2539201413375e-10, ''),
'B_1_2': (-3.0354276197375e-11, ''),
'A_2_1': (-1.0714004130419e-10, ''),
'B_2_1': (-4.4034927976003e-10, ''),
'A_3_0': (-4.6936360210189e-10, ''),
'B_3_0': (9.00334210115821e-11, ''),
'A_0_4': (1.35191449346299e-13, ''),
'B_0_4': (-1.5248974790417e-13, ''),
'A_1_3': (-1.4269338401366e-14, ''),
'B_1_3': (2.75911271664302e-14, ''),
'A_2_2': (9.70199603291834e-14, ''),
'B_2_2': (-1.0403607372429e-13, ''),
'A_3_1': (3.80059786170717e-14, ''),
'B_3_1': (-3.8363933112663e-14, ''),
'A_4_0': (1.83627862287182e-14, ''),
'B_4_0': (-1.6913942054528e-14, ''),
'A_ORDER': (4, ''),
'B_ORDER': (4, ''),
'IDCSCALE': (0.05, ''),
'IDCV2REF': (261.1130981445312, ''),
'IDCV3REF': (198.231201171875, ''),
'IDCTHETA': (0.0, ''),
'OCX10': (0.002270935984783606, ''),
'OCX11': (0.04922343821974121, ''),
'OCY10': (0.0485839959198564, ''),
'OCY11': (0.00213603403929032, ''),
'TDDALPHA': (0.2802605508521792, ''),
'TDDBETA': (-0.0907535169507264, ''),
'SKYVAL': (32.5013968269, ''),
'SKYRMS': (7.873235, ''),
'QUADOFFA': (0.190616225, ''),
'QUADOFFB': (-0.660557125, ''),
'QUADOFFC': (0.117621775, ''),
'QUADOFFD': (0.352319125, ''),
'NDRIZIM': (100, 'Drizzle, number of images drizzled onto this ou'),
'D001VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D001GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D001DATA': ('cos01_28_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'),
'D001DEXP': (275.0, 'Drizzle, input image exposure time (s)'),
'D001OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D001OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D001OUCO': ('', 'Drizzle, output context image'),
'D001MASK': ('cos01_28_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D001WTSC': (583770.1, 'Drizzle, weighting factor for input image'),
'D001KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D001PIXF': (0.8, 'Drizzle, linear size of drop'),
'D001COEF': ('cos01_28_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D001XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D001YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D001LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D001EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D001INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D001OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D001FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D001INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D001INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D001OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D001OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D001SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D002VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D002GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D002DATA': ('cos01_28_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'),
'D002DEXP': (707.0, 'Drizzle, input image exposure time (s)'),
'D002OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D002OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D002OUCO': ('', 'Drizzle, output context image'),
'D002MASK': ('cos01_28_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D002WTSC': (3858213.0, 'Drizzle, weighting factor for input image'),
'D002KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D002PIXF': (0.8, 'Drizzle, linear size of drop'),
'D002COEF': ('cos01_28_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D002XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D002YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D002LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D002EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D002INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D002OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D002FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D002INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D002INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D002OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D002OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D002SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D003VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D003GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D003DATA': ('cos01_29_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'),
'D003DEXP': (275.0, 'Drizzle, input image exposure time (s)'),
'D003OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D003OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D003OUCO': ('', 'Drizzle, output context image'),
'D003MASK': ('cos01_29_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D003WTSC': (583802.2, 'Drizzle, weighting factor for input image'),
'D003KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D003PIXF': (0.8, 'Drizzle, linear size of drop'),
'D003COEF': ('cos01_29_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D003XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D003YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D003LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D003EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D003INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D003OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D003FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D003INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D003INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D003OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D003OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D003SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D004VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D004GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D004DATA': ('cos01_29_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'),
'D004DEXP': (707.0, 'Drizzle, input image exposure time (s)'),
'D004OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D004OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D004OUCO': ('', 'Drizzle, output context image'),
'D004MASK': ('cos01_29_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D004WTSC': (3858522.0, 'Drizzle, weighting factor for input image'),
'D004KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D004PIXF': (0.8, 'Drizzle, linear size of drop'),
'D004COEF': ('cos01_29_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D004XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D004YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D004LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D004EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D004INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D004OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D004FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D004INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D004INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D004OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D004OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D004SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D005VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D005GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D005DATA': ('cos01_30_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'),
'D005DEXP': (275.0, 'Drizzle, input image exposure time (s)'),
'D005OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D005OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D005OUCO': ('', 'Drizzle, output context image'),
'D005MASK': ('cos01_30_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D005WTSC': (583802.4, 'Drizzle, weighting factor for input image'),
'D005KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D005PIXF': (0.8, 'Drizzle, linear size of drop'),
'D005COEF': ('cos01_30_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D005XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D005YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D005LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D005EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D005INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D005OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D005FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D005INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D005INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D005OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D005OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D005SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D006VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D006GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D006DATA': ('cos01_30_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'),
'D006DEXP': (707.0, 'Drizzle, input image exposure time (s)'),
'D006OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D006OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D006OUCO': ('', 'Drizzle, output context image'),
'D006MASK': ('cos01_30_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D006WTSC': (3858522.0, 'Drizzle, weighting factor for input image'),
'D006KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D006PIXF': (0.8, 'Drizzle, linear size of drop'),
'D006COEF': ('cos01_30_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D006XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D006YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D006LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D006EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D006INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D006OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D006FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D006INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D006INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D006OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D006OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D006SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D007VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D007GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D007DATA': ('cos01_32_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'),
'D007DEXP': (275.0, 'Drizzle, input image exposure time (s)'),
'D007OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D007OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D007OUCO': ('', 'Drizzle, output context image'),
'D007MASK': ('cos01_32_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D007WTSC': (583801.9, 'Drizzle, weighting factor for input image'),
'D007KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D007PIXF': (0.8, 'Drizzle, linear size of drop'),
'D007COEF': ('cos01_32_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D007XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D007YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D007LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D007EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D007INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D007OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D007FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D007INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D007INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D007OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D007OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D007SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D008VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D008GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D008DATA': ('cos01_32_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'),
'D008DEXP': (707.0, 'Drizzle, input image exposure time (s)'),
'D008OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D008OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D008OUCO': ('', 'Drizzle, output context image'),
'D008MASK': ('cos01_32_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D008WTSC': (3858506.0, 'Drizzle, weighting factor for input image'),
'D008KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D008PIXF': (0.8, 'Drizzle, linear size of drop'),
'D008COEF': ('cos01_32_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D008XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D008YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D008LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D008EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D008INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D008OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D008FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D008INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D008INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D008OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D008OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D008SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D009VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D009GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D009DATA': ('cos01_33_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'),
'D009DEXP': (275.0, 'Drizzle, input image exposure time (s)'),
'D009OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D009OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D009OUCO': ('', 'Drizzle, output context image'),
'D009MASK': ('cos01_33_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'),
'D009WTSC': (583803.6, 'Drizzle, weighting factor for input image'),
'D009KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D009PIXF': (0.8, 'Drizzle, linear size of drop'),
'D009COEF': ('cos01_33_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'),
'D009XGIM': ('jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'),
'D009YGIM': ('jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'),
'D009LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D009EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D009INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D009OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D009FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D009INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D009INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D009OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D009OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D009SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D010VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D010GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D010DATA': ('cos01_33_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'),
'D010DEXP': (275.0, 'Drizzle, input image exposure time (s)'),
'D010OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D010OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D010OUCO': ('', 'Drizzle, output context image'),
'D010MASK': ('cos01_33_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D010WTSC': (583803.6, 'Drizzle, weighting factor for input image'),
'D010KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D010PIXF': (0.8, 'Drizzle, linear size of drop'),
'D010COEF': ('cos01_33_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D010XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D010YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D010LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D010EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D010INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D010OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D010FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D010INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D010INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D010OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D010OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D010SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D011VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D011GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D011DATA': ('cos01_33_f606w_2_flt_sci1_final.fits',
'Drizzle, input data image'),
'D011DEXP': (707.0, 'Drizzle, input image exposure time (s)'),
'D011OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D011OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D011OUCO': ('', 'Drizzle, output context image'),
'D011MASK': ('cos01_33_f606w_2_flt_wht1_final.fits',
'Drizzle, input weighting imag'),
'D011WTSC': (3858528.0, 'Drizzle, weighting factor for input image'),
'D011KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D011PIXF': (0.8, 'Drizzle, linear size of drop'),
'D011COEF': ('cos01_33_f606w_2_flt_coeffs2.dat',
'Drizzle, coefficients file name'),
'D011XGIM': ('jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'),
'D011YGIM': ('jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'),
'D011LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D011EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D011INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D011OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D011FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D011INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D011INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D011OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D011OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D011SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D012VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D012GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D012DATA': ('cos01_33_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'),
'D012DEXP': (707.0, 'Drizzle, input image exposure time (s)'),
'D012OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D012OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D012OUCO': ('', 'Drizzle, output context image'),
'D012MASK': ('cos01_33_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D012WTSC': (3858528.0, 'Drizzle, weighting factor for input image'),
'D012KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D012PIXF': (0.8, 'Drizzle, linear size of drop'),
'D012COEF': ('cos01_33_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D012XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D012YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D012LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D012EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D012INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D012OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D012FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D012INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D012INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D012OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D012OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D012SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D013VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D013GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D013DATA': ('cos01_34_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'),
'D013DEXP': (275.0, 'Drizzle, input image exposure time (s)'),
'D013OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D013OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D013OUCO': ('', 'Drizzle, output context image'),
'D013MASK': ('cos01_34_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'),
'D013WTSC': (583803.6, 'Drizzle, weighting factor for input image'),
'D013KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D013PIXF': (0.8, 'Drizzle, linear size of drop'),
'D013COEF': ('cos01_34_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'),
'D013XGIM': ('jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'),
'D013YGIM': ('jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'),
'D013LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D013EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D013INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D013OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D013FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D013INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D013INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D013OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D013OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D013SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D014VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D014GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D014DATA': ('cos01_34_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'),
'D014DEXP': (275.0, 'Drizzle, input image exposure time (s)'),
'D014OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D014OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D014OUCO': ('', 'Drizzle, output context image'),
'D014MASK': ('cos01_34_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D014WTSC': (583803.6, 'Drizzle, weighting factor for input image'),
'D014KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D014PIXF': (0.8, 'Drizzle, linear size of drop'),
'D014COEF': ('cos01_34_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D014XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D014YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D014LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D014EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D014INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D014OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D014FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D014INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D014INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D014OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D014OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D014SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D015VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D015GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D015DATA': ('cos01_34_f606w_2_flt_sci1_final.fits',
'Drizzle, input data image'),
'D015DEXP': (707.0, 'Drizzle, input image exposure time (s)'),
'D015OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D015OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D015OUCO': ('', 'Drizzle, output context image'),
'D015MASK': ('cos01_34_f606w_2_flt_wht1_final.fits',
'Drizzle, input weighting imag'),
'D015WTSC': (3858529.0, 'Drizzle, weighting factor for input image'),
'D015KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D015PIXF': (0.8, 'Drizzle, linear size of drop'),
'D015COEF': ('cos01_34_f606w_2_flt_coeffs2.dat',
'Drizzle, coefficients file name'),
'D015XGIM': ('jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'),
'D015YGIM': ('jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'),
'D015LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D015EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D015INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D015OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D015FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D015INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D015INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D015OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D015OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D015SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D016VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D016GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D016DATA': ('cos01_34_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'),
'D016DEXP': (707.0, 'Drizzle, input image exposure time (s)'),
'D016OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D016OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D016OUCO': ('', 'Drizzle, output context image'),
'D016MASK': ('cos01_34_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D016WTSC': (3858529.0, 'Drizzle, weighting factor for input image'),
'D016KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D016PIXF': (0.8, 'Drizzle, linear size of drop'),
'D016COEF': ('cos01_34_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D016XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D016YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D016LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D016EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D016INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D016OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D016FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D016INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D016INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D016OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D016OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D016SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D017VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D017GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D017DATA': ('cos01_36_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'),
'D017DEXP': (275.0, 'Drizzle, input image exposure time (s)'),
'D017OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D017OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D017OUCO': ('', 'Drizzle, output context image'),
'D017MASK': ('cos01_36_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D017WTSC': (583804.3, 'Drizzle, weighting factor for input image'),
'D017KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D017PIXF': (0.8, 'Drizzle, linear size of drop'),
'D017COEF': ('cos01_36_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D017XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D017YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D017LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D017EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D017INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D017OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D017FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D017INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D017INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D017OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D017OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D017SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D018VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D018GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D018DATA': ('cos01_36_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'),
'D018DEXP': (707.0, 'Drizzle, input image exposure time (s)'),
'D018OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D018OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D018OUCO': ('', 'Drizzle, output context image'),
'D018MASK': ('cos01_36_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D018WTSC': (3858532.0, 'Drizzle, weighting factor for input image'),
'D018KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D018PIXF': (0.8, 'Drizzle, linear size of drop'),
'D018COEF': ('cos01_36_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D018XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D018YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D018LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D018EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D018INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D018OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D018FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D018INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D018INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D018OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D018OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D018SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D019VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D019GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D019DATA': ('cos01_37_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'),
'D019DEXP': (275.0, 'Drizzle, input image exposure time (s)'),
'D019OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D019OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D019OUCO': ('', 'Drizzle, output context image'),
'D019MASK': ('cos01_37_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'),
'D019WTSC': (583796.7, 'Drizzle, weighting factor for input image'),
'D019KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D019PIXF': (0.8, 'Drizzle, linear size of drop'),
'D019COEF': ('cos01_37_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'),
'D019XGIM': ('jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'),
'D019YGIM': ('jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'),
'D019LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D019EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D019INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D019OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D019FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D019INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D019INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D019OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D019OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D019SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D020VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D020GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D020DATA': ('cos01_37_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'),
'D020DEXP': (275.0, 'Drizzle, input image exposure time (s)'),
'D020OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D020OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D020OUCO': ('', 'Drizzle, output context image'),
'D020MASK': ('cos01_37_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D020WTSC': (583796.7, 'Drizzle, weighting factor for input image'),
'D020KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D020PIXF': (0.8, 'Drizzle, linear size of drop'),
'D020COEF': ('cos01_37_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D020XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D020YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D020LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D020EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D020INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D020OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D020FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D020INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D020INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D020OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D020OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D020SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D021VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D021GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D021DATA': ('cos01_37_f606w_2_flt_sci1_final.fits',
'Drizzle, input data image'),
'D021DEXP': (707.0, 'Drizzle, input image exposure time (s)'),
'D021OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D021OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D021OUCO': ('', 'Drizzle, output context image'),
'D021MASK': ('cos01_37_f606w_2_flt_wht1_final.fits',
'Drizzle, input weighting imag'),
'D021WTSC': (3858427.0, 'Drizzle, weighting factor for input image'),
'D021KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D021PIXF': (0.8, 'Drizzle, linear size of drop'),
'D021COEF': ('cos01_37_f606w_2_flt_coeffs2.dat',
'Drizzle, coefficients file name'),
'D021XGIM': ('jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'),
'D021YGIM': ('jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'),
'D021LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D021EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D021INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D021OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D021FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D021INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D021INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D021OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D021OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D021SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D022VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D022GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D022DATA': ('cos01_37_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'),
'D022DEXP': (707.0, 'Drizzle, input image exposure time (s)'),
'D022OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D022OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D022OUCO': ('', 'Drizzle, output context image'),
'D022MASK': ('cos01_37_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D022WTSC': (3858427.0, 'Drizzle, weighting factor for input image'),
'D022KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D022PIXF': (0.8, 'Drizzle, linear size of drop'),
'D022COEF': ('cos01_37_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D022XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D022YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D022LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D022EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D022INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D022OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D022FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D022INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D022INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D022OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D022OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D022SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D023VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D023GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D023DATA': ('cos01_38_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'),
'D023DEXP': (275.0, 'Drizzle, input image exposure time (s)'),
'D023OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D023OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D023OUCO': ('', 'Drizzle, output context image'),
'D023MASK': ('cos01_38_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'),
'D023WTSC': (583805.7, 'Drizzle, weighting factor for input image'),
'D023KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D023PIXF': (0.8, 'Drizzle, linear size of drop'),
'D023COEF': ('cos01_38_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'),
'D023XGIM': ('jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'),
'D023YGIM': ('jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'),
'D023LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D023EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D023INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D023OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D023FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D023INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D023INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D023OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D023OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D023SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D024VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D024GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D024DATA': ('cos01_38_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'),
'D024DEXP': (275.0, 'Drizzle, input image exposure time (s)'),
'D024OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D024OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D024OUCO': ('', 'Drizzle, output context image'),
'D024MASK': ('cos01_38_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D024WTSC': (583805.7, 'Drizzle, weighting factor for input image'),
'D024KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D024PIXF': (0.8, 'Drizzle, linear size of drop'),
'D024COEF': ('cos01_38_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D024XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D024YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D024LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D024EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D024INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D024OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D024FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D024INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D024INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D024OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D024OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D024SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D025VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D025GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D025DATA': ('cos01_38_f606w_2_flt_sci1_final.fits',
'Drizzle, input data image'),
'D025DEXP': (707.0, 'Drizzle, input image exposure time (s)'),
'D025OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D025OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D025OUCO': ('', 'Drizzle, output context image'),
'D025MASK': ('cos01_38_f606w_2_flt_wht1_final.fits',
'Drizzle, input weighting imag'),
'D025WTSC': (3858539.0, 'Drizzle, weighting factor for input image'),
'D025KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D025PIXF': (0.8, 'Drizzle, linear size of drop'),
'D025COEF': ('cos01_38_f606w_2_flt_coeffs2.dat',
'Drizzle, coefficients file name'),
'D025XGIM': ('jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'),
'D025YGIM': ('jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'),
'D025LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D025EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D025INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D025OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D025FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D025INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D025INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D025OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D025OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D025SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D026VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D026GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D026DATA': ('cos01_38_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'),
'D026DEXP': (707.0, 'Drizzle, input image exposure time (s)'),
'D026OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D026OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D026OUCO': ('', 'Drizzle, output context image'),
'D026MASK': ('cos01_38_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D026WTSC': (3858539.0, 'Drizzle, weighting factor for input image'),
'D026KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D026PIXF': (0.8, 'Drizzle, linear size of drop'),
'D026COEF': ('cos01_38_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D026XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D026YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D026LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D026EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D026INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D026OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D026FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D026INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D026INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D026OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D026OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D026SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D027VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D027GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D027DATA': ('cos01_40_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'),
'D027DEXP': (225.0, 'Drizzle, input image exposure time (s)'),
'D027OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D027OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D027OUCO': ('', 'Drizzle, output context image'),
'D027MASK': ('cos01_40_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D027WTSC': (390803.6, 'Drizzle, weighting factor for input image'),
'D027KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D027PIXF': (0.8, 'Drizzle, linear size of drop'),
'D027COEF': ('cos01_40_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D027XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D027YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D027LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D027EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D027INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D027OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D027FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D027INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D027INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D027OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D027OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D027SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D028VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D028GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D028DATA': ('cos01_40_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'),
'D028DEXP': (407.0, 'Drizzle, input image exposure time (s)'),
'D028OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D028OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D028OUCO': ('', 'Drizzle, output context image'),
'D028MASK': ('cos01_40_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D028WTSC': (1278684.0, 'Drizzle, weighting factor for input image'),
'D028KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D028PIXF': (0.8, 'Drizzle, linear size of drop'),
'D028COEF': ('cos01_40_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D028XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D028YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D028LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D028EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D028INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D028OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D028FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D028INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D028INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D028OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D028OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D028SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D029VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D029GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D029DATA': ('cos01_41_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'),
'D029DEXP': (225.0, 'Drizzle, input image exposure time (s)'),
'D029OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D029OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D029OUCO': ('', 'Drizzle, output context image'),
'D029MASK': ('cos01_41_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'),
'D029WTSC': (390813.4, 'Drizzle, weighting factor for input image'),
'D029KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D029PIXF': (0.8, 'Drizzle, linear size of drop'),
'D029COEF': ('cos01_41_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'),
'D029XGIM': ('jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'),
'D029YGIM': ('jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'),
'D029LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D029EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D029INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D029OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D029FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D029INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D029INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D029OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D029OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D029SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D030VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D030GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D030DATA': ('cos01_41_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'),
'D030DEXP': (225.0, 'Drizzle, input image exposure time (s)'),
'D030OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D030OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D030OUCO': ('', 'Drizzle, output context image'),
'D030MASK': ('cos01_41_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'),
'D030WTSC': (390813.4, 'Drizzle, weighting factor for input image'),
'D030KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D030PIXF': (0.8, 'Drizzle, linear size of drop'),
'D030COEF': ('cos01_41_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'),
'D030XGIM': ('jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'),
'D030YGIM': ('jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'),
'D030LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D030EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D030INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D030OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D030FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D030INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D030INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
'D030OUXC': (7001.0, 'Drizzle, reference center of output image (X)'),
'D030OUYC': (7201.0, 'Drizzle, reference center of output image (Y)'),
'D030SECP': (False, 'Drizzle, there are no secondary geometric param'),
'D031VER': ('WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'),
'D031GEOM': ('Header WCS', 'Drizzle, source of geometric information'),
'D031DATA': ('cos01_41_f606w_2_flt_sci1_final.fits',
'Drizzle, input data image'),
'D031DEXP': (407.0, 'Drizzle, input image exposure time (s)'),
'D031OUDA': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'),
'D031OUWE': ('tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'),
'D031OUCO': ('', 'Drizzle, output context image'),
'D031MASK': ('cos01_41_f606w_2_flt_wht1_final.fits',
'Drizzle, input weighting imag'),
'D031WTSC': (1278740.0, 'Drizzle, weighting factor for input image'),
'D031KERN': ('square', 'Drizzle, form of weight distribution kernel'),
'D031PIXF': (0.8, 'Drizzle, linear size of drop'),
'D031COEF': ('cos01_41_f606w_2_flt_coeffs2.dat',
'Drizzle, coefficients file name'),
'D031XGIM': ('jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'),
'D031YGIM': ('jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'),
'D031LAM': (555.0, 'Drizzle, wavelength applied for transformation'),
'D031EXKY': ('exptime', 'Drizzle, exposure keyword name in input image'),
'D031INUN': ('counts', 'Drizzle, units of input image - counts or cps'),
'D031OUUN': ('cps', 'Drizzle, units of output image - counts or cps'),
'D031FVAL': ('INDEF', 'Drizzle, fill value for zero weight output pixe'),
'D031INXC': (2049.0, 'Drizzle, reference center of input image (X)'),
'D031INYC': (1025.0, 'Drizzle, reference center of input image (Y)'),
...}
The value is now in the first element of each tuple. For example, to get just the value of CRVAL1
, we could do something like the following.
myfile['CRVAL1'][0]
150.1163213
# Update O_EXT_NM key since it was blank and causing crashing while saving below.
myfile.tree['O_EXT_NM'] = 'Original Name Filler'
Example 3: View the file as a searchable table#
For both FITS and ASDF, it can sometimes be painful to search through a long header. This example shows one way of putting the ASDF file into an Astropy table, and then using the show_in_notebook
method to provide an interactive tabular view. You can then search by keyword or sort by column (by clicking on the headers).
In this example, we pull apart two-element tuples into values and comments. For the other data structures, we just put them into the comment column.
def tree_to_table(tree):
keys = list(tree.keys())
values, other = ([] for i in range(2))
for k in keys:
try:
values += [tree[k][0]]
other += [tree[k][1]]
except Exception as e:
values += [None]
other += [tree[k]]
print("An error occured ", e)
return Table([keys, values, other], names=['key', 'value', 'comment or data structure'])
t = tree_to_table(myfile.tree)
t.show_in_notebook()
idx | key | value | comment or data structure |
---|---|---|---|
0 | OBJECT | COS_2EPOCH_ACS_F606W_030MAS_V1.0_SECT23_DRZ[1/1] | |
1 | ORIGIN | NOAO-IRAF FITS Image Kernel July 2003 | FITS file originator |
2 | DATE | 2012-04-10T16:39:27 | Date FITS file was generated |
3 | DATAMIN | 0.0 | |
4 | DATAMAX | 0.0 | |
5 | CRPIX1 | -2552.5 | Pixel coordinate of reference point |
6 | CRVAL1 | 150.1163213 | [deg] Coordinate value at reference point |
7 | CTYPE1 | RA---TAN | Right ascension, gnomonic projection |
8 | CD1_1 | -8.333333e-06 | |
9 | CD2_1 | 0.0 | |
10 | CRPIX2 | -22248.5 | Pixel coordinate of reference point |
11 | CRVAL2 | 2.200973097 | [deg] Coordinate value at reference point |
12 | CTYPE2 | DEC--TAN | Declination, gnomonic projection |
13 | CD1_2 | 0.0 | |
14 | CD2_2 | 8.333333e-06 | |
15 | |||
16 | TELESCOP | HST | telescope used to acquire data |
17 | INSTRUME | ACS | identifier for instrument used to acquire data |
18 | EQUINOX | 2000.0 | [yr] Equinox of equatorial coordinates |
19 | ROOTNAME | jboa28wmq | rootname of the observation set |
20 | IMAGETYP | EXT | type of exposure identifier |
21 | PRIMESI | WFC3 | instrument designated as prime |
22 | TARGNAME | ANY | proposer's target name |
23 | RA_TARG | 150.1554086126 | right ascension of the target (deg) (J2000) |
24 | DEC_TARG | 2.270881608073 | declination of the target (deg) (J2000) |
25 | PROPOSID | 12440 | PEP proposal identifier |
26 | LINENUM | 28.002 | proposal logsheet line number |
27 | PR_INV_L | Faber | last name of principal investigator |
28 | PR_INV_F | Sandra | first name of principal investigator |
29 | PR_INV_M | M. | middle name / initial of principal investigat |
30 | SUNANGLE | 107.339531 | angle between sun and V1 axis |
31 | MOONANGL | 61.991249 | angle between moon and V1 axis |
32 | SUN_ALT | -32.338875 | altitude of the sun above Earth's limb |
33 | FGSLOCK | FINE | commanded FGS lock (FINE,COARSE,GYROS,UNKNOWN) |
34 | GYROMODE | T | number of gyros scheduled, T=3+OBAD |
35 | REFFRAME | ICRS | guide star catalog version |
36 | MTFLAG | moving target flag; T if it is a moving target | |
37 | DATE-OBS | 2011-12-11 | ISO-8601 time of observation |
38 | TIME-OBS | 13:09:12 | UT time of start of observation (hh:mm:ss) |
39 | EXPSTART | 55906.54805854 | exposure start time (Modified Julian Date) |
40 | EXPEND | 55906.55125326 | exposure end time (Modified Julian Date) |
41 | EXPTIME | 36800.0 | exposure duration (seconds)--calculated |
42 | EXPFLAG | NORMAL | Exposure interruption indicator |
43 | QUALCOM1 | ||
44 | QUALCOM2 | ||
45 | QUALCOM3 | ||
46 | QUALITY | ||
47 | PA_V3 | 128.0 | position angle of V3-axis of HST (deg) |
48 | POSTARG1 | 0.0 | POSTARG in axis 1 direction |
49 | POSTARG2 | 0.0 | POSTARG in axis 2 direction |
50 | OPUS_VER | OPUS 2011_1h | OPUS software system version number |
51 | CAL_VER | 5.1.1 (27-Apr-2010) | CALACS code version |
52 | PROCTIME | 55908.85636574 | Pipeline processing time (MJD) |
53 | OBSTYPE | IMAGING | observation type - imaging or spectroscopic |
54 | OBSMODE | ACCUM | operating mode |
55 | CTEIMAGE | NONE | type of Charge Transfer Image, if applicable |
56 | SCLAMP | NONE | lamp status, NONE or name of lamp which is on |
57 | NRPTEXP | 1 | number of repeat exposures in set: default 1 |
58 | SUBARRAY | False | data from a subarray (T) or full frame (F) |
59 | DETECTOR | WFC | detector in use: WFC, HRC, or SBC |
60 | FILTER1 | F606W | element selected from filter wheel 1 |
61 | FW1OFFST | 0 | computed filter wheel offset |
62 | FILTER2 | CLEAR2L | element selected from filter wheel 2 |
63 | FW1ERROR | False | filter wheel position error flag |
64 | FW2OFFST | -4320 | computed filter wheel offset |
65 | FW2ERROR | True | filter wheel position error flag |
66 | FWSOFFST | 0 | computed filter wheel offset |
67 | FWSERROR | False | filter wheel position error flag |
68 | LRFWAVE | 0.0 | proposed linear ramp filter wavelength |
69 | APERTURE | WFC | aperture name |
70 | PROPAPER | WFC | proposed aperture name |
71 | DIRIMAGE | NONE | direct image for grism or prism exposure |
72 | CTEDIR | NONE | CTE measurement direction: serial or parallel |
73 | CRSPLIT | 1 | number of cosmic ray split exposures |
74 | STATFLAG | False | Calculate statistics? |
75 | WRTERR | True | write out error array extension |
76 | DQICORR | COMPLETE | data quality initialization |
77 | ATODCORR | OMIT | correct for A to D conversion errors |
78 | BLEVCORR | COMPLETE | subtract bias level computed from overscan img |
79 | BIASCORR | COMPLETE | Subtract bias image |
80 | FLSHCORR | OMIT | post flash correction |
81 | CRCORR | OMIT | combine observations to reject cosmic rays |
82 | EXPSCORR | COMPLETE | process individual observations after cr-reject |
83 | SHADCORR | OMIT | apply shutter shading correction |
84 | DARKCORR | COMPLETE | Subtract dark image |
85 | FLATCORR | COMPLETE | flat field data |
86 | PHOTCORR | COMPLETE | populate photometric header keywords |
87 | RPTCORR | OMIT | add individual repeat observations |
88 | DRIZCORR | PERFORM | drizzle processing |
89 | BPIXTAB | jref$t3n1116nj_bpx.fits | bad pixel table |
90 | CCDTAB | jref$uc82140bj_ccd.fits | CCD calibration parameters |
91 | ATODTAB | jref$t3n1116mj_a2d.fits | analog to digital correction file |
92 | OSCNTAB | jref$lch1459bj_osc.fits | CCD overscan table |
93 | BIASFILE | jref$vbh1844rj_bia.fits | bias image file name |
94 | FLSHFILE | N/A | post flash correction file name |
95 | CRREJTAB | jref$n4e12511j_crr.fits | cosmic ray rejection parameters |
96 | SHADFILE | jref$kcb17349j_shd.fits | shutter shading correction file |
97 | DARKFILE | jref$vbh18454j_drk.fits | dark image file name |
98 | PFLTFILE | jref$qb12257sj_pfl.fits | pixel to pixel flat field file name |
99 | DFLTFILE | N/A | delta flat field file name |
100 | LFLTFILE | N/A | low order flat |
101 | PHOTTAB | N/A | Photometric throughput table |
102 | GRAPHTAB | mtab$v9n1603mm_tmg.fits | the HST graph table |
103 | COMPTAB | mtab$vb71653dm_tmc.fits | the HST components table |
104 | IDCTAB | jref$v8q1444tj_idc.fits | image distortion correction table |
105 | DGEOFILE | jref$qbu16424j_dxy.fits | Distortion correction image |
106 | MDRIZTAB | jref$ub21537aj_mdz.fits | MultiDrizzle parameter table |
107 | CFLTFILE | N/A | Coronagraphic spot image |
108 | SPOTTAB | N/A | Coronagraphic spot offset table |
109 | IMPHTTAB | jref$vbb18107j_imp.fits | Image Photometry Table |
110 | MEANEXP | 0.0 | reference exposure time for parameters |
111 | SCALENSE | 0.0 | multiplicative scale factor applied to noise |
112 | INITGUES | initial guess method (MIN or MED) | |
113 | SKYSUB | sky value subtracted (MODE or NONE) | |
114 | SKYSUM | 0.0 | sky level from the sum of all constituent image |
115 | CRSIGMAS | statistical rejection criteria | |
116 | CRRADIUS | 0.0 | rejection propagation radius (pixels) |
117 | CRTHRESH | 0.0 | rejection propagation threshold |
118 | BADINPDQ | 0 | data quality flag bits to reject |
119 | REJ_RATE | 0.0 | rate at which pixels are affected by cosmic ray |
120 | CRMASK | False | flag CR-rejected pixels in input files (T/F) |
121 | MDRIZSKY | 32.08782958984375 | Sky value computed by MultiDrizzle |
122 | T_SGSTAR | N/A | OMS calculated guide star control |
123 | PATTERN1 | NONE | primary pattern type |
124 | P1_SHAPE | primary pattern shape | |
125 | P1_PURPS | primary pattern purpose | |
126 | P1_NPTS | 0 | number of points in primary pattern |
127 | P1_PSPAC | 0.0 | point spacing for primary pattern (arc-sec) |
128 | P1_LSPAC | 0.0 | line spacing for primary pattern (arc-sec) |
129 | P1_ANGLE | 0.0 | angle between sides of parallelogram patt (deg) |
130 | P1_FRAME | coordinate frame of primary pattern | |
131 | P1_ORINT | 0.0 | orientation of pattern to coordinate frame (deg |
132 | P1_CENTR | center pattern relative to pointing (yes/no) | |
133 | PATTSTEP | 0 | position number of this point in the pattern |
134 | FLASHDUR | 0.0 | Exposure time in seconds: 0.1 to 409.5 |
135 | FLASHCUR | OFF | Post flash current: OFF, LOW, MED, HIGH |
136 | FLASHSTA | NOT PERFORMED | Status: SUCCESSFUL, ABORTED, NOT PERFORMED |
137 | SHUTRPOS | A | Shutter position: A or B |
138 | CCDAMP | ABCD | CCD Amplifier Readout Configuration |
139 | CCDGAIN | 2.0 | commanded gain of CCD |
140 | CCDOFSTA | 1 | commanded CCD bias offset for amplifier A |
141 | CCDOFSTB | 1 | commanded CCD bias offset for amplifier B |
142 | CCDOFSTC | 1 | commanded CCD bias offset for amplifier C |
143 | CCDOFSTD | 1 | commanded CCD bias offset for amplifier D |
144 | ATODGNA | 2.02 | calibrated gain for amplifier A |
145 | ATODGNB | 1.886 | calibrated gain for amplifier B |
146 | ATODGNC | 2.017 | calibrated gain for amplifier C |
147 | ATODGND | 2.0109999 | calibrated gain for amplifier D |
148 | READNSEA | 4.5700002 | calibrated read noise for amplifier A |
149 | READNSEB | 3.9100001 | calibrated read noise for amplifier B |
150 | READNSEC | 4.25 | calibrated read noise for amplifier C |
151 | READNSED | 4.04 | calibrated read noise for amplifier D |
152 | BIASLEVA | 2088.5564 | bias level for amplifier A |
153 | BIASLEVB | 2140.5024 | bias level for amplifier B |
154 | BIASLEVC | 2208.7419 | bias level for amplifier C |
155 | BIASLEVD | 2296.7388 | bias level for amplifier D |
156 | ASN_ID | JBOA28010 | unique identifier assigned to association |
157 | ASN_TAB | jboa28010_asn.fits | name of the association table |
158 | ASN_MTYP | EXP-DTH | Role of the Member in the Association |
159 | BSTRCORR | COMPLETE | |
160 | PCTEFILE | jref$pctefile_101109.fits | |
161 | PCTETAB | jref$pctetab_pcte_20110913113559.fits | |
162 | PCTECORR | COMPLETE | |
163 | PCTEFRAC | 1.289367530158845 | |
164 | EXPNAME | jboa28wmq | exposure identifier |
165 | BUNIT | ELECTRONS | brightness units |
166 | CCDCHIP | 1 | CCD chip (1 or 2) |
167 | WCSAXES | 2 | Number of coordinate axes |
168 | LTV1 | 0.0 | offset in X to subsection start |
169 | LTV2 | 0.0 | offset in Y to subsection start |
170 | LTM1_1 | 1.0 | reciprocal of sampling rate in X |
171 | LTM2_2 | 1.0 | reciprocal of sampling rate in Y |
172 | ORIENTAT | -54.67632556350016 | position angle of image y axis (deg. e of n) |
173 | RA_APER | 150.1554086126 | RA of aperture reference position |
174 | DEC_APER | 2.270881608073 | Declination of aperture reference position |
175 | PA_APER | -54.4475 | Position Angle of reference aperture center (de |
176 | VAFACTOR | 1.000104465141 | velocity aberration plate scale factor |
177 | CENTERA1 | 2073 | subarray axis1 center pt in unbinned dect. pix |
178 | CENTERA2 | 1035 | subarray axis2 center pt in unbinned dect. pix |
179 | SIZAXIS1 | 4096 | subarray axis1 size in unbinned detector pixels |
180 | SIZAXIS2 | 2048 | subarray axis2 size in unbinned detector pixels |
181 | BINAXIS1 | 1 | axis1 data bin size in unbinned detector pixels |
182 | BINAXIS2 | 1 | axis2 data bin size in unbinned detector pixels |
183 | PHOTMODE | ACS WFC1 F606W MJD#55906.5481 | observation con |
184 | PHOTFLAM | 7.8624958e-20 | inverse sensitivity, ergs/cm2/Ang/electron |
185 | PHOTZPT | -21.1 | ST magnitude zero point |
186 | PHOTPLAM | 5921.1147 | Pivot wavelength (Angstroms) |
187 | PHOTBW | 672.23627 | RMS bandwidth of filter plus detector |
188 | NCOMBINE | 1 | number of image sets combined during CR rejecti |
189 | FILLCNT | 1 | number of segments containing fill |
190 | ERRCNT | 1 | number of segments containing errors |
191 | PODPSFF | False | podps fill present (T/F) |
192 | STDCFFF | True | science telemetry fill data present (T=1/F=0) |
193 | STDCFFP | 0x5569 | science telemetry fill pattern (hex) |
194 | WFCMPRSD | False | was WFC data compressed? (T/F) |
195 | CBLKSIZ | 0 | size of compression block in 2-byte words |
196 | LOSTPIX | 0 | #pixels lost due to buffer overflow |
197 | COMPTYP | None | compression type performed (Partial/Full/None) |
198 | NGOODPIX | 8097343 | number of good pixels |
199 | SDQFLAGS | 31743 | serious data quality flags |
200 | GOODMIN | -31.759687 | minimum value of good pixels |
201 | GOODMAX | 85606.719 | maximum value of good pixels |
202 | GOODMEAN | 35.94437 | mean value of good pixels |
203 | SOFTERRS | 0 | number of soft error pixels (DQF=1) |
204 | SNRMIN | -3.4609985 | minimum signal to noise of good pixels |
205 | SNRMAX | 233.93831 | maximum signal to noise of good pixels |
206 | SNRMEAN | 5.9348207 | mean value of signal to noise of good pixels |
207 | MEANDARK | 1.2713139 | average of the dark values subtracted |
208 | MEANBLEV | 2114.5295 | average of all bias levels subtracted |
209 | MEANFLSH | 0.0 | Mean number of counts in post flash exposure |
210 | ONAXIS2 | 2048 | Axis length |
211 | ONAXIS1 | 4096 | Axis length |
212 | OORIENTA | -54.64776336099293 | position angle of image y axis (deg. e of n) |
213 | OCTYPE1 | RA---TAN | the coordinate type for the first axis |
214 | OCTYPE2 | DEC--TAN | the coordinate type for the second axis |
215 | WCSCDATE | 13:02:32 (10/04/2012) | Time WCS keywords were copied. |
216 | A_0_2 | 2.26194120304176e-06 | |
217 | B_0_2 | -9.7985788387639e-06 | |
218 | A_1_1 | -7.5302905463753e-06 | |
219 | B_1_1 | 6.42569986264533e-06 | |
220 | A_2_0 | 8.51886870532632e-06 | |
221 | B_2_0 | -2.9658922285423e-06 | |
222 | A_0_3 | 6.51050854317125e-11 | |
223 | B_0_3 | -4.1421499542394e-10 | |
224 | A_1_2 | -5.2539201413375e-10 | |
225 | B_1_2 | -3.0354276197375e-11 | |
226 | A_2_1 | -1.0714004130419e-10 | |
227 | B_2_1 | -4.4034927976003e-10 | |
228 | A_3_0 | -4.6936360210189e-10 | |
229 | B_3_0 | 9.00334210115821e-11 | |
230 | A_0_4 | 1.35191449346299e-13 | |
231 | B_0_4 | -1.5248974790417e-13 | |
232 | A_1_3 | -1.4269338401366e-14 | |
233 | B_1_3 | 2.75911271664302e-14 | |
234 | A_2_2 | 9.70199603291834e-14 | |
235 | B_2_2 | -1.0403607372429e-13 | |
236 | A_3_1 | 3.80059786170717e-14 | |
237 | B_3_1 | -3.8363933112663e-14 | |
238 | A_4_0 | 1.83627862287182e-14 | |
239 | B_4_0 | -1.6913942054528e-14 | |
240 | A_ORDER | 4 | |
241 | B_ORDER | 4 | |
242 | IDCSCALE | 0.05 | |
243 | IDCV2REF | 261.1130981445312 | |
244 | IDCV3REF | 198.231201171875 | |
245 | IDCTHETA | 0.0 | |
246 | OCX10 | 0.002270935984783606 | |
247 | OCX11 | 0.04922343821974121 | |
248 | OCY10 | 0.0485839959198564 | |
249 | OCY11 | 0.00213603403929032 | |
250 | TDDALPHA | 0.2802605508521792 | |
251 | TDDBETA | -0.0907535169507264 | |
252 | SKYVAL | 32.5013968269 | |
253 | SKYRMS | 7.873235 | |
254 | QUADOFFA | 0.190616225 | |
255 | QUADOFFB | -0.660557125 | |
256 | QUADOFFC | 0.117621775 | |
257 | QUADOFFD | 0.352319125 | |
258 | NDRIZIM | 100 | Drizzle, number of images drizzled onto this ou |
259 | D001VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
260 | D001GEOM | Header WCS | Drizzle, source of geometric information |
261 | D001DATA | cos01_28_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
262 | D001DEXP | 275.0 | Drizzle, input image exposure time (s) |
263 | D001OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
264 | D001OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
265 | D001OUCO | Drizzle, output context image | |
266 | D001MASK | cos01_28_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
267 | D001WTSC | 583770.1 | Drizzle, weighting factor for input image |
268 | D001KERN | square | Drizzle, form of weight distribution kernel |
269 | D001PIXF | 0.8 | Drizzle, linear size of drop |
270 | D001COEF | cos01_28_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
271 | D001XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
272 | D001YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
273 | D001LAM | 555.0 | Drizzle, wavelength applied for transformation |
274 | D001EXKY | exptime | Drizzle, exposure keyword name in input image |
275 | D001INUN | counts | Drizzle, units of input image - counts or cps |
276 | D001OUUN | cps | Drizzle, units of output image - counts or cps |
277 | D001FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
278 | D001INXC | 2049.0 | Drizzle, reference center of input image (X) |
279 | D001INYC | 1025.0 | Drizzle, reference center of input image (Y) |
280 | D001OUXC | 7001.0 | Drizzle, reference center of output image (X) |
281 | D001OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
282 | D001SECP | False | Drizzle, there are no secondary geometric param |
283 | D002VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
284 | D002GEOM | Header WCS | Drizzle, source of geometric information |
285 | D002DATA | cos01_28_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
286 | D002DEXP | 707.0 | Drizzle, input image exposure time (s) |
287 | D002OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
288 | D002OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
289 | D002OUCO | Drizzle, output context image | |
290 | D002MASK | cos01_28_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
291 | D002WTSC | 3858213.0 | Drizzle, weighting factor for input image |
292 | D002KERN | square | Drizzle, form of weight distribution kernel |
293 | D002PIXF | 0.8 | Drizzle, linear size of drop |
294 | D002COEF | cos01_28_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
295 | D002XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
296 | D002YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
297 | D002LAM | 555.0 | Drizzle, wavelength applied for transformation |
298 | D002EXKY | exptime | Drizzle, exposure keyword name in input image |
299 | D002INUN | counts | Drizzle, units of input image - counts or cps |
300 | D002OUUN | cps | Drizzle, units of output image - counts or cps |
301 | D002FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
302 | D002INXC | 2049.0 | Drizzle, reference center of input image (X) |
303 | D002INYC | 1025.0 | Drizzle, reference center of input image (Y) |
304 | D002OUXC | 7001.0 | Drizzle, reference center of output image (X) |
305 | D002OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
306 | D002SECP | False | Drizzle, there are no secondary geometric param |
307 | D003VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
308 | D003GEOM | Header WCS | Drizzle, source of geometric information |
309 | D003DATA | cos01_29_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
310 | D003DEXP | 275.0 | Drizzle, input image exposure time (s) |
311 | D003OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
312 | D003OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
313 | D003OUCO | Drizzle, output context image | |
314 | D003MASK | cos01_29_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
315 | D003WTSC | 583802.2 | Drizzle, weighting factor for input image |
316 | D003KERN | square | Drizzle, form of weight distribution kernel |
317 | D003PIXF | 0.8 | Drizzle, linear size of drop |
318 | D003COEF | cos01_29_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
319 | D003XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
320 | D003YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
321 | D003LAM | 555.0 | Drizzle, wavelength applied for transformation |
322 | D003EXKY | exptime | Drizzle, exposure keyword name in input image |
323 | D003INUN | counts | Drizzle, units of input image - counts or cps |
324 | D003OUUN | cps | Drizzle, units of output image - counts or cps |
325 | D003FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
326 | D003INXC | 2049.0 | Drizzle, reference center of input image (X) |
327 | D003INYC | 1025.0 | Drizzle, reference center of input image (Y) |
328 | D003OUXC | 7001.0 | Drizzle, reference center of output image (X) |
329 | D003OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
330 | D003SECP | False | Drizzle, there are no secondary geometric param |
331 | D004VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
332 | D004GEOM | Header WCS | Drizzle, source of geometric information |
333 | D004DATA | cos01_29_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
334 | D004DEXP | 707.0 | Drizzle, input image exposure time (s) |
335 | D004OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
336 | D004OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
337 | D004OUCO | Drizzle, output context image | |
338 | D004MASK | cos01_29_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
339 | D004WTSC | 3858522.0 | Drizzle, weighting factor for input image |
340 | D004KERN | square | Drizzle, form of weight distribution kernel |
341 | D004PIXF | 0.8 | Drizzle, linear size of drop |
342 | D004COEF | cos01_29_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
343 | D004XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
344 | D004YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
345 | D004LAM | 555.0 | Drizzle, wavelength applied for transformation |
346 | D004EXKY | exptime | Drizzle, exposure keyword name in input image |
347 | D004INUN | counts | Drizzle, units of input image - counts or cps |
348 | D004OUUN | cps | Drizzle, units of output image - counts or cps |
349 | D004FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
350 | D004INXC | 2049.0 | Drizzle, reference center of input image (X) |
351 | D004INYC | 1025.0 | Drizzle, reference center of input image (Y) |
352 | D004OUXC | 7001.0 | Drizzle, reference center of output image (X) |
353 | D004OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
354 | D004SECP | False | Drizzle, there are no secondary geometric param |
355 | D005VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
356 | D005GEOM | Header WCS | Drizzle, source of geometric information |
357 | D005DATA | cos01_30_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
358 | D005DEXP | 275.0 | Drizzle, input image exposure time (s) |
359 | D005OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
360 | D005OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
361 | D005OUCO | Drizzle, output context image | |
362 | D005MASK | cos01_30_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
363 | D005WTSC | 583802.4 | Drizzle, weighting factor for input image |
364 | D005KERN | square | Drizzle, form of weight distribution kernel |
365 | D005PIXF | 0.8 | Drizzle, linear size of drop |
366 | D005COEF | cos01_30_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
367 | D005XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
368 | D005YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
369 | D005LAM | 555.0 | Drizzle, wavelength applied for transformation |
370 | D005EXKY | exptime | Drizzle, exposure keyword name in input image |
371 | D005INUN | counts | Drizzle, units of input image - counts or cps |
372 | D005OUUN | cps | Drizzle, units of output image - counts or cps |
373 | D005FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
374 | D005INXC | 2049.0 | Drizzle, reference center of input image (X) |
375 | D005INYC | 1025.0 | Drizzle, reference center of input image (Y) |
376 | D005OUXC | 7001.0 | Drizzle, reference center of output image (X) |
377 | D005OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
378 | D005SECP | False | Drizzle, there are no secondary geometric param |
379 | D006VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
380 | D006GEOM | Header WCS | Drizzle, source of geometric information |
381 | D006DATA | cos01_30_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
382 | D006DEXP | 707.0 | Drizzle, input image exposure time (s) |
383 | D006OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
384 | D006OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
385 | D006OUCO | Drizzle, output context image | |
386 | D006MASK | cos01_30_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
387 | D006WTSC | 3858522.0 | Drizzle, weighting factor for input image |
388 | D006KERN | square | Drizzle, form of weight distribution kernel |
389 | D006PIXF | 0.8 | Drizzle, linear size of drop |
390 | D006COEF | cos01_30_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
391 | D006XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
392 | D006YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
393 | D006LAM | 555.0 | Drizzle, wavelength applied for transformation |
394 | D006EXKY | exptime | Drizzle, exposure keyword name in input image |
395 | D006INUN | counts | Drizzle, units of input image - counts or cps |
396 | D006OUUN | cps | Drizzle, units of output image - counts or cps |
397 | D006FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
398 | D006INXC | 2049.0 | Drizzle, reference center of input image (X) |
399 | D006INYC | 1025.0 | Drizzle, reference center of input image (Y) |
400 | D006OUXC | 7001.0 | Drizzle, reference center of output image (X) |
401 | D006OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
402 | D006SECP | False | Drizzle, there are no secondary geometric param |
403 | D007VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
404 | D007GEOM | Header WCS | Drizzle, source of geometric information |
405 | D007DATA | cos01_32_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
406 | D007DEXP | 275.0 | Drizzle, input image exposure time (s) |
407 | D007OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
408 | D007OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
409 | D007OUCO | Drizzle, output context image | |
410 | D007MASK | cos01_32_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
411 | D007WTSC | 583801.9 | Drizzle, weighting factor for input image |
412 | D007KERN | square | Drizzle, form of weight distribution kernel |
413 | D007PIXF | 0.8 | Drizzle, linear size of drop |
414 | D007COEF | cos01_32_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
415 | D007XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
416 | D007YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
417 | D007LAM | 555.0 | Drizzle, wavelength applied for transformation |
418 | D007EXKY | exptime | Drizzle, exposure keyword name in input image |
419 | D007INUN | counts | Drizzle, units of input image - counts or cps |
420 | D007OUUN | cps | Drizzle, units of output image - counts or cps |
421 | D007FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
422 | D007INXC | 2049.0 | Drizzle, reference center of input image (X) |
423 | D007INYC | 1025.0 | Drizzle, reference center of input image (Y) |
424 | D007OUXC | 7001.0 | Drizzle, reference center of output image (X) |
425 | D007OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
426 | D007SECP | False | Drizzle, there are no secondary geometric param |
427 | D008VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
428 | D008GEOM | Header WCS | Drizzle, source of geometric information |
429 | D008DATA | cos01_32_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
430 | D008DEXP | 707.0 | Drizzle, input image exposure time (s) |
431 | D008OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
432 | D008OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
433 | D008OUCO | Drizzle, output context image | |
434 | D008MASK | cos01_32_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
435 | D008WTSC | 3858506.0 | Drizzle, weighting factor for input image |
436 | D008KERN | square | Drizzle, form of weight distribution kernel |
437 | D008PIXF | 0.8 | Drizzle, linear size of drop |
438 | D008COEF | cos01_32_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
439 | D008XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
440 | D008YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
441 | D008LAM | 555.0 | Drizzle, wavelength applied for transformation |
442 | D008EXKY | exptime | Drizzle, exposure keyword name in input image |
443 | D008INUN | counts | Drizzle, units of input image - counts or cps |
444 | D008OUUN | cps | Drizzle, units of output image - counts or cps |
445 | D008FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
446 | D008INXC | 2049.0 | Drizzle, reference center of input image (X) |
447 | D008INYC | 1025.0 | Drizzle, reference center of input image (Y) |
448 | D008OUXC | 7001.0 | Drizzle, reference center of output image (X) |
449 | D008OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
450 | D008SECP | False | Drizzle, there are no secondary geometric param |
451 | D009VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
452 | D009GEOM | Header WCS | Drizzle, source of geometric information |
453 | D009DATA | cos01_33_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
454 | D009DEXP | 275.0 | Drizzle, input image exposure time (s) |
455 | D009OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
456 | D009OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
457 | D009OUCO | Drizzle, output context image | |
458 | D009MASK | cos01_33_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
459 | D009WTSC | 583803.6 | Drizzle, weighting factor for input image |
460 | D009KERN | square | Drizzle, form of weight distribution kernel |
461 | D009PIXF | 0.8 | Drizzle, linear size of drop |
462 | D009COEF | cos01_33_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
463 | D009XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
464 | D009YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
465 | D009LAM | 555.0 | Drizzle, wavelength applied for transformation |
466 | D009EXKY | exptime | Drizzle, exposure keyword name in input image |
467 | D009INUN | counts | Drizzle, units of input image - counts or cps |
468 | D009OUUN | cps | Drizzle, units of output image - counts or cps |
469 | D009FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
470 | D009INXC | 2049.0 | Drizzle, reference center of input image (X) |
471 | D009INYC | 1025.0 | Drizzle, reference center of input image (Y) |
472 | D009OUXC | 7001.0 | Drizzle, reference center of output image (X) |
473 | D009OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
474 | D009SECP | False | Drizzle, there are no secondary geometric param |
475 | D010VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
476 | D010GEOM | Header WCS | Drizzle, source of geometric information |
477 | D010DATA | cos01_33_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
478 | D010DEXP | 275.0 | Drizzle, input image exposure time (s) |
479 | D010OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
480 | D010OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
481 | D010OUCO | Drizzle, output context image | |
482 | D010MASK | cos01_33_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
483 | D010WTSC | 583803.6 | Drizzle, weighting factor for input image |
484 | D010KERN | square | Drizzle, form of weight distribution kernel |
485 | D010PIXF | 0.8 | Drizzle, linear size of drop |
486 | D010COEF | cos01_33_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
487 | D010XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
488 | D010YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
489 | D010LAM | 555.0 | Drizzle, wavelength applied for transformation |
490 | D010EXKY | exptime | Drizzle, exposure keyword name in input image |
491 | D010INUN | counts | Drizzle, units of input image - counts or cps |
492 | D010OUUN | cps | Drizzle, units of output image - counts or cps |
493 | D010FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
494 | D010INXC | 2049.0 | Drizzle, reference center of input image (X) |
495 | D010INYC | 1025.0 | Drizzle, reference center of input image (Y) |
496 | D010OUXC | 7001.0 | Drizzle, reference center of output image (X) |
497 | D010OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
498 | D010SECP | False | Drizzle, there are no secondary geometric param |
499 | D011VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
500 | D011GEOM | Header WCS | Drizzle, source of geometric information |
501 | D011DATA | cos01_33_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
502 | D011DEXP | 707.0 | Drizzle, input image exposure time (s) |
503 | D011OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
504 | D011OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
505 | D011OUCO | Drizzle, output context image | |
506 | D011MASK | cos01_33_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
507 | D011WTSC | 3858528.0 | Drizzle, weighting factor for input image |
508 | D011KERN | square | Drizzle, form of weight distribution kernel |
509 | D011PIXF | 0.8 | Drizzle, linear size of drop |
510 | D011COEF | cos01_33_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
511 | D011XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
512 | D011YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
513 | D011LAM | 555.0 | Drizzle, wavelength applied for transformation |
514 | D011EXKY | exptime | Drizzle, exposure keyword name in input image |
515 | D011INUN | counts | Drizzle, units of input image - counts or cps |
516 | D011OUUN | cps | Drizzle, units of output image - counts or cps |
517 | D011FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
518 | D011INXC | 2049.0 | Drizzle, reference center of input image (X) |
519 | D011INYC | 1025.0 | Drizzle, reference center of input image (Y) |
520 | D011OUXC | 7001.0 | Drizzle, reference center of output image (X) |
521 | D011OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
522 | D011SECP | False | Drizzle, there are no secondary geometric param |
523 | D012VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
524 | D012GEOM | Header WCS | Drizzle, source of geometric information |
525 | D012DATA | cos01_33_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
526 | D012DEXP | 707.0 | Drizzle, input image exposure time (s) |
527 | D012OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
528 | D012OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
529 | D012OUCO | Drizzle, output context image | |
530 | D012MASK | cos01_33_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
531 | D012WTSC | 3858528.0 | Drizzle, weighting factor for input image |
532 | D012KERN | square | Drizzle, form of weight distribution kernel |
533 | D012PIXF | 0.8 | Drizzle, linear size of drop |
534 | D012COEF | cos01_33_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
535 | D012XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
536 | D012YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
537 | D012LAM | 555.0 | Drizzle, wavelength applied for transformation |
538 | D012EXKY | exptime | Drizzle, exposure keyword name in input image |
539 | D012INUN | counts | Drizzle, units of input image - counts or cps |
540 | D012OUUN | cps | Drizzle, units of output image - counts or cps |
541 | D012FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
542 | D012INXC | 2049.0 | Drizzle, reference center of input image (X) |
543 | D012INYC | 1025.0 | Drizzle, reference center of input image (Y) |
544 | D012OUXC | 7001.0 | Drizzle, reference center of output image (X) |
545 | D012OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
546 | D012SECP | False | Drizzle, there are no secondary geometric param |
547 | D013VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
548 | D013GEOM | Header WCS | Drizzle, source of geometric information |
549 | D013DATA | cos01_34_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
550 | D013DEXP | 275.0 | Drizzle, input image exposure time (s) |
551 | D013OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
552 | D013OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
553 | D013OUCO | Drizzle, output context image | |
554 | D013MASK | cos01_34_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
555 | D013WTSC | 583803.6 | Drizzle, weighting factor for input image |
556 | D013KERN | square | Drizzle, form of weight distribution kernel |
557 | D013PIXF | 0.8 | Drizzle, linear size of drop |
558 | D013COEF | cos01_34_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
559 | D013XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
560 | D013YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
561 | D013LAM | 555.0 | Drizzle, wavelength applied for transformation |
562 | D013EXKY | exptime | Drizzle, exposure keyword name in input image |
563 | D013INUN | counts | Drizzle, units of input image - counts or cps |
564 | D013OUUN | cps | Drizzle, units of output image - counts or cps |
565 | D013FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
566 | D013INXC | 2049.0 | Drizzle, reference center of input image (X) |
567 | D013INYC | 1025.0 | Drizzle, reference center of input image (Y) |
568 | D013OUXC | 7001.0 | Drizzle, reference center of output image (X) |
569 | D013OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
570 | D013SECP | False | Drizzle, there are no secondary geometric param |
571 | D014VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
572 | D014GEOM | Header WCS | Drizzle, source of geometric information |
573 | D014DATA | cos01_34_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
574 | D014DEXP | 275.0 | Drizzle, input image exposure time (s) |
575 | D014OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
576 | D014OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
577 | D014OUCO | Drizzle, output context image | |
578 | D014MASK | cos01_34_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
579 | D014WTSC | 583803.6 | Drizzle, weighting factor for input image |
580 | D014KERN | square | Drizzle, form of weight distribution kernel |
581 | D014PIXF | 0.8 | Drizzle, linear size of drop |
582 | D014COEF | cos01_34_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
583 | D014XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
584 | D014YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
585 | D014LAM | 555.0 | Drizzle, wavelength applied for transformation |
586 | D014EXKY | exptime | Drizzle, exposure keyword name in input image |
587 | D014INUN | counts | Drizzle, units of input image - counts or cps |
588 | D014OUUN | cps | Drizzle, units of output image - counts or cps |
589 | D014FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
590 | D014INXC | 2049.0 | Drizzle, reference center of input image (X) |
591 | D014INYC | 1025.0 | Drizzle, reference center of input image (Y) |
592 | D014OUXC | 7001.0 | Drizzle, reference center of output image (X) |
593 | D014OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
594 | D014SECP | False | Drizzle, there are no secondary geometric param |
595 | D015VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
596 | D015GEOM | Header WCS | Drizzle, source of geometric information |
597 | D015DATA | cos01_34_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
598 | D015DEXP | 707.0 | Drizzle, input image exposure time (s) |
599 | D015OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
600 | D015OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
601 | D015OUCO | Drizzle, output context image | |
602 | D015MASK | cos01_34_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
603 | D015WTSC | 3858529.0 | Drizzle, weighting factor for input image |
604 | D015KERN | square | Drizzle, form of weight distribution kernel |
605 | D015PIXF | 0.8 | Drizzle, linear size of drop |
606 | D015COEF | cos01_34_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
607 | D015XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
608 | D015YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
609 | D015LAM | 555.0 | Drizzle, wavelength applied for transformation |
610 | D015EXKY | exptime | Drizzle, exposure keyword name in input image |
611 | D015INUN | counts | Drizzle, units of input image - counts or cps |
612 | D015OUUN | cps | Drizzle, units of output image - counts or cps |
613 | D015FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
614 | D015INXC | 2049.0 | Drizzle, reference center of input image (X) |
615 | D015INYC | 1025.0 | Drizzle, reference center of input image (Y) |
616 | D015OUXC | 7001.0 | Drizzle, reference center of output image (X) |
617 | D015OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
618 | D015SECP | False | Drizzle, there are no secondary geometric param |
619 | D016VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
620 | D016GEOM | Header WCS | Drizzle, source of geometric information |
621 | D016DATA | cos01_34_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
622 | D016DEXP | 707.0 | Drizzle, input image exposure time (s) |
623 | D016OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
624 | D016OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
625 | D016OUCO | Drizzle, output context image | |
626 | D016MASK | cos01_34_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
627 | D016WTSC | 3858529.0 | Drizzle, weighting factor for input image |
628 | D016KERN | square | Drizzle, form of weight distribution kernel |
629 | D016PIXF | 0.8 | Drizzle, linear size of drop |
630 | D016COEF | cos01_34_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
631 | D016XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
632 | D016YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
633 | D016LAM | 555.0 | Drizzle, wavelength applied for transformation |
634 | D016EXKY | exptime | Drizzle, exposure keyword name in input image |
635 | D016INUN | counts | Drizzle, units of input image - counts or cps |
636 | D016OUUN | cps | Drizzle, units of output image - counts or cps |
637 | D016FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
638 | D016INXC | 2049.0 | Drizzle, reference center of input image (X) |
639 | D016INYC | 1025.0 | Drizzle, reference center of input image (Y) |
640 | D016OUXC | 7001.0 | Drizzle, reference center of output image (X) |
641 | D016OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
642 | D016SECP | False | Drizzle, there are no secondary geometric param |
643 | D017VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
644 | D017GEOM | Header WCS | Drizzle, source of geometric information |
645 | D017DATA | cos01_36_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
646 | D017DEXP | 275.0 | Drizzle, input image exposure time (s) |
647 | D017OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
648 | D017OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
649 | D017OUCO | Drizzle, output context image | |
650 | D017MASK | cos01_36_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
651 | D017WTSC | 583804.3 | Drizzle, weighting factor for input image |
652 | D017KERN | square | Drizzle, form of weight distribution kernel |
653 | D017PIXF | 0.8 | Drizzle, linear size of drop |
654 | D017COEF | cos01_36_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
655 | D017XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
656 | D017YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
657 | D017LAM | 555.0 | Drizzle, wavelength applied for transformation |
658 | D017EXKY | exptime | Drizzle, exposure keyword name in input image |
659 | D017INUN | counts | Drizzle, units of input image - counts or cps |
660 | D017OUUN | cps | Drizzle, units of output image - counts or cps |
661 | D017FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
662 | D017INXC | 2049.0 | Drizzle, reference center of input image (X) |
663 | D017INYC | 1025.0 | Drizzle, reference center of input image (Y) |
664 | D017OUXC | 7001.0 | Drizzle, reference center of output image (X) |
665 | D017OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
666 | D017SECP | False | Drizzle, there are no secondary geometric param |
667 | D018VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
668 | D018GEOM | Header WCS | Drizzle, source of geometric information |
669 | D018DATA | cos01_36_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
670 | D018DEXP | 707.0 | Drizzle, input image exposure time (s) |
671 | D018OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
672 | D018OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
673 | D018OUCO | Drizzle, output context image | |
674 | D018MASK | cos01_36_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
675 | D018WTSC | 3858532.0 | Drizzle, weighting factor for input image |
676 | D018KERN | square | Drizzle, form of weight distribution kernel |
677 | D018PIXF | 0.8 | Drizzle, linear size of drop |
678 | D018COEF | cos01_36_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
679 | D018XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
680 | D018YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
681 | D018LAM | 555.0 | Drizzle, wavelength applied for transformation |
682 | D018EXKY | exptime | Drizzle, exposure keyword name in input image |
683 | D018INUN | counts | Drizzle, units of input image - counts or cps |
684 | D018OUUN | cps | Drizzle, units of output image - counts or cps |
685 | D018FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
686 | D018INXC | 2049.0 | Drizzle, reference center of input image (X) |
687 | D018INYC | 1025.0 | Drizzle, reference center of input image (Y) |
688 | D018OUXC | 7001.0 | Drizzle, reference center of output image (X) |
689 | D018OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
690 | D018SECP | False | Drizzle, there are no secondary geometric param |
691 | D019VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
692 | D019GEOM | Header WCS | Drizzle, source of geometric information |
693 | D019DATA | cos01_37_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
694 | D019DEXP | 275.0 | Drizzle, input image exposure time (s) |
695 | D019OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
696 | D019OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
697 | D019OUCO | Drizzle, output context image | |
698 | D019MASK | cos01_37_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
699 | D019WTSC | 583796.7 | Drizzle, weighting factor for input image |
700 | D019KERN | square | Drizzle, form of weight distribution kernel |
701 | D019PIXF | 0.8 | Drizzle, linear size of drop |
702 | D019COEF | cos01_37_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
703 | D019XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
704 | D019YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
705 | D019LAM | 555.0 | Drizzle, wavelength applied for transformation |
706 | D019EXKY | exptime | Drizzle, exposure keyword name in input image |
707 | D019INUN | counts | Drizzle, units of input image - counts or cps |
708 | D019OUUN | cps | Drizzle, units of output image - counts or cps |
709 | D019FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
710 | D019INXC | 2049.0 | Drizzle, reference center of input image (X) |
711 | D019INYC | 1025.0 | Drizzle, reference center of input image (Y) |
712 | D019OUXC | 7001.0 | Drizzle, reference center of output image (X) |
713 | D019OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
714 | D019SECP | False | Drizzle, there are no secondary geometric param |
715 | D020VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
716 | D020GEOM | Header WCS | Drizzle, source of geometric information |
717 | D020DATA | cos01_37_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
718 | D020DEXP | 275.0 | Drizzle, input image exposure time (s) |
719 | D020OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
720 | D020OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
721 | D020OUCO | Drizzle, output context image | |
722 | D020MASK | cos01_37_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
723 | D020WTSC | 583796.7 | Drizzle, weighting factor for input image |
724 | D020KERN | square | Drizzle, form of weight distribution kernel |
725 | D020PIXF | 0.8 | Drizzle, linear size of drop |
726 | D020COEF | cos01_37_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
727 | D020XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
728 | D020YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
729 | D020LAM | 555.0 | Drizzle, wavelength applied for transformation |
730 | D020EXKY | exptime | Drizzle, exposure keyword name in input image |
731 | D020INUN | counts | Drizzle, units of input image - counts or cps |
732 | D020OUUN | cps | Drizzle, units of output image - counts or cps |
733 | D020FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
734 | D020INXC | 2049.0 | Drizzle, reference center of input image (X) |
735 | D020INYC | 1025.0 | Drizzle, reference center of input image (Y) |
736 | D020OUXC | 7001.0 | Drizzle, reference center of output image (X) |
737 | D020OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
738 | D020SECP | False | Drizzle, there are no secondary geometric param |
739 | D021VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
740 | D021GEOM | Header WCS | Drizzle, source of geometric information |
741 | D021DATA | cos01_37_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
742 | D021DEXP | 707.0 | Drizzle, input image exposure time (s) |
743 | D021OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
744 | D021OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
745 | D021OUCO | Drizzle, output context image | |
746 | D021MASK | cos01_37_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
747 | D021WTSC | 3858427.0 | Drizzle, weighting factor for input image |
748 | D021KERN | square | Drizzle, form of weight distribution kernel |
749 | D021PIXF | 0.8 | Drizzle, linear size of drop |
750 | D021COEF | cos01_37_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
751 | D021XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
752 | D021YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
753 | D021LAM | 555.0 | Drizzle, wavelength applied for transformation |
754 | D021EXKY | exptime | Drizzle, exposure keyword name in input image |
755 | D021INUN | counts | Drizzle, units of input image - counts or cps |
756 | D021OUUN | cps | Drizzle, units of output image - counts or cps |
757 | D021FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
758 | D021INXC | 2049.0 | Drizzle, reference center of input image (X) |
759 | D021INYC | 1025.0 | Drizzle, reference center of input image (Y) |
760 | D021OUXC | 7001.0 | Drizzle, reference center of output image (X) |
761 | D021OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
762 | D021SECP | False | Drizzle, there are no secondary geometric param |
763 | D022VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
764 | D022GEOM | Header WCS | Drizzle, source of geometric information |
765 | D022DATA | cos01_37_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
766 | D022DEXP | 707.0 | Drizzle, input image exposure time (s) |
767 | D022OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
768 | D022OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
769 | D022OUCO | Drizzle, output context image | |
770 | D022MASK | cos01_37_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
771 | D022WTSC | 3858427.0 | Drizzle, weighting factor for input image |
772 | D022KERN | square | Drizzle, form of weight distribution kernel |
773 | D022PIXF | 0.8 | Drizzle, linear size of drop |
774 | D022COEF | cos01_37_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
775 | D022XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
776 | D022YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
777 | D022LAM | 555.0 | Drizzle, wavelength applied for transformation |
778 | D022EXKY | exptime | Drizzle, exposure keyword name in input image |
779 | D022INUN | counts | Drizzle, units of input image - counts or cps |
780 | D022OUUN | cps | Drizzle, units of output image - counts or cps |
781 | D022FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
782 | D022INXC | 2049.0 | Drizzle, reference center of input image (X) |
783 | D022INYC | 1025.0 | Drizzle, reference center of input image (Y) |
784 | D022OUXC | 7001.0 | Drizzle, reference center of output image (X) |
785 | D022OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
786 | D022SECP | False | Drizzle, there are no secondary geometric param |
787 | D023VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
788 | D023GEOM | Header WCS | Drizzle, source of geometric information |
789 | D023DATA | cos01_38_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
790 | D023DEXP | 275.0 | Drizzle, input image exposure time (s) |
791 | D023OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
792 | D023OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
793 | D023OUCO | Drizzle, output context image | |
794 | D023MASK | cos01_38_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
795 | D023WTSC | 583805.7 | Drizzle, weighting factor for input image |
796 | D023KERN | square | Drizzle, form of weight distribution kernel |
797 | D023PIXF | 0.8 | Drizzle, linear size of drop |
798 | D023COEF | cos01_38_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
799 | D023XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
800 | D023YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
801 | D023LAM | 555.0 | Drizzle, wavelength applied for transformation |
802 | D023EXKY | exptime | Drizzle, exposure keyword name in input image |
803 | D023INUN | counts | Drizzle, units of input image - counts or cps |
804 | D023OUUN | cps | Drizzle, units of output image - counts or cps |
805 | D023FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
806 | D023INXC | 2049.0 | Drizzle, reference center of input image (X) |
807 | D023INYC | 1025.0 | Drizzle, reference center of input image (Y) |
808 | D023OUXC | 7001.0 | Drizzle, reference center of output image (X) |
809 | D023OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
810 | D023SECP | False | Drizzle, there are no secondary geometric param |
811 | D024VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
812 | D024GEOM | Header WCS | Drizzle, source of geometric information |
813 | D024DATA | cos01_38_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
814 | D024DEXP | 275.0 | Drizzle, input image exposure time (s) |
815 | D024OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
816 | D024OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
817 | D024OUCO | Drizzle, output context image | |
818 | D024MASK | cos01_38_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
819 | D024WTSC | 583805.7 | Drizzle, weighting factor for input image |
820 | D024KERN | square | Drizzle, form of weight distribution kernel |
821 | D024PIXF | 0.8 | Drizzle, linear size of drop |
822 | D024COEF | cos01_38_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
823 | D024XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
824 | D024YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
825 | D024LAM | 555.0 | Drizzle, wavelength applied for transformation |
826 | D024EXKY | exptime | Drizzle, exposure keyword name in input image |
827 | D024INUN | counts | Drizzle, units of input image - counts or cps |
828 | D024OUUN | cps | Drizzle, units of output image - counts or cps |
829 | D024FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
830 | D024INXC | 2049.0 | Drizzle, reference center of input image (X) |
831 | D024INYC | 1025.0 | Drizzle, reference center of input image (Y) |
832 | D024OUXC | 7001.0 | Drizzle, reference center of output image (X) |
833 | D024OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
834 | D024SECP | False | Drizzle, there are no secondary geometric param |
835 | D025VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
836 | D025GEOM | Header WCS | Drizzle, source of geometric information |
837 | D025DATA | cos01_38_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
838 | D025DEXP | 707.0 | Drizzle, input image exposure time (s) |
839 | D025OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
840 | D025OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
841 | D025OUCO | Drizzle, output context image | |
842 | D025MASK | cos01_38_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
843 | D025WTSC | 3858539.0 | Drizzle, weighting factor for input image |
844 | D025KERN | square | Drizzle, form of weight distribution kernel |
845 | D025PIXF | 0.8 | Drizzle, linear size of drop |
846 | D025COEF | cos01_38_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
847 | D025XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
848 | D025YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
849 | D025LAM | 555.0 | Drizzle, wavelength applied for transformation |
850 | D025EXKY | exptime | Drizzle, exposure keyword name in input image |
851 | D025INUN | counts | Drizzle, units of input image - counts or cps |
852 | D025OUUN | cps | Drizzle, units of output image - counts or cps |
853 | D025FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
854 | D025INXC | 2049.0 | Drizzle, reference center of input image (X) |
855 | D025INYC | 1025.0 | Drizzle, reference center of input image (Y) |
856 | D025OUXC | 7001.0 | Drizzle, reference center of output image (X) |
857 | D025OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
858 | D025SECP | False | Drizzle, there are no secondary geometric param |
859 | D026VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
860 | D026GEOM | Header WCS | Drizzle, source of geometric information |
861 | D026DATA | cos01_38_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
862 | D026DEXP | 707.0 | Drizzle, input image exposure time (s) |
863 | D026OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
864 | D026OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
865 | D026OUCO | Drizzle, output context image | |
866 | D026MASK | cos01_38_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
867 | D026WTSC | 3858539.0 | Drizzle, weighting factor for input image |
868 | D026KERN | square | Drizzle, form of weight distribution kernel |
869 | D026PIXF | 0.8 | Drizzle, linear size of drop |
870 | D026COEF | cos01_38_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
871 | D026XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
872 | D026YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
873 | D026LAM | 555.0 | Drizzle, wavelength applied for transformation |
874 | D026EXKY | exptime | Drizzle, exposure keyword name in input image |
875 | D026INUN | counts | Drizzle, units of input image - counts or cps |
876 | D026OUUN | cps | Drizzle, units of output image - counts or cps |
877 | D026FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
878 | D026INXC | 2049.0 | Drizzle, reference center of input image (X) |
879 | D026INYC | 1025.0 | Drizzle, reference center of input image (Y) |
880 | D026OUXC | 7001.0 | Drizzle, reference center of output image (X) |
881 | D026OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
882 | D026SECP | False | Drizzle, there are no secondary geometric param |
883 | D027VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
884 | D027GEOM | Header WCS | Drizzle, source of geometric information |
885 | D027DATA | cos01_40_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
886 | D027DEXP | 225.0 | Drizzle, input image exposure time (s) |
887 | D027OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
888 | D027OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
889 | D027OUCO | Drizzle, output context image | |
890 | D027MASK | cos01_40_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
891 | D027WTSC | 390803.6 | Drizzle, weighting factor for input image |
892 | D027KERN | square | Drizzle, form of weight distribution kernel |
893 | D027PIXF | 0.8 | Drizzle, linear size of drop |
894 | D027COEF | cos01_40_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
895 | D027XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
896 | D027YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
897 | D027LAM | 555.0 | Drizzle, wavelength applied for transformation |
898 | D027EXKY | exptime | Drizzle, exposure keyword name in input image |
899 | D027INUN | counts | Drizzle, units of input image - counts or cps |
900 | D027OUUN | cps | Drizzle, units of output image - counts or cps |
901 | D027FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
902 | D027INXC | 2049.0 | Drizzle, reference center of input image (X) |
903 | D027INYC | 1025.0 | Drizzle, reference center of input image (Y) |
904 | D027OUXC | 7001.0 | Drizzle, reference center of output image (X) |
905 | D027OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
906 | D027SECP | False | Drizzle, there are no secondary geometric param |
907 | D028VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
908 | D028GEOM | Header WCS | Drizzle, source of geometric information |
909 | D028DATA | cos01_40_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
910 | D028DEXP | 407.0 | Drizzle, input image exposure time (s) |
911 | D028OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
912 | D028OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
913 | D028OUCO | Drizzle, output context image | |
914 | D028MASK | cos01_40_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
915 | D028WTSC | 1278684.0 | Drizzle, weighting factor for input image |
916 | D028KERN | square | Drizzle, form of weight distribution kernel |
917 | D028PIXF | 0.8 | Drizzle, linear size of drop |
918 | D028COEF | cos01_40_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
919 | D028XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
920 | D028YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
921 | D028LAM | 555.0 | Drizzle, wavelength applied for transformation |
922 | D028EXKY | exptime | Drizzle, exposure keyword name in input image |
923 | D028INUN | counts | Drizzle, units of input image - counts or cps |
924 | D028OUUN | cps | Drizzle, units of output image - counts or cps |
925 | D028FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
926 | D028INXC | 2049.0 | Drizzle, reference center of input image (X) |
927 | D028INYC | 1025.0 | Drizzle, reference center of input image (Y) |
928 | D028OUXC | 7001.0 | Drizzle, reference center of output image (X) |
929 | D028OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
930 | D028SECP | False | Drizzle, there are no secondary geometric param |
931 | D029VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
932 | D029GEOM | Header WCS | Drizzle, source of geometric information |
933 | D029DATA | cos01_41_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
934 | D029DEXP | 225.0 | Drizzle, input image exposure time (s) |
935 | D029OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
936 | D029OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
937 | D029OUCO | Drizzle, output context image | |
938 | D029MASK | cos01_41_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
939 | D029WTSC | 390813.4 | Drizzle, weighting factor for input image |
940 | D029KERN | square | Drizzle, form of weight distribution kernel |
941 | D029PIXF | 0.8 | Drizzle, linear size of drop |
942 | D029COEF | cos01_41_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
943 | D029XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
944 | D029YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
945 | D029LAM | 555.0 | Drizzle, wavelength applied for transformation |
946 | D029EXKY | exptime | Drizzle, exposure keyword name in input image |
947 | D029INUN | counts | Drizzle, units of input image - counts or cps |
948 | D029OUUN | cps | Drizzle, units of output image - counts or cps |
949 | D029FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
950 | D029INXC | 2049.0 | Drizzle, reference center of input image (X) |
951 | D029INYC | 1025.0 | Drizzle, reference center of input image (Y) |
952 | D029OUXC | 7001.0 | Drizzle, reference center of output image (X) |
953 | D029OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
954 | D029SECP | False | Drizzle, there are no secondary geometric param |
955 | D030VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
956 | D030GEOM | Header WCS | Drizzle, source of geometric information |
957 | D030DATA | cos01_41_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
958 | D030DEXP | 225.0 | Drizzle, input image exposure time (s) |
959 | D030OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
960 | D030OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
961 | D030OUCO | Drizzle, output context image | |
962 | D030MASK | cos01_41_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
963 | D030WTSC | 390813.4 | Drizzle, weighting factor for input image |
964 | D030KERN | square | Drizzle, form of weight distribution kernel |
965 | D030PIXF | 0.8 | Drizzle, linear size of drop |
966 | D030COEF | cos01_41_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
967 | D030XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
968 | D030YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
969 | D030LAM | 555.0 | Drizzle, wavelength applied for transformation |
970 | D030EXKY | exptime | Drizzle, exposure keyword name in input image |
971 | D030INUN | counts | Drizzle, units of input image - counts or cps |
972 | D030OUUN | cps | Drizzle, units of output image - counts or cps |
973 | D030FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
974 | D030INXC | 2049.0 | Drizzle, reference center of input image (X) |
975 | D030INYC | 1025.0 | Drizzle, reference center of input image (Y) |
976 | D030OUXC | 7001.0 | Drizzle, reference center of output image (X) |
977 | D030OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
978 | D030SECP | False | Drizzle, there are no secondary geometric param |
979 | D031VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
980 | D031GEOM | Header WCS | Drizzle, source of geometric information |
981 | D031DATA | cos01_41_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
982 | D031DEXP | 407.0 | Drizzle, input image exposure time (s) |
983 | D031OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
984 | D031OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
985 | D031OUCO | Drizzle, output context image | |
986 | D031MASK | cos01_41_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
987 | D031WTSC | 1278740.0 | Drizzle, weighting factor for input image |
988 | D031KERN | square | Drizzle, form of weight distribution kernel |
989 | D031PIXF | 0.8 | Drizzle, linear size of drop |
990 | D031COEF | cos01_41_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
991 | D031XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
992 | D031YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
993 | D031LAM | 555.0 | Drizzle, wavelength applied for transformation |
994 | D031EXKY | exptime | Drizzle, exposure keyword name in input image |
995 | D031INUN | counts | Drizzle, units of input image - counts or cps |
996 | D031OUUN | cps | Drizzle, units of output image - counts or cps |
997 | D031FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
998 | D031INXC | 2049.0 | Drizzle, reference center of input image (X) |
999 | D031INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1000 | D031OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1001 | D031OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1002 | D031SECP | False | Drizzle, there are no secondary geometric param |
1003 | D032VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1004 | D032GEOM | Header WCS | Drizzle, source of geometric information |
1005 | D032DATA | cos01_41_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1006 | D032DEXP | 407.0 | Drizzle, input image exposure time (s) |
1007 | D032OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1008 | D032OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1009 | D032OUCO | Drizzle, output context image | |
1010 | D032MASK | cos01_41_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1011 | D032WTSC | 1278740.0 | Drizzle, weighting factor for input image |
1012 | D032KERN | square | Drizzle, form of weight distribution kernel |
1013 | D032PIXF | 0.8 | Drizzle, linear size of drop |
1014 | D032COEF | cos01_41_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1015 | D032XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1016 | D032YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1017 | D032LAM | 555.0 | Drizzle, wavelength applied for transformation |
1018 | D032EXKY | exptime | Drizzle, exposure keyword name in input image |
1019 | D032INUN | counts | Drizzle, units of input image - counts or cps |
1020 | D032OUUN | cps | Drizzle, units of output image - counts or cps |
1021 | D032FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1022 | D032INXC | 2049.0 | Drizzle, reference center of input image (X) |
1023 | D032INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1024 | D032OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1025 | D032OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1026 | D032SECP | False | Drizzle, there are no secondary geometric param |
1027 | D033VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1028 | D033GEOM | Header WCS | Drizzle, source of geometric information |
1029 | D033DATA | cos01_42_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
1030 | D033DEXP | 225.0 | Drizzle, input image exposure time (s) |
1031 | D033OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1032 | D033OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1033 | D033OUCO | Drizzle, output context image | |
1034 | D033MASK | cos01_42_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
1035 | D033WTSC | 390813.7 | Drizzle, weighting factor for input image |
1036 | D033KERN | square | Drizzle, form of weight distribution kernel |
1037 | D033PIXF | 0.8 | Drizzle, linear size of drop |
1038 | D033COEF | cos01_42_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
1039 | D033XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1040 | D033YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1041 | D033LAM | 555.0 | Drizzle, wavelength applied for transformation |
1042 | D033EXKY | exptime | Drizzle, exposure keyword name in input image |
1043 | D033INUN | counts | Drizzle, units of input image - counts or cps |
1044 | D033OUUN | cps | Drizzle, units of output image - counts or cps |
1045 | D033FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1046 | D033INXC | 2049.0 | Drizzle, reference center of input image (X) |
1047 | D033INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1048 | D033OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1049 | D033OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1050 | D033SECP | False | Drizzle, there are no secondary geometric param |
1051 | D034VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1052 | D034GEOM | Header WCS | Drizzle, source of geometric information |
1053 | D034DATA | cos01_42_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1054 | D034DEXP | 225.0 | Drizzle, input image exposure time (s) |
1055 | D034OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1056 | D034OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1057 | D034OUCO | Drizzle, output context image | |
1058 | D034MASK | cos01_42_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1059 | D034WTSC | 390813.7 | Drizzle, weighting factor for input image |
1060 | D034KERN | square | Drizzle, form of weight distribution kernel |
1061 | D034PIXF | 0.8 | Drizzle, linear size of drop |
1062 | D034COEF | cos01_42_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1063 | D034XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1064 | D034YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1065 | D034LAM | 555.0 | Drizzle, wavelength applied for transformation |
1066 | D034EXKY | exptime | Drizzle, exposure keyword name in input image |
1067 | D034INUN | counts | Drizzle, units of input image - counts or cps |
1068 | D034OUUN | cps | Drizzle, units of output image - counts or cps |
1069 | D034FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1070 | D034INXC | 2049.0 | Drizzle, reference center of input image (X) |
1071 | D034INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1072 | D034OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1073 | D034OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1074 | D034SECP | False | Drizzle, there are no secondary geometric param |
1075 | D035VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1076 | D035GEOM | Header WCS | Drizzle, source of geometric information |
1077 | D035DATA | cos01_42_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
1078 | D035DEXP | 407.0 | Drizzle, input image exposure time (s) |
1079 | D035OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1080 | D035OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1081 | D035OUCO | Drizzle, output context image | |
1082 | D035MASK | cos01_42_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
1083 | D035WTSC | 1278741.0 | Drizzle, weighting factor for input image |
1084 | D035KERN | square | Drizzle, form of weight distribution kernel |
1085 | D035PIXF | 0.8 | Drizzle, linear size of drop |
1086 | D035COEF | cos01_42_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
1087 | D035XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1088 | D035YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1089 | D035LAM | 555.0 | Drizzle, wavelength applied for transformation |
1090 | D035EXKY | exptime | Drizzle, exposure keyword name in input image |
1091 | D035INUN | counts | Drizzle, units of input image - counts or cps |
1092 | D035OUUN | cps | Drizzle, units of output image - counts or cps |
1093 | D035FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1094 | D035INXC | 2049.0 | Drizzle, reference center of input image (X) |
1095 | D035INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1096 | D035OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1097 | D035OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1098 | D035SECP | False | Drizzle, there are no secondary geometric param |
1099 | D036VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1100 | D036GEOM | Header WCS | Drizzle, source of geometric information |
1101 | D036DATA | cos01_42_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1102 | D036DEXP | 407.0 | Drizzle, input image exposure time (s) |
1103 | D036OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1104 | D036OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1105 | D036OUCO | Drizzle, output context image | |
1106 | D036MASK | cos01_42_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1107 | D036WTSC | 1278741.0 | Drizzle, weighting factor for input image |
1108 | D036KERN | square | Drizzle, form of weight distribution kernel |
1109 | D036PIXF | 0.8 | Drizzle, linear size of drop |
1110 | D036COEF | cos01_42_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1111 | D036XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1112 | D036YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1113 | D036LAM | 555.0 | Drizzle, wavelength applied for transformation |
1114 | D036EXKY | exptime | Drizzle, exposure keyword name in input image |
1115 | D036INUN | counts | Drizzle, units of input image - counts or cps |
1116 | D036OUUN | cps | Drizzle, units of output image - counts or cps |
1117 | D036FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1118 | D036INXC | 2049.0 | Drizzle, reference center of input image (X) |
1119 | D036INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1120 | D036OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1121 | D036OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1122 | D036SECP | False | Drizzle, there are no secondary geometric param |
1123 | D037VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1124 | D037GEOM | Header WCS | Drizzle, source of geometric information |
1125 | D037DATA | cos01_45_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
1126 | D037DEXP | 225.0 | Drizzle, input image exposure time (s) |
1127 | D037OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1128 | D037OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1129 | D037OUCO | Drizzle, output context image | |
1130 | D037MASK | cos01_45_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
1131 | D037WTSC | 390814.3 | Drizzle, weighting factor for input image |
1132 | D037KERN | square | Drizzle, form of weight distribution kernel |
1133 | D037PIXF | 0.8 | Drizzle, linear size of drop |
1134 | D037COEF | cos01_45_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
1135 | D037XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1136 | D037YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1137 | D037LAM | 555.0 | Drizzle, wavelength applied for transformation |
1138 | D037EXKY | exptime | Drizzle, exposure keyword name in input image |
1139 | D037INUN | counts | Drizzle, units of input image - counts or cps |
1140 | D037OUUN | cps | Drizzle, units of output image - counts or cps |
1141 | D037FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1142 | D037INXC | 2049.0 | Drizzle, reference center of input image (X) |
1143 | D037INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1144 | D037OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1145 | D037OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1146 | D037SECP | False | Drizzle, there are no secondary geometric param |
1147 | D038VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1148 | D038GEOM | Header WCS | Drizzle, source of geometric information |
1149 | D038DATA | cos01_45_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1150 | D038DEXP | 225.0 | Drizzle, input image exposure time (s) |
1151 | D038OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1152 | D038OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1153 | D038OUCO | Drizzle, output context image | |
1154 | D038MASK | cos01_45_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1155 | D038WTSC | 390814.3 | Drizzle, weighting factor for input image |
1156 | D038KERN | square | Drizzle, form of weight distribution kernel |
1157 | D038PIXF | 0.8 | Drizzle, linear size of drop |
1158 | D038COEF | cos01_45_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1159 | D038XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1160 | D038YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1161 | D038LAM | 555.0 | Drizzle, wavelength applied for transformation |
1162 | D038EXKY | exptime | Drizzle, exposure keyword name in input image |
1163 | D038INUN | counts | Drizzle, units of input image - counts or cps |
1164 | D038OUUN | cps | Drizzle, units of output image - counts or cps |
1165 | D038FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1166 | D038INXC | 2049.0 | Drizzle, reference center of input image (X) |
1167 | D038INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1168 | D038OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1169 | D038OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1170 | D038SECP | False | Drizzle, there are no secondary geometric param |
1171 | D039VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1172 | D039GEOM | Header WCS | Drizzle, source of geometric information |
1173 | D039DATA | cos01_45_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
1174 | D039DEXP | 407.0 | Drizzle, input image exposure time (s) |
1175 | D039OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1176 | D039OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1177 | D039OUCO | Drizzle, output context image | |
1178 | D039MASK | cos01_45_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
1179 | D039WTSC | 1278743.0 | Drizzle, weighting factor for input image |
1180 | D039KERN | square | Drizzle, form of weight distribution kernel |
1181 | D039PIXF | 0.8 | Drizzle, linear size of drop |
1182 | D039COEF | cos01_45_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
1183 | D039XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1184 | D039YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1185 | D039LAM | 555.0 | Drizzle, wavelength applied for transformation |
1186 | D039EXKY | exptime | Drizzle, exposure keyword name in input image |
1187 | D039INUN | counts | Drizzle, units of input image - counts or cps |
1188 | D039OUUN | cps | Drizzle, units of output image - counts or cps |
1189 | D039FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1190 | D039INXC | 2049.0 | Drizzle, reference center of input image (X) |
1191 | D039INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1192 | D039OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1193 | D039OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1194 | D039SECP | False | Drizzle, there are no secondary geometric param |
1195 | D040VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1196 | D040GEOM | Header WCS | Drizzle, source of geometric information |
1197 | D040DATA | cos01_45_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1198 | D040DEXP | 407.0 | Drizzle, input image exposure time (s) |
1199 | D040OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1200 | D040OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1201 | D040OUCO | Drizzle, output context image | |
1202 | D040MASK | cos01_45_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1203 | D040WTSC | 1278743.0 | Drizzle, weighting factor for input image |
1204 | D040KERN | square | Drizzle, form of weight distribution kernel |
1205 | D040PIXF | 0.8 | Drizzle, linear size of drop |
1206 | D040COEF | cos01_45_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1207 | D040XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1208 | D040YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1209 | D040LAM | 555.0 | Drizzle, wavelength applied for transformation |
1210 | D040EXKY | exptime | Drizzle, exposure keyword name in input image |
1211 | D040INUN | counts | Drizzle, units of input image - counts or cps |
1212 | D040OUUN | cps | Drizzle, units of output image - counts or cps |
1213 | D040FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1214 | D040INXC | 2049.0 | Drizzle, reference center of input image (X) |
1215 | D040INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1216 | D040OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1217 | D040OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1218 | D040SECP | False | Drizzle, there are no secondary geometric param |
1219 | D041VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1220 | D041GEOM | Header WCS | Drizzle, source of geometric information |
1221 | D041DATA | cos01_46_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
1222 | D041DEXP | 225.0 | Drizzle, input image exposure time (s) |
1223 | D041OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1224 | D041OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1225 | D041OUCO | Drizzle, output context image | |
1226 | D041MASK | cos01_46_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
1227 | D041WTSC | 390814.0 | Drizzle, weighting factor for input image |
1228 | D041KERN | square | Drizzle, form of weight distribution kernel |
1229 | D041PIXF | 0.8 | Drizzle, linear size of drop |
1230 | D041COEF | cos01_46_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
1231 | D041XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1232 | D041YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1233 | D041LAM | 555.0 | Drizzle, wavelength applied for transformation |
1234 | D041EXKY | exptime | Drizzle, exposure keyword name in input image |
1235 | D041INUN | counts | Drizzle, units of input image - counts or cps |
1236 | D041OUUN | cps | Drizzle, units of output image - counts or cps |
1237 | D041FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1238 | D041INXC | 2049.0 | Drizzle, reference center of input image (X) |
1239 | D041INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1240 | D041OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1241 | D041OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1242 | D041SECP | False | Drizzle, there are no secondary geometric param |
1243 | D042VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1244 | D042GEOM | Header WCS | Drizzle, source of geometric information |
1245 | D042DATA | cos01_46_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1246 | D042DEXP | 225.0 | Drizzle, input image exposure time (s) |
1247 | D042OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1248 | D042OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1249 | D042OUCO | Drizzle, output context image | |
1250 | D042MASK | cos01_46_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1251 | D042WTSC | 390814.0 | Drizzle, weighting factor for input image |
1252 | D042KERN | square | Drizzle, form of weight distribution kernel |
1253 | D042PIXF | 0.8 | Drizzle, linear size of drop |
1254 | D042COEF | cos01_46_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1255 | D042XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1256 | D042YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1257 | D042LAM | 555.0 | Drizzle, wavelength applied for transformation |
1258 | D042EXKY | exptime | Drizzle, exposure keyword name in input image |
1259 | D042INUN | counts | Drizzle, units of input image - counts or cps |
1260 | D042OUUN | cps | Drizzle, units of output image - counts or cps |
1261 | D042FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1262 | D042INXC | 2049.0 | Drizzle, reference center of input image (X) |
1263 | D042INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1264 | D042OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1265 | D042OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1266 | D042SECP | False | Drizzle, there are no secondary geometric param |
1267 | D043VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1268 | D043GEOM | Header WCS | Drizzle, source of geometric information |
1269 | D043DATA | cos01_46_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
1270 | D043DEXP | 407.0 | Drizzle, input image exposure time (s) |
1271 | D043OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1272 | D043OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1273 | D043OUCO | Drizzle, output context image | |
1274 | D043MASK | cos01_46_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
1275 | D043WTSC | 1278739.0 | Drizzle, weighting factor for input image |
1276 | D043KERN | square | Drizzle, form of weight distribution kernel |
1277 | D043PIXF | 0.8 | Drizzle, linear size of drop |
1278 | D043COEF | cos01_46_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
1279 | D043XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1280 | D043YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1281 | D043LAM | 555.0 | Drizzle, wavelength applied for transformation |
1282 | D043EXKY | exptime | Drizzle, exposure keyword name in input image |
1283 | D043INUN | counts | Drizzle, units of input image - counts or cps |
1284 | D043OUUN | cps | Drizzle, units of output image - counts or cps |
1285 | D043FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1286 | D043INXC | 2049.0 | Drizzle, reference center of input image (X) |
1287 | D043INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1288 | D043OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1289 | D043OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1290 | D043SECP | False | Drizzle, there are no secondary geometric param |
1291 | D044VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1292 | D044GEOM | Header WCS | Drizzle, source of geometric information |
1293 | D044DATA | cos01_46_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1294 | D044DEXP | 407.0 | Drizzle, input image exposure time (s) |
1295 | D044OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1296 | D044OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1297 | D044OUCO | Drizzle, output context image | |
1298 | D044MASK | cos01_46_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1299 | D044WTSC | 1278739.0 | Drizzle, weighting factor for input image |
1300 | D044KERN | square | Drizzle, form of weight distribution kernel |
1301 | D044PIXF | 0.8 | Drizzle, linear size of drop |
1302 | D044COEF | cos01_46_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1303 | D044XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1304 | D044YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1305 | D044LAM | 555.0 | Drizzle, wavelength applied for transformation |
1306 | D044EXKY | exptime | Drizzle, exposure keyword name in input image |
1307 | D044INUN | counts | Drizzle, units of input image - counts or cps |
1308 | D044OUUN | cps | Drizzle, units of output image - counts or cps |
1309 | D044FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1310 | D044INXC | 2049.0 | Drizzle, reference center of input image (X) |
1311 | D044INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1312 | D044OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1313 | D044OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1314 | D044SECP | False | Drizzle, there are no secondary geometric param |
1315 | D045VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1316 | D045GEOM | Header WCS | Drizzle, source of geometric information |
1317 | D045DATA | cos01_49_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
1318 | D045DEXP | 225.0 | Drizzle, input image exposure time (s) |
1319 | D045OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1320 | D045OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1321 | D045OUCO | Drizzle, output context image | |
1322 | D045MASK | cos01_49_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
1323 | D045WTSC | 390814.1 | Drizzle, weighting factor for input image |
1324 | D045KERN | square | Drizzle, form of weight distribution kernel |
1325 | D045PIXF | 0.8 | Drizzle, linear size of drop |
1326 | D045COEF | cos01_49_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
1327 | D045XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1328 | D045YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1329 | D045LAM | 555.0 | Drizzle, wavelength applied for transformation |
1330 | D045EXKY | exptime | Drizzle, exposure keyword name in input image |
1331 | D045INUN | counts | Drizzle, units of input image - counts or cps |
1332 | D045OUUN | cps | Drizzle, units of output image - counts or cps |
1333 | D045FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1334 | D045INXC | 2049.0 | Drizzle, reference center of input image (X) |
1335 | D045INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1336 | D045OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1337 | D045OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1338 | D045SECP | False | Drizzle, there are no secondary geometric param |
1339 | D046VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1340 | D046GEOM | Header WCS | Drizzle, source of geometric information |
1341 | D046DATA | cos01_49_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
1342 | D046DEXP | 407.0 | Drizzle, input image exposure time (s) |
1343 | D046OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1344 | D046OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1345 | D046OUCO | Drizzle, output context image | |
1346 | D046MASK | cos01_49_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
1347 | D046WTSC | 1278740.0 | Drizzle, weighting factor for input image |
1348 | D046KERN | square | Drizzle, form of weight distribution kernel |
1349 | D046PIXF | 0.8 | Drizzle, linear size of drop |
1350 | D046COEF | cos01_49_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
1351 | D046XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1352 | D046YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1353 | D046LAM | 555.0 | Drizzle, wavelength applied for transformation |
1354 | D046EXKY | exptime | Drizzle, exposure keyword name in input image |
1355 | D046INUN | counts | Drizzle, units of input image - counts or cps |
1356 | D046OUUN | cps | Drizzle, units of output image - counts or cps |
1357 | D046FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1358 | D046INXC | 2049.0 | Drizzle, reference center of input image (X) |
1359 | D046INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1360 | D046OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1361 | D046OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1362 | D046SECP | False | Drizzle, there are no secondary geometric param |
1363 | D047VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1364 | D047GEOM | Header WCS | Drizzle, source of geometric information |
1365 | D047DATA | cos01_50_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
1366 | D047DEXP | 225.0 | Drizzle, input image exposure time (s) |
1367 | D047OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1368 | D047OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1369 | D047OUCO | Drizzle, output context image | |
1370 | D047MASK | cos01_50_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
1371 | D047WTSC | 390814.2 | Drizzle, weighting factor for input image |
1372 | D047KERN | square | Drizzle, form of weight distribution kernel |
1373 | D047PIXF | 0.8 | Drizzle, linear size of drop |
1374 | D047COEF | cos01_50_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
1375 | D047XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1376 | D047YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1377 | D047LAM | 555.0 | Drizzle, wavelength applied for transformation |
1378 | D047EXKY | exptime | Drizzle, exposure keyword name in input image |
1379 | D047INUN | counts | Drizzle, units of input image - counts or cps |
1380 | D047OUUN | cps | Drizzle, units of output image - counts or cps |
1381 | D047FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1382 | D047INXC | 2049.0 | Drizzle, reference center of input image (X) |
1383 | D047INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1384 | D047OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1385 | D047OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1386 | D047SECP | False | Drizzle, there are no secondary geometric param |
1387 | D048VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1388 | D048GEOM | Header WCS | Drizzle, source of geometric information |
1389 | D048DATA | cos01_50_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1390 | D048DEXP | 225.0 | Drizzle, input image exposure time (s) |
1391 | D048OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1392 | D048OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1393 | D048OUCO | Drizzle, output context image | |
1394 | D048MASK | cos01_50_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1395 | D048WTSC | 390814.2 | Drizzle, weighting factor for input image |
1396 | D048KERN | square | Drizzle, form of weight distribution kernel |
1397 | D048PIXF | 0.8 | Drizzle, linear size of drop |
1398 | D048COEF | cos01_50_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1399 | D048XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1400 | D048YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1401 | D048LAM | 555.0 | Drizzle, wavelength applied for transformation |
1402 | D048EXKY | exptime | Drizzle, exposure keyword name in input image |
1403 | D048INUN | counts | Drizzle, units of input image - counts or cps |
1404 | D048OUUN | cps | Drizzle, units of output image - counts or cps |
1405 | D048FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1406 | D048INXC | 2049.0 | Drizzle, reference center of input image (X) |
1407 | D048INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1408 | D048OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1409 | D048OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1410 | D048SECP | False | Drizzle, there are no secondary geometric param |
1411 | D049VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1412 | D049GEOM | Header WCS | Drizzle, source of geometric information |
1413 | D049DATA | cos01_50_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
1414 | D049DEXP | 407.0 | Drizzle, input image exposure time (s) |
1415 | D049OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1416 | D049OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1417 | D049OUCO | Drizzle, output context image | |
1418 | D049MASK | cos01_50_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
1419 | D049WTSC | 1278740.0 | Drizzle, weighting factor for input image |
1420 | D049KERN | square | Drizzle, form of weight distribution kernel |
1421 | D049PIXF | 0.8 | Drizzle, linear size of drop |
1422 | D049COEF | cos01_50_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
1423 | D049XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1424 | D049YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1425 | D049LAM | 555.0 | Drizzle, wavelength applied for transformation |
1426 | D049EXKY | exptime | Drizzle, exposure keyword name in input image |
1427 | D049INUN | counts | Drizzle, units of input image - counts or cps |
1428 | D049OUUN | cps | Drizzle, units of output image - counts or cps |
1429 | D049FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1430 | D049INXC | 2049.0 | Drizzle, reference center of input image (X) |
1431 | D049INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1432 | D049OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1433 | D049OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1434 | D049SECP | False | Drizzle, there are no secondary geometric param |
1435 | D050VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1436 | D050GEOM | Header WCS | Drizzle, source of geometric information |
1437 | D050DATA | cos01_50_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1438 | D050DEXP | 407.0 | Drizzle, input image exposure time (s) |
1439 | D050OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1440 | D050OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1441 | D050OUCO | Drizzle, output context image | |
1442 | D050MASK | cos01_50_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1443 | D050WTSC | 1278740.0 | Drizzle, weighting factor for input image |
1444 | D050KERN | square | Drizzle, form of weight distribution kernel |
1445 | D050PIXF | 0.8 | Drizzle, linear size of drop |
1446 | D050COEF | cos01_50_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1447 | D050XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1448 | D050YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1449 | D050LAM | 555.0 | Drizzle, wavelength applied for transformation |
1450 | D050EXKY | exptime | Drizzle, exposure keyword name in input image |
1451 | D050INUN | counts | Drizzle, units of input image - counts or cps |
1452 | D050OUUN | cps | Drizzle, units of output image - counts or cps |
1453 | D050FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1454 | D050INXC | 2049.0 | Drizzle, reference center of input image (X) |
1455 | D050INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1456 | D050OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1457 | D050OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1458 | D050SECP | False | Drizzle, there are no secondary geometric param |
1459 | D051VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1460 | D051GEOM | Header WCS | Drizzle, source of geometric information |
1461 | D051DATA | cos02_72_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1462 | D051DEXP | 275.0 | Drizzle, input image exposure time (s) |
1463 | D051OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1464 | D051OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1465 | D051OUCO | Drizzle, output context image | |
1466 | D051MASK | cos02_72_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1467 | D051WTSC | 583572.3 | Drizzle, weighting factor for input image |
1468 | D051KERN | square | Drizzle, form of weight distribution kernel |
1469 | D051PIXF | 0.8 | Drizzle, linear size of drop |
1470 | D051COEF | cos02_72_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1471 | D051XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1472 | D051YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1473 | D051LAM | 555.0 | Drizzle, wavelength applied for transformation |
1474 | D051EXKY | exptime | Drizzle, exposure keyword name in input image |
1475 | D051INUN | counts | Drizzle, units of input image - counts or cps |
1476 | D051OUUN | cps | Drizzle, units of output image - counts or cps |
1477 | D051FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1478 | D051INXC | 2049.0 | Drizzle, reference center of input image (X) |
1479 | D051INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1480 | D051OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1481 | D051OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1482 | D051SECP | False | Drizzle, there are no secondary geometric param |
1483 | D052VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1484 | D052GEOM | Header WCS | Drizzle, source of geometric information |
1485 | D052DATA | cos02_72_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1486 | D052DEXP | 407.0 | Drizzle, input image exposure time (s) |
1487 | D052OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1488 | D052OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1489 | D052OUCO | Drizzle, output context image | |
1490 | D052MASK | cos02_72_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1491 | D052WTSC | 1278505.0 | Drizzle, weighting factor for input image |
1492 | D052KERN | square | Drizzle, form of weight distribution kernel |
1493 | D052PIXF | 0.8 | Drizzle, linear size of drop |
1494 | D052COEF | cos02_72_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1495 | D052XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1496 | D052YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1497 | D052LAM | 555.0 | Drizzle, wavelength applied for transformation |
1498 | D052EXKY | exptime | Drizzle, exposure keyword name in input image |
1499 | D052INUN | counts | Drizzle, units of input image - counts or cps |
1500 | D052OUUN | cps | Drizzle, units of output image - counts or cps |
1501 | D052FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1502 | D052INXC | 2049.0 | Drizzle, reference center of input image (X) |
1503 | D052INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1504 | D052OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1505 | D052OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1506 | D052SECP | False | Drizzle, there are no secondary geometric param |
1507 | D053VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1508 | D053GEOM | Header WCS | Drizzle, source of geometric information |
1509 | D053DATA | cos02_73_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1510 | D053DEXP | 275.0 | Drizzle, input image exposure time (s) |
1511 | D053OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1512 | D053OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1513 | D053OUCO | Drizzle, output context image | |
1514 | D053MASK | cos02_73_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1515 | D053WTSC | 583662.8 | Drizzle, weighting factor for input image |
1516 | D053KERN | square | Drizzle, form of weight distribution kernel |
1517 | D053PIXF | 0.8 | Drizzle, linear size of drop |
1518 | D053COEF | cos02_73_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1519 | D053XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1520 | D053YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1521 | D053LAM | 555.0 | Drizzle, wavelength applied for transformation |
1522 | D053EXKY | exptime | Drizzle, exposure keyword name in input image |
1523 | D053INUN | counts | Drizzle, units of input image - counts or cps |
1524 | D053OUUN | cps | Drizzle, units of output image - counts or cps |
1525 | D053FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1526 | D053INXC | 2049.0 | Drizzle, reference center of input image (X) |
1527 | D053INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1528 | D053OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1529 | D053OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1530 | D053SECP | False | Drizzle, there are no secondary geometric param |
1531 | D054VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1532 | D054GEOM | Header WCS | Drizzle, source of geometric information |
1533 | D054DATA | cos02_73_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1534 | D054DEXP | 407.0 | Drizzle, input image exposure time (s) |
1535 | D054OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1536 | D054OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1537 | D054OUCO | Drizzle, output context image | |
1538 | D054MASK | cos02_73_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1539 | D054WTSC | 1278391.0 | Drizzle, weighting factor for input image |
1540 | D054KERN | square | Drizzle, form of weight distribution kernel |
1541 | D054PIXF | 0.8 | Drizzle, linear size of drop |
1542 | D054COEF | cos02_73_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1543 | D054XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1544 | D054YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1545 | D054LAM | 555.0 | Drizzle, wavelength applied for transformation |
1546 | D054EXKY | exptime | Drizzle, exposure keyword name in input image |
1547 | D054INUN | counts | Drizzle, units of input image - counts or cps |
1548 | D054OUUN | cps | Drizzle, units of output image - counts or cps |
1549 | D054FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1550 | D054INXC | 2049.0 | Drizzle, reference center of input image (X) |
1551 | D054INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1552 | D054OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1553 | D054OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1554 | D054SECP | False | Drizzle, there are no secondary geometric param |
1555 | D055VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1556 | D055GEOM | Header WCS | Drizzle, source of geometric information |
1557 | D055DATA | cos02_74_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1558 | D055DEXP | 275.0 | Drizzle, input image exposure time (s) |
1559 | D055OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1560 | D055OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1561 | D055OUCO | Drizzle, output context image | |
1562 | D055MASK | cos02_74_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1563 | D055WTSC | 583683.6 | Drizzle, weighting factor for input image |
1564 | D055KERN | square | Drizzle, form of weight distribution kernel |
1565 | D055PIXF | 0.8 | Drizzle, linear size of drop |
1566 | D055COEF | cos02_74_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1567 | D055XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1568 | D055YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1569 | D055LAM | 555.0 | Drizzle, wavelength applied for transformation |
1570 | D055EXKY | exptime | Drizzle, exposure keyword name in input image |
1571 | D055INUN | counts | Drizzle, units of input image - counts or cps |
1572 | D055OUUN | cps | Drizzle, units of output image - counts or cps |
1573 | D055FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1574 | D055INXC | 2049.0 | Drizzle, reference center of input image (X) |
1575 | D055INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1576 | D055OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1577 | D055OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1578 | D055SECP | False | Drizzle, there are no secondary geometric param |
1579 | D056VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1580 | D056GEOM | Header WCS | Drizzle, source of geometric information |
1581 | D056DATA | cos02_74_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1582 | D056DEXP | 407.0 | Drizzle, input image exposure time (s) |
1583 | D056OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1584 | D056OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1585 | D056OUCO | Drizzle, output context image | |
1586 | D056MASK | cos02_74_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1587 | D056WTSC | 1278462.0 | Drizzle, weighting factor for input image |
1588 | D056KERN | square | Drizzle, form of weight distribution kernel |
1589 | D056PIXF | 0.8 | Drizzle, linear size of drop |
1590 | D056COEF | cos02_74_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1591 | D056XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1592 | D056YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1593 | D056LAM | 555.0 | Drizzle, wavelength applied for transformation |
1594 | D056EXKY | exptime | Drizzle, exposure keyword name in input image |
1595 | D056INUN | counts | Drizzle, units of input image - counts or cps |
1596 | D056OUUN | cps | Drizzle, units of output image - counts or cps |
1597 | D056FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1598 | D056INXC | 2049.0 | Drizzle, reference center of input image (X) |
1599 | D056INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1600 | D056OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1601 | D056OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1602 | D056SECP | False | Drizzle, there are no secondary geometric param |
1603 | D057VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1604 | D057GEOM | Header WCS | Drizzle, source of geometric information |
1605 | D057DATA | cos02_76_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1606 | D057DEXP | 275.0 | Drizzle, input image exposure time (s) |
1607 | D057OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1608 | D057OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1609 | D057OUCO | Drizzle, output context image | |
1610 | D057MASK | cos02_76_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1611 | D057WTSC | 583685.8 | Drizzle, weighting factor for input image |
1612 | D057KERN | square | Drizzle, form of weight distribution kernel |
1613 | D057PIXF | 0.8 | Drizzle, linear size of drop |
1614 | D057COEF | cos02_76_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1615 | D057XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1616 | D057YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1617 | D057LAM | 555.0 | Drizzle, wavelength applied for transformation |
1618 | D057EXKY | exptime | Drizzle, exposure keyword name in input image |
1619 | D057INUN | counts | Drizzle, units of input image - counts or cps |
1620 | D057OUUN | cps | Drizzle, units of output image - counts or cps |
1621 | D057FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1622 | D057INXC | 2049.0 | Drizzle, reference center of input image (X) |
1623 | D057INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1624 | D057OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1625 | D057OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1626 | D057SECP | False | Drizzle, there are no secondary geometric param |
1627 | D058VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1628 | D058GEOM | Header WCS | Drizzle, source of geometric information |
1629 | D058DATA | cos02_76_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1630 | D058DEXP | 407.0 | Drizzle, input image exposure time (s) |
1631 | D058OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1632 | D058OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1633 | D058OUCO | Drizzle, output context image | |
1634 | D058MASK | cos02_76_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1635 | D058WTSC | 1278469.0 | Drizzle, weighting factor for input image |
1636 | D058KERN | square | Drizzle, form of weight distribution kernel |
1637 | D058PIXF | 0.8 | Drizzle, linear size of drop |
1638 | D058COEF | cos02_76_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1639 | D058XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1640 | D058YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1641 | D058LAM | 555.0 | Drizzle, wavelength applied for transformation |
1642 | D058EXKY | exptime | Drizzle, exposure keyword name in input image |
1643 | D058INUN | counts | Drizzle, units of input image - counts or cps |
1644 | D058OUUN | cps | Drizzle, units of output image - counts or cps |
1645 | D058FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1646 | D058INXC | 2049.0 | Drizzle, reference center of input image (X) |
1647 | D058INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1648 | D058OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1649 | D058OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1650 | D058SECP | False | Drizzle, there are no secondary geometric param |
1651 | D059VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1652 | D059GEOM | Header WCS | Drizzle, source of geometric information |
1653 | D059DATA | cos02_77_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
1654 | D059DEXP | 275.0 | Drizzle, input image exposure time (s) |
1655 | D059OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1656 | D059OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1657 | D059OUCO | Drizzle, output context image | |
1658 | D059MASK | cos02_77_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
1659 | D059WTSC | 583685.2 | Drizzle, weighting factor for input image |
1660 | D059KERN | square | Drizzle, form of weight distribution kernel |
1661 | D059PIXF | 0.8 | Drizzle, linear size of drop |
1662 | D059COEF | cos02_77_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
1663 | D059XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1664 | D059YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1665 | D059LAM | 555.0 | Drizzle, wavelength applied for transformation |
1666 | D059EXKY | exptime | Drizzle, exposure keyword name in input image |
1667 | D059INUN | counts | Drizzle, units of input image - counts or cps |
1668 | D059OUUN | cps | Drizzle, units of output image - counts or cps |
1669 | D059FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1670 | D059INXC | 2049.0 | Drizzle, reference center of input image (X) |
1671 | D059INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1672 | D059OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1673 | D059OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1674 | D059SECP | False | Drizzle, there are no secondary geometric param |
1675 | D060VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1676 | D060GEOM | Header WCS | Drizzle, source of geometric information |
1677 | D060DATA | cos02_77_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1678 | D060DEXP | 275.0 | Drizzle, input image exposure time (s) |
1679 | D060OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1680 | D060OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1681 | D060OUCO | Drizzle, output context image | |
1682 | D060MASK | cos02_77_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1683 | D060WTSC | 583685.2 | Drizzle, weighting factor for input image |
1684 | D060KERN | square | Drizzle, form of weight distribution kernel |
1685 | D060PIXF | 0.8 | Drizzle, linear size of drop |
1686 | D060COEF | cos02_77_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1687 | D060XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1688 | D060YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1689 | D060LAM | 555.0 | Drizzle, wavelength applied for transformation |
1690 | D060EXKY | exptime | Drizzle, exposure keyword name in input image |
1691 | D060INUN | counts | Drizzle, units of input image - counts or cps |
1692 | D060OUUN | cps | Drizzle, units of output image - counts or cps |
1693 | D060FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1694 | D060INXC | 2049.0 | Drizzle, reference center of input image (X) |
1695 | D060INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1696 | D060OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1697 | D060OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1698 | D060SECP | False | Drizzle, there are no secondary geometric param |
1699 | D061VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1700 | D061GEOM | Header WCS | Drizzle, source of geometric information |
1701 | D061DATA | cos02_77_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
1702 | D061DEXP | 407.0 | Drizzle, input image exposure time (s) |
1703 | D061OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1704 | D061OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1705 | D061OUCO | Drizzle, output context image | |
1706 | D061MASK | cos02_77_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
1707 | D061WTSC | 1278466.0 | Drizzle, weighting factor for input image |
1708 | D061KERN | square | Drizzle, form of weight distribution kernel |
1709 | D061PIXF | 0.8 | Drizzle, linear size of drop |
1710 | D061COEF | cos02_77_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
1711 | D061XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1712 | D061YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1713 | D061LAM | 555.0 | Drizzle, wavelength applied for transformation |
1714 | D061EXKY | exptime | Drizzle, exposure keyword name in input image |
1715 | D061INUN | counts | Drizzle, units of input image - counts or cps |
1716 | D061OUUN | cps | Drizzle, units of output image - counts or cps |
1717 | D061FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1718 | D061INXC | 2049.0 | Drizzle, reference center of input image (X) |
1719 | D061INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1720 | D061OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1721 | D061OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1722 | D061SECP | False | Drizzle, there are no secondary geometric param |
1723 | D062VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1724 | D062GEOM | Header WCS | Drizzle, source of geometric information |
1725 | D062DATA | cos02_77_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1726 | D062DEXP | 407.0 | Drizzle, input image exposure time (s) |
1727 | D062OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1728 | D062OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1729 | D062OUCO | Drizzle, output context image | |
1730 | D062MASK | cos02_77_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1731 | D062WTSC | 1278466.0 | Drizzle, weighting factor for input image |
1732 | D062KERN | square | Drizzle, form of weight distribution kernel |
1733 | D062PIXF | 0.8 | Drizzle, linear size of drop |
1734 | D062COEF | cos02_77_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1735 | D062XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1736 | D062YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1737 | D062LAM | 555.0 | Drizzle, wavelength applied for transformation |
1738 | D062EXKY | exptime | Drizzle, exposure keyword name in input image |
1739 | D062INUN | counts | Drizzle, units of input image - counts or cps |
1740 | D062OUUN | cps | Drizzle, units of output image - counts or cps |
1741 | D062FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1742 | D062INXC | 2049.0 | Drizzle, reference center of input image (X) |
1743 | D062INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1744 | D062OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1745 | D062OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1746 | D062SECP | False | Drizzle, there are no secondary geometric param |
1747 | D063VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1748 | D063GEOM | Header WCS | Drizzle, source of geometric information |
1749 | D063DATA | cos02_78_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
1750 | D063DEXP | 275.0 | Drizzle, input image exposure time (s) |
1751 | D063OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1752 | D063OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1753 | D063OUCO | Drizzle, output context image | |
1754 | D063MASK | cos02_78_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
1755 | D063WTSC | 583685.3 | Drizzle, weighting factor for input image |
1756 | D063KERN | square | Drizzle, form of weight distribution kernel |
1757 | D063PIXF | 0.8 | Drizzle, linear size of drop |
1758 | D063COEF | cos02_78_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
1759 | D063XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1760 | D063YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1761 | D063LAM | 555.0 | Drizzle, wavelength applied for transformation |
1762 | D063EXKY | exptime | Drizzle, exposure keyword name in input image |
1763 | D063INUN | counts | Drizzle, units of input image - counts or cps |
1764 | D063OUUN | cps | Drizzle, units of output image - counts or cps |
1765 | D063FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1766 | D063INXC | 2049.0 | Drizzle, reference center of input image (X) |
1767 | D063INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1768 | D063OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1769 | D063OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1770 | D063SECP | False | Drizzle, there are no secondary geometric param |
1771 | D064VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1772 | D064GEOM | Header WCS | Drizzle, source of geometric information |
1773 | D064DATA | cos02_78_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1774 | D064DEXP | 275.0 | Drizzle, input image exposure time (s) |
1775 | D064OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1776 | D064OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1777 | D064OUCO | Drizzle, output context image | |
1778 | D064MASK | cos02_78_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1779 | D064WTSC | 583685.3 | Drizzle, weighting factor for input image |
1780 | D064KERN | square | Drizzle, form of weight distribution kernel |
1781 | D064PIXF | 0.8 | Drizzle, linear size of drop |
1782 | D064COEF | cos02_78_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1783 | D064XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1784 | D064YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1785 | D064LAM | 555.0 | Drizzle, wavelength applied for transformation |
1786 | D064EXKY | exptime | Drizzle, exposure keyword name in input image |
1787 | D064INUN | counts | Drizzle, units of input image - counts or cps |
1788 | D064OUUN | cps | Drizzle, units of output image - counts or cps |
1789 | D064FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1790 | D064INXC | 2049.0 | Drizzle, reference center of input image (X) |
1791 | D064INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1792 | D064OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1793 | D064OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1794 | D064SECP | False | Drizzle, there are no secondary geometric param |
1795 | D065VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1796 | D065GEOM | Header WCS | Drizzle, source of geometric information |
1797 | D065DATA | cos02_78_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
1798 | D065DEXP | 407.0 | Drizzle, input image exposure time (s) |
1799 | D065OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1800 | D065OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1801 | D065OUCO | Drizzle, output context image | |
1802 | D065MASK | cos02_78_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
1803 | D065WTSC | 1278466.0 | Drizzle, weighting factor for input image |
1804 | D065KERN | square | Drizzle, form of weight distribution kernel |
1805 | D065PIXF | 0.8 | Drizzle, linear size of drop |
1806 | D065COEF | cos02_78_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
1807 | D065XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1808 | D065YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1809 | D065LAM | 555.0 | Drizzle, wavelength applied for transformation |
1810 | D065EXKY | exptime | Drizzle, exposure keyword name in input image |
1811 | D065INUN | counts | Drizzle, units of input image - counts or cps |
1812 | D065OUUN | cps | Drizzle, units of output image - counts or cps |
1813 | D065FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1814 | D065INXC | 2049.0 | Drizzle, reference center of input image (X) |
1815 | D065INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1816 | D065OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1817 | D065OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1818 | D065SECP | False | Drizzle, there are no secondary geometric param |
1819 | D066VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1820 | D066GEOM | Header WCS | Drizzle, source of geometric information |
1821 | D066DATA | cos02_78_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1822 | D066DEXP | 407.0 | Drizzle, input image exposure time (s) |
1823 | D066OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1824 | D066OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1825 | D066OUCO | Drizzle, output context image | |
1826 | D066MASK | cos02_78_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1827 | D066WTSC | 1278466.0 | Drizzle, weighting factor for input image |
1828 | D066KERN | square | Drizzle, form of weight distribution kernel |
1829 | D066PIXF | 0.8 | Drizzle, linear size of drop |
1830 | D066COEF | cos02_78_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1831 | D066XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1832 | D066YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1833 | D066LAM | 555.0 | Drizzle, wavelength applied for transformation |
1834 | D066EXKY | exptime | Drizzle, exposure keyword name in input image |
1835 | D066INUN | counts | Drizzle, units of input image - counts or cps |
1836 | D066OUUN | cps | Drizzle, units of output image - counts or cps |
1837 | D066FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1838 | D066INXC | 2049.0 | Drizzle, reference center of input image (X) |
1839 | D066INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1840 | D066OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1841 | D066OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1842 | D066SECP | False | Drizzle, there are no secondary geometric param |
1843 | D067VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1844 | D067GEOM | Header WCS | Drizzle, source of geometric information |
1845 | D067DATA | cos02_80_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1846 | D067DEXP | 275.0 | Drizzle, input image exposure time (s) |
1847 | D067OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1848 | D067OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1849 | D067OUCO | Drizzle, output context image | |
1850 | D067MASK | cos02_80_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1851 | D067WTSC | 583685.9 | Drizzle, weighting factor for input image |
1852 | D067KERN | square | Drizzle, form of weight distribution kernel |
1853 | D067PIXF | 0.8 | Drizzle, linear size of drop |
1854 | D067COEF | cos02_80_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1855 | D067XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1856 | D067YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1857 | D067LAM | 555.0 | Drizzle, wavelength applied for transformation |
1858 | D067EXKY | exptime | Drizzle, exposure keyword name in input image |
1859 | D067INUN | counts | Drizzle, units of input image - counts or cps |
1860 | D067OUUN | cps | Drizzle, units of output image - counts or cps |
1861 | D067FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1862 | D067INXC | 2049.0 | Drizzle, reference center of input image (X) |
1863 | D067INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1864 | D067OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1865 | D067OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1866 | D067SECP | False | Drizzle, there are no secondary geometric param |
1867 | D068VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1868 | D068GEOM | Header WCS | Drizzle, source of geometric information |
1869 | D068DATA | cos02_80_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1870 | D068DEXP | 407.0 | Drizzle, input image exposure time (s) |
1871 | D068OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1872 | D068OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1873 | D068OUCO | Drizzle, output context image | |
1874 | D068MASK | cos02_80_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1875 | D068WTSC | 1278468.0 | Drizzle, weighting factor for input image |
1876 | D068KERN | square | Drizzle, form of weight distribution kernel |
1877 | D068PIXF | 0.8 | Drizzle, linear size of drop |
1878 | D068COEF | cos02_80_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1879 | D068XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1880 | D068YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1881 | D068LAM | 555.0 | Drizzle, wavelength applied for transformation |
1882 | D068EXKY | exptime | Drizzle, exposure keyword name in input image |
1883 | D068INUN | counts | Drizzle, units of input image - counts or cps |
1884 | D068OUUN | cps | Drizzle, units of output image - counts or cps |
1885 | D068FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1886 | D068INXC | 2049.0 | Drizzle, reference center of input image (X) |
1887 | D068INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1888 | D068OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1889 | D068OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1890 | D068SECP | False | Drizzle, there are no secondary geometric param |
1891 | D069VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1892 | D069GEOM | Header WCS | Drizzle, source of geometric information |
1893 | D069DATA | cos02_81_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
1894 | D069DEXP | 275.0 | Drizzle, input image exposure time (s) |
1895 | D069OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1896 | D069OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1897 | D069OUCO | Drizzle, output context image | |
1898 | D069MASK | cos02_81_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
1899 | D069WTSC | 583576.4 | Drizzle, weighting factor for input image |
1900 | D069KERN | square | Drizzle, form of weight distribution kernel |
1901 | D069PIXF | 0.8 | Drizzle, linear size of drop |
1902 | D069COEF | cos02_81_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
1903 | D069XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1904 | D069YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1905 | D069LAM | 555.0 | Drizzle, wavelength applied for transformation |
1906 | D069EXKY | exptime | Drizzle, exposure keyword name in input image |
1907 | D069INUN | counts | Drizzle, units of input image - counts or cps |
1908 | D069OUUN | cps | Drizzle, units of output image - counts or cps |
1909 | D069FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1910 | D069INXC | 2049.0 | Drizzle, reference center of input image (X) |
1911 | D069INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1912 | D069OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1913 | D069OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1914 | D069SECP | False | Drizzle, there are no secondary geometric param |
1915 | D070VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1916 | D070GEOM | Header WCS | Drizzle, source of geometric information |
1917 | D070DATA | cos02_81_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1918 | D070DEXP | 275.0 | Drizzle, input image exposure time (s) |
1919 | D070OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1920 | D070OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1921 | D070OUCO | Drizzle, output context image | |
1922 | D070MASK | cos02_81_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1923 | D070WTSC | 583576.4 | Drizzle, weighting factor for input image |
1924 | D070KERN | square | Drizzle, form of weight distribution kernel |
1925 | D070PIXF | 0.8 | Drizzle, linear size of drop |
1926 | D070COEF | cos02_81_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1927 | D070XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1928 | D070YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1929 | D070LAM | 555.0 | Drizzle, wavelength applied for transformation |
1930 | D070EXKY | exptime | Drizzle, exposure keyword name in input image |
1931 | D070INUN | counts | Drizzle, units of input image - counts or cps |
1932 | D070OUUN | cps | Drizzle, units of output image - counts or cps |
1933 | D070FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1934 | D070INXC | 2049.0 | Drizzle, reference center of input image (X) |
1935 | D070INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1936 | D070OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1937 | D070OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1938 | D070SECP | False | Drizzle, there are no secondary geometric param |
1939 | D071VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1940 | D071GEOM | Header WCS | Drizzle, source of geometric information |
1941 | D071DATA | cos02_81_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
1942 | D071DEXP | 407.0 | Drizzle, input image exposure time (s) |
1943 | D071OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1944 | D071OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1945 | D071OUCO | Drizzle, output context image | |
1946 | D071MASK | cos02_81_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
1947 | D071WTSC | 1278511.0 | Drizzle, weighting factor for input image |
1948 | D071KERN | square | Drizzle, form of weight distribution kernel |
1949 | D071PIXF | 0.8 | Drizzle, linear size of drop |
1950 | D071COEF | cos02_81_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
1951 | D071XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1952 | D071YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1953 | D071LAM | 555.0 | Drizzle, wavelength applied for transformation |
1954 | D071EXKY | exptime | Drizzle, exposure keyword name in input image |
1955 | D071INUN | counts | Drizzle, units of input image - counts or cps |
1956 | D071OUUN | cps | Drizzle, units of output image - counts or cps |
1957 | D071FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1958 | D071INXC | 2049.0 | Drizzle, reference center of input image (X) |
1959 | D071INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1960 | D071OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1961 | D071OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1962 | D071SECP | False | Drizzle, there are no secondary geometric param |
1963 | D072VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1964 | D072GEOM | Header WCS | Drizzle, source of geometric information |
1965 | D072DATA | cos02_81_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1966 | D072DEXP | 407.0 | Drizzle, input image exposure time (s) |
1967 | D072OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1968 | D072OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1969 | D072OUCO | Drizzle, output context image | |
1970 | D072MASK | cos02_81_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1971 | D072WTSC | 1278511.0 | Drizzle, weighting factor for input image |
1972 | D072KERN | square | Drizzle, form of weight distribution kernel |
1973 | D072PIXF | 0.8 | Drizzle, linear size of drop |
1974 | D072COEF | cos02_81_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1975 | D072XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1976 | D072YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1977 | D072LAM | 555.0 | Drizzle, wavelength applied for transformation |
1978 | D072EXKY | exptime | Drizzle, exposure keyword name in input image |
1979 | D072INUN | counts | Drizzle, units of input image - counts or cps |
1980 | D072OUUN | cps | Drizzle, units of output image - counts or cps |
1981 | D072FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1982 | D072INXC | 2049.0 | Drizzle, reference center of input image (X) |
1983 | D072INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1984 | D072OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1985 | D072OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1986 | D072SECP | False | Drizzle, there are no secondary geometric param |
1987 | D073VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1988 | D073GEOM | Header WCS | Drizzle, source of geometric information |
1989 | D073DATA | cos02_82_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
1990 | D073DEXP | 275.0 | Drizzle, input image exposure time (s) |
1991 | D073OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1992 | D073OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1993 | D073OUCO | Drizzle, output context image | |
1994 | D073MASK | cos02_82_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
1995 | D073WTSC | 583665.9 | Drizzle, weighting factor for input image |
1996 | D073KERN | square | Drizzle, form of weight distribution kernel |
1997 | D073PIXF | 0.8 | Drizzle, linear size of drop |
1998 | D073COEF | cos02_82_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
1999 | D073XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2000 | D073YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2001 | D073LAM | 555.0 | Drizzle, wavelength applied for transformation |
2002 | D073EXKY | exptime | Drizzle, exposure keyword name in input image |
2003 | D073INUN | counts | Drizzle, units of input image - counts or cps |
2004 | D073OUUN | cps | Drizzle, units of output image - counts or cps |
2005 | D073FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2006 | D073INXC | 2049.0 | Drizzle, reference center of input image (X) |
2007 | D073INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2008 | D073OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2009 | D073OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2010 | D073SECP | False | Drizzle, there are no secondary geometric param |
2011 | D074VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2012 | D074GEOM | Header WCS | Drizzle, source of geometric information |
2013 | D074DATA | cos02_82_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
2014 | D074DEXP | 275.0 | Drizzle, input image exposure time (s) |
2015 | D074OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2016 | D074OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2017 | D074OUCO | Drizzle, output context image | |
2018 | D074MASK | cos02_82_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
2019 | D074WTSC | 583665.9 | Drizzle, weighting factor for input image |
2020 | D074KERN | square | Drizzle, form of weight distribution kernel |
2021 | D074PIXF | 0.8 | Drizzle, linear size of drop |
2022 | D074COEF | cos02_82_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
2023 | D074XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2024 | D074YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2025 | D074LAM | 555.0 | Drizzle, wavelength applied for transformation |
2026 | D074EXKY | exptime | Drizzle, exposure keyword name in input image |
2027 | D074INUN | counts | Drizzle, units of input image - counts or cps |
2028 | D074OUUN | cps | Drizzle, units of output image - counts or cps |
2029 | D074FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2030 | D074INXC | 2049.0 | Drizzle, reference center of input image (X) |
2031 | D074INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2032 | D074OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2033 | D074OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2034 | D074SECP | False | Drizzle, there are no secondary geometric param |
2035 | D075VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2036 | D075GEOM | Header WCS | Drizzle, source of geometric information |
2037 | D075DATA | cos02_82_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
2038 | D075DEXP | 407.0 | Drizzle, input image exposure time (s) |
2039 | D075OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2040 | D075OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2041 | D075OUCO | Drizzle, output context image | |
2042 | D075MASK | cos02_82_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
2043 | D075WTSC | 1278398.0 | Drizzle, weighting factor for input image |
2044 | D075KERN | square | Drizzle, form of weight distribution kernel |
2045 | D075PIXF | 0.8 | Drizzle, linear size of drop |
2046 | D075COEF | cos02_82_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
2047 | D075XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2048 | D075YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2049 | D075LAM | 555.0 | Drizzle, wavelength applied for transformation |
2050 | D075EXKY | exptime | Drizzle, exposure keyword name in input image |
2051 | D075INUN | counts | Drizzle, units of input image - counts or cps |
2052 | D075OUUN | cps | Drizzle, units of output image - counts or cps |
2053 | D075FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2054 | D075INXC | 2049.0 | Drizzle, reference center of input image (X) |
2055 | D075INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2056 | D075OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2057 | D075OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2058 | D075SECP | False | Drizzle, there are no secondary geometric param |
2059 | D076VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2060 | D076GEOM | Header WCS | Drizzle, source of geometric information |
2061 | D076DATA | cos02_82_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
2062 | D076DEXP | 407.0 | Drizzle, input image exposure time (s) |
2063 | D076OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2064 | D076OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2065 | D076OUCO | Drizzle, output context image | |
2066 | D076MASK | cos02_82_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
2067 | D076WTSC | 1278398.0 | Drizzle, weighting factor for input image |
2068 | D076KERN | square | Drizzle, form of weight distribution kernel |
2069 | D076PIXF | 0.8 | Drizzle, linear size of drop |
2070 | D076COEF | cos02_82_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
2071 | D076XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2072 | D076YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2073 | D076LAM | 555.0 | Drizzle, wavelength applied for transformation |
2074 | D076EXKY | exptime | Drizzle, exposure keyword name in input image |
2075 | D076INUN | counts | Drizzle, units of input image - counts or cps |
2076 | D076OUUN | cps | Drizzle, units of output image - counts or cps |
2077 | D076FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2078 | D076INXC | 2049.0 | Drizzle, reference center of input image (X) |
2079 | D076INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2080 | D076OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2081 | D076OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2082 | D076SECP | False | Drizzle, there are no secondary geometric param |
2083 | D077VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2084 | D077GEOM | Header WCS | Drizzle, source of geometric information |
2085 | D077DATA | cos02_84_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
2086 | D077DEXP | 225.0 | Drizzle, input image exposure time (s) |
2087 | D077OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2088 | D077OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2089 | D077OUCO | Drizzle, output context image | |
2090 | D077MASK | cos02_84_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
2091 | D077WTSC | 390733.3 | Drizzle, weighting factor for input image |
2092 | D077KERN | square | Drizzle, form of weight distribution kernel |
2093 | D077PIXF | 0.8 | Drizzle, linear size of drop |
2094 | D077COEF | cos02_84_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
2095 | D077XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2096 | D077YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2097 | D077LAM | 555.0 | Drizzle, wavelength applied for transformation |
2098 | D077EXKY | exptime | Drizzle, exposure keyword name in input image |
2099 | D077INUN | counts | Drizzle, units of input image - counts or cps |
2100 | D077OUUN | cps | Drizzle, units of output image - counts or cps |
2101 | D077FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2102 | D077INXC | 2049.0 | Drizzle, reference center of input image (X) |
2103 | D077INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2104 | D077OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2105 | D077OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2106 | D077SECP | False | Drizzle, there are no secondary geometric param |
2107 | D078VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2108 | D078GEOM | Header WCS | Drizzle, source of geometric information |
2109 | D078DATA | cos02_84_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
2110 | D078DEXP | 407.0 | Drizzle, input image exposure time (s) |
2111 | D078OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2112 | D078OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2113 | D078OUCO | Drizzle, output context image | |
2114 | D078MASK | cos02_84_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
2115 | D078WTSC | 1278475.0 | Drizzle, weighting factor for input image |
2116 | D078KERN | square | Drizzle, form of weight distribution kernel |
2117 | D078PIXF | 0.8 | Drizzle, linear size of drop |
2118 | D078COEF | cos02_84_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
2119 | D078XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2120 | D078YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2121 | D078LAM | 555.0 | Drizzle, wavelength applied for transformation |
2122 | D078EXKY | exptime | Drizzle, exposure keyword name in input image |
2123 | D078INUN | counts | Drizzle, units of input image - counts or cps |
2124 | D078OUUN | cps | Drizzle, units of output image - counts or cps |
2125 | D078FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2126 | D078INXC | 2049.0 | Drizzle, reference center of input image (X) |
2127 | D078INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2128 | D078OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2129 | D078OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2130 | D078SECP | False | Drizzle, there are no secondary geometric param |
2131 | D079VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2132 | D079GEOM | Header WCS | Drizzle, source of geometric information |
2133 | D079DATA | cos02_85_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
2134 | D079DEXP | 225.0 | Drizzle, input image exposure time (s) |
2135 | D079OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2136 | D079OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2137 | D079OUCO | Drizzle, output context image | |
2138 | D079MASK | cos02_85_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
2139 | D079WTSC | 390734.6 | Drizzle, weighting factor for input image |
2140 | D079KERN | square | Drizzle, form of weight distribution kernel |
2141 | D079PIXF | 0.8 | Drizzle, linear size of drop |
2142 | D079COEF | cos02_85_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
2143 | D079XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2144 | D079YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2145 | D079LAM | 555.0 | Drizzle, wavelength applied for transformation |
2146 | D079EXKY | exptime | Drizzle, exposure keyword name in input image |
2147 | D079INUN | counts | Drizzle, units of input image - counts or cps |
2148 | D079OUUN | cps | Drizzle, units of output image - counts or cps |
2149 | D079FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2150 | D079INXC | 2049.0 | Drizzle, reference center of input image (X) |
2151 | D079INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2152 | D079OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2153 | D079OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2154 | D079SECP | False | Drizzle, there are no secondary geometric param |
2155 | D080VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2156 | D080GEOM | Header WCS | Drizzle, source of geometric information |
2157 | D080DATA | cos02_85_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
2158 | D080DEXP | 225.0 | Drizzle, input image exposure time (s) |
2159 | D080OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2160 | D080OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2161 | D080OUCO | Drizzle, output context image | |
2162 | D080MASK | cos02_85_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
2163 | D080WTSC | 390734.6 | Drizzle, weighting factor for input image |
2164 | D080KERN | square | Drizzle, form of weight distribution kernel |
2165 | D080PIXF | 0.8 | Drizzle, linear size of drop |
2166 | D080COEF | cos02_85_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
2167 | D080XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2168 | D080YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2169 | D080LAM | 555.0 | Drizzle, wavelength applied for transformation |
2170 | D080EXKY | exptime | Drizzle, exposure keyword name in input image |
2171 | D080INUN | counts | Drizzle, units of input image - counts or cps |
2172 | D080OUUN | cps | Drizzle, units of output image - counts or cps |
2173 | D080FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2174 | D080INXC | 2049.0 | Drizzle, reference center of input image (X) |
2175 | D080INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2176 | D080OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2177 | D080OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2178 | D080SECP | False | Drizzle, there are no secondary geometric param |
2179 | D081VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2180 | D081GEOM | Header WCS | Drizzle, source of geometric information |
2181 | D081DATA | cos02_85_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
2182 | D081DEXP | 407.0 | Drizzle, input image exposure time (s) |
2183 | D081OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2184 | D081OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2185 | D081OUCO | Drizzle, output context image | |
2186 | D081MASK | cos02_85_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
2187 | D081WTSC | 1278483.0 | Drizzle, weighting factor for input image |
2188 | D081KERN | square | Drizzle, form of weight distribution kernel |
2189 | D081PIXF | 0.8 | Drizzle, linear size of drop |
2190 | D081COEF | cos02_85_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
2191 | D081XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2192 | D081YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2193 | D081LAM | 555.0 | Drizzle, wavelength applied for transformation |
2194 | D081EXKY | exptime | Drizzle, exposure keyword name in input image |
2195 | D081INUN | counts | Drizzle, units of input image - counts or cps |
2196 | D081OUUN | cps | Drizzle, units of output image - counts or cps |
2197 | D081FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2198 | D081INXC | 2049.0 | Drizzle, reference center of input image (X) |
2199 | D081INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2200 | D081OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2201 | D081OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2202 | D081SECP | False | Drizzle, there are no secondary geometric param |
2203 | D082VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2204 | D082GEOM | Header WCS | Drizzle, source of geometric information |
2205 | D082DATA | cos02_85_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
2206 | D082DEXP | 407.0 | Drizzle, input image exposure time (s) |
2207 | D082OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2208 | D082OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2209 | D082OUCO | Drizzle, output context image | |
2210 | D082MASK | cos02_85_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
2211 | D082WTSC | 1278483.0 | Drizzle, weighting factor for input image |
2212 | D082KERN | square | Drizzle, form of weight distribution kernel |
2213 | D082PIXF | 0.8 | Drizzle, linear size of drop |
2214 | D082COEF | cos02_85_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
2215 | D082XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2216 | D082YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2217 | D082LAM | 555.0 | Drizzle, wavelength applied for transformation |
2218 | D082EXKY | exptime | Drizzle, exposure keyword name in input image |
2219 | D082INUN | counts | Drizzle, units of input image - counts or cps |
2220 | D082OUUN | cps | Drizzle, units of output image - counts or cps |
2221 | D082FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2222 | D082INXC | 2049.0 | Drizzle, reference center of input image (X) |
2223 | D082INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2224 | D082OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2225 | D082OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2226 | D082SECP | False | Drizzle, there are no secondary geometric param |
2227 | D083VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2228 | D083GEOM | Header WCS | Drizzle, source of geometric information |
2229 | D083DATA | cos02_86_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
2230 | D083DEXP | 225.0 | Drizzle, input image exposure time (s) |
2231 | D083OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2232 | D083OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2233 | D083OUCO | Drizzle, output context image | |
2234 | D083MASK | cos02_86_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
2235 | D083WTSC | 390660.8 | Drizzle, weighting factor for input image |
2236 | D083KERN | square | Drizzle, form of weight distribution kernel |
2237 | D083PIXF | 0.8 | Drizzle, linear size of drop |
2238 | D083COEF | cos02_86_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
2239 | D083XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2240 | D083YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2241 | D083LAM | 555.0 | Drizzle, wavelength applied for transformation |
2242 | D083EXKY | exptime | Drizzle, exposure keyword name in input image |
2243 | D083INUN | counts | Drizzle, units of input image - counts or cps |
2244 | D083OUUN | cps | Drizzle, units of output image - counts or cps |
2245 | D083FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2246 | D083INXC | 2049.0 | Drizzle, reference center of input image (X) |
2247 | D083INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2248 | D083OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2249 | D083OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2250 | D083SECP | False | Drizzle, there are no secondary geometric param |
2251 | D084VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2252 | D084GEOM | Header WCS | Drizzle, source of geometric information |
2253 | D084DATA | cos02_86_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
2254 | D084DEXP | 225.0 | Drizzle, input image exposure time (s) |
2255 | D084OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2256 | D084OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2257 | D084OUCO | Drizzle, output context image | |
2258 | D084MASK | cos02_86_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
2259 | D084WTSC | 390660.8 | Drizzle, weighting factor for input image |
2260 | D084KERN | square | Drizzle, form of weight distribution kernel |
2261 | D084PIXF | 0.8 | Drizzle, linear size of drop |
2262 | D084COEF | cos02_86_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
2263 | D084XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2264 | D084YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2265 | D084LAM | 555.0 | Drizzle, wavelength applied for transformation |
2266 | D084EXKY | exptime | Drizzle, exposure keyword name in input image |
2267 | D084INUN | counts | Drizzle, units of input image - counts or cps |
2268 | D084OUUN | cps | Drizzle, units of output image - counts or cps |
2269 | D084FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2270 | D084INXC | 2049.0 | Drizzle, reference center of input image (X) |
2271 | D084INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2272 | D084OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2273 | D084OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2274 | D084SECP | False | Drizzle, there are no secondary geometric param |
2275 | D085VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2276 | D085GEOM | Header WCS | Drizzle, source of geometric information |
2277 | D085DATA | cos02_86_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
2278 | D085DEXP | 407.0 | Drizzle, input image exposure time (s) |
2279 | D085OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2280 | D085OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2281 | D085OUCO | Drizzle, output context image | |
2282 | D085MASK | cos02_86_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
2283 | D085WTSC | 1278516.0 | Drizzle, weighting factor for input image |
2284 | D085KERN | square | Drizzle, form of weight distribution kernel |
2285 | D085PIXF | 0.8 | Drizzle, linear size of drop |
2286 | D085COEF | cos02_86_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
2287 | D085XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2288 | D085YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2289 | D085LAM | 555.0 | Drizzle, wavelength applied for transformation |
2290 | D085EXKY | exptime | Drizzle, exposure keyword name in input image |
2291 | D085INUN | counts | Drizzle, units of input image - counts or cps |
2292 | D085OUUN | cps | Drizzle, units of output image - counts or cps |
2293 | D085FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2294 | D085INXC | 2049.0 | Drizzle, reference center of input image (X) |
2295 | D085INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2296 | D085OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2297 | D085OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2298 | D085SECP | False | Drizzle, there are no secondary geometric param |
2299 | D086VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2300 | D086GEOM | Header WCS | Drizzle, source of geometric information |
2301 | D086DATA | cos02_86_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
2302 | D086DEXP | 407.0 | Drizzle, input image exposure time (s) |
2303 | D086OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2304 | D086OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2305 | D086OUCO | Drizzle, output context image | |
2306 | D086MASK | cos02_86_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
2307 | D086WTSC | 1278516.0 | Drizzle, weighting factor for input image |
2308 | D086KERN | square | Drizzle, form of weight distribution kernel |
2309 | D086PIXF | 0.8 | Drizzle, linear size of drop |
2310 | D086COEF | cos02_86_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
2311 | D086XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2312 | D086YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2313 | D086LAM | 555.0 | Drizzle, wavelength applied for transformation |
2314 | D086EXKY | exptime | Drizzle, exposure keyword name in input image |
2315 | D086INUN | counts | Drizzle, units of input image - counts or cps |
2316 | D086OUUN | cps | Drizzle, units of output image - counts or cps |
2317 | D086FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2318 | D086INXC | 2049.0 | Drizzle, reference center of input image (X) |
2319 | D086INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2320 | D086OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2321 | D086OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2322 | D086SECP | False | Drizzle, there are no secondary geometric param |
2323 | D087VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2324 | D087GEOM | Header WCS | Drizzle, source of geometric information |
2325 | D087DATA | cos02_89_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
2326 | D087DEXP | 225.0 | Drizzle, input image exposure time (s) |
2327 | D087OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2328 | D087OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2329 | D087OUCO | Drizzle, output context image | |
2330 | D087MASK | cos02_89_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
2331 | D087WTSC | 390736.4 | Drizzle, weighting factor for input image |
2332 | D087KERN | square | Drizzle, form of weight distribution kernel |
2333 | D087PIXF | 0.8 | Drizzle, linear size of drop |
2334 | D087COEF | cos02_89_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
2335 | D087XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2336 | D087YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2337 | D087LAM | 555.0 | Drizzle, wavelength applied for transformation |
2338 | D087EXKY | exptime | Drizzle, exposure keyword name in input image |
2339 | D087INUN | counts | Drizzle, units of input image - counts or cps |
2340 | D087OUUN | cps | Drizzle, units of output image - counts or cps |
2341 | D087FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2342 | D087INXC | 2049.0 | Drizzle, reference center of input image (X) |
2343 | D087INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2344 | D087OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2345 | D087OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2346 | D087SECP | False | Drizzle, there are no secondary geometric param |
2347 | D088VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2348 | D088GEOM | Header WCS | Drizzle, source of geometric information |
2349 | D088DATA | cos02_89_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
2350 | D088DEXP | 225.0 | Drizzle, input image exposure time (s) |
2351 | D088OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2352 | D088OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2353 | D088OUCO | Drizzle, output context image | |
2354 | D088MASK | cos02_89_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
2355 | D088WTSC | 390736.4 | Drizzle, weighting factor for input image |
2356 | D088KERN | square | Drizzle, form of weight distribution kernel |
2357 | D088PIXF | 0.8 | Drizzle, linear size of drop |
2358 | D088COEF | cos02_89_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
2359 | D088XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2360 | D088YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2361 | D088LAM | 555.0 | Drizzle, wavelength applied for transformation |
2362 | D088EXKY | exptime | Drizzle, exposure keyword name in input image |
2363 | D088INUN | counts | Drizzle, units of input image - counts or cps |
2364 | D088OUUN | cps | Drizzle, units of output image - counts or cps |
2365 | D088FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2366 | D088INXC | 2049.0 | Drizzle, reference center of input image (X) |
2367 | D088INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2368 | D088OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2369 | D088OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2370 | D088SECP | False | Drizzle, there are no secondary geometric param |
2371 | D089VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2372 | D089GEOM | Header WCS | Drizzle, source of geometric information |
2373 | D089DATA | cos02_89_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
2374 | D089DEXP | 407.0 | Drizzle, input image exposure time (s) |
2375 | D089OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2376 | D089OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2377 | D089OUCO | Drizzle, output context image | |
2378 | D089MASK | cos02_89_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
2379 | D089WTSC | 1278490.0 | Drizzle, weighting factor for input image |
2380 | D089KERN | square | Drizzle, form of weight distribution kernel |
2381 | D089PIXF | 0.8 | Drizzle, linear size of drop |
2382 | D089COEF | cos02_89_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
2383 | D089XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2384 | D089YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2385 | D089LAM | 555.0 | Drizzle, wavelength applied for transformation |
2386 | D089EXKY | exptime | Drizzle, exposure keyword name in input image |
2387 | D089INUN | counts | Drizzle, units of input image - counts or cps |
2388 | D089OUUN | cps | Drizzle, units of output image - counts or cps |
2389 | D089FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2390 | D089INXC | 2049.0 | Drizzle, reference center of input image (X) |
2391 | D089INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2392 | D089OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2393 | D089OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2394 | D089SECP | False | Drizzle, there are no secondary geometric param |
2395 | D090VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2396 | D090GEOM | Header WCS | Drizzle, source of geometric information |
2397 | D090DATA | cos02_89_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
2398 | D090DEXP | 407.0 | Drizzle, input image exposure time (s) |
2399 | D090OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2400 | D090OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2401 | D090OUCO | Drizzle, output context image | |
2402 | D090MASK | cos02_89_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
2403 | D090WTSC | 1278490.0 | Drizzle, weighting factor for input image |
2404 | D090KERN | square | Drizzle, form of weight distribution kernel |
2405 | D090PIXF | 0.8 | Drizzle, linear size of drop |
2406 | D090COEF | cos02_89_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
2407 | D090XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2408 | D090YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2409 | D090LAM | 555.0 | Drizzle, wavelength applied for transformation |
2410 | D090EXKY | exptime | Drizzle, exposure keyword name in input image |
2411 | D090INUN | counts | Drizzle, units of input image - counts or cps |
2412 | D090OUUN | cps | Drizzle, units of output image - counts or cps |
2413 | D090FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2414 | D090INXC | 2049.0 | Drizzle, reference center of input image (X) |
2415 | D090INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2416 | D090OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2417 | D090OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2418 | D090SECP | False | Drizzle, there are no secondary geometric param |
2419 | D091VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2420 | D091GEOM | Header WCS | Drizzle, source of geometric information |
2421 | D091DATA | cos02_90_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
2422 | D091DEXP | 225.0 | Drizzle, input image exposure time (s) |
2423 | D091OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2424 | D091OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2425 | D091OUCO | Drizzle, output context image | |
2426 | D091MASK | cos02_90_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
2427 | D091WTSC | 390736.1 | Drizzle, weighting factor for input image |
2428 | D091KERN | square | Drizzle, form of weight distribution kernel |
2429 | D091PIXF | 0.8 | Drizzle, linear size of drop |
2430 | D091COEF | cos02_90_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
2431 | D091XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2432 | D091YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2433 | D091LAM | 555.0 | Drizzle, wavelength applied for transformation |
2434 | D091EXKY | exptime | Drizzle, exposure keyword name in input image |
2435 | D091INUN | counts | Drizzle, units of input image - counts or cps |
2436 | D091OUUN | cps | Drizzle, units of output image - counts or cps |
2437 | D091FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2438 | D091INXC | 2049.0 | Drizzle, reference center of input image (X) |
2439 | D091INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2440 | D091OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2441 | D091OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2442 | D091SECP | False | Drizzle, there are no secondary geometric param |
2443 | D092VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2444 | D092GEOM | Header WCS | Drizzle, source of geometric information |
2445 | D092DATA | cos02_90_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
2446 | D092DEXP | 225.0 | Drizzle, input image exposure time (s) |
2447 | D092OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2448 | D092OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2449 | D092OUCO | Drizzle, output context image | |
2450 | D092MASK | cos02_90_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
2451 | D092WTSC | 390736.1 | Drizzle, weighting factor for input image |
2452 | D092KERN | square | Drizzle, form of weight distribution kernel |
2453 | D092PIXF | 0.8 | Drizzle, linear size of drop |
2454 | D092COEF | cos02_90_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
2455 | D092XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2456 | D092YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2457 | D092LAM | 555.0 | Drizzle, wavelength applied for transformation |
2458 | D092EXKY | exptime | Drizzle, exposure keyword name in input image |
2459 | D092INUN | counts | Drizzle, units of input image - counts or cps |
2460 | D092OUUN | cps | Drizzle, units of output image - counts or cps |
2461 | D092FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2462 | D092INXC | 2049.0 | Drizzle, reference center of input image (X) |
2463 | D092INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2464 | D092OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2465 | D092OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2466 | D092SECP | False | Drizzle, there are no secondary geometric param |
2467 | D093VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2468 | D093GEOM | Header WCS | Drizzle, source of geometric information |
2469 | D093DATA | cos02_90_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
2470 | D093DEXP | 407.0 | Drizzle, input image exposure time (s) |
2471 | D093OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2472 | D093OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2473 | D093OUCO | Drizzle, output context image | |
2474 | D093MASK | cos02_90_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
2475 | D093WTSC | 1278487.0 | Drizzle, weighting factor for input image |
2476 | D093KERN | square | Drizzle, form of weight distribution kernel |
2477 | D093PIXF | 0.8 | Drizzle, linear size of drop |
2478 | D093COEF | cos02_90_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
2479 | D093XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2480 | D093YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2481 | D093LAM | 555.0 | Drizzle, wavelength applied for transformation |
2482 | D093EXKY | exptime | Drizzle, exposure keyword name in input image |
2483 | D093INUN | counts | Drizzle, units of input image - counts or cps |
2484 | D093OUUN | cps | Drizzle, units of output image - counts or cps |
2485 | D093FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2486 | D093INXC | 2049.0 | Drizzle, reference center of input image (X) |
2487 | D093INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2488 | D093OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2489 | D093OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2490 | D093SECP | False | Drizzle, there are no secondary geometric param |
2491 | D094VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2492 | D094GEOM | Header WCS | Drizzle, source of geometric information |
2493 | D094DATA | cos02_90_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
2494 | D094DEXP | 407.0 | Drizzle, input image exposure time (s) |
2495 | D094OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2496 | D094OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2497 | D094OUCO | Drizzle, output context image | |
2498 | D094MASK | cos02_90_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
2499 | D094WTSC | 1278487.0 | Drizzle, weighting factor for input image |
2500 | D094KERN | square | Drizzle, form of weight distribution kernel |
2501 | D094PIXF | 0.8 | Drizzle, linear size of drop |
2502 | D094COEF | cos02_90_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
2503 | D094XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2504 | D094YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2505 | D094LAM | 555.0 | Drizzle, wavelength applied for transformation |
2506 | D094EXKY | exptime | Drizzle, exposure keyword name in input image |
2507 | D094INUN | counts | Drizzle, units of input image - counts or cps |
2508 | D094OUUN | cps | Drizzle, units of output image - counts or cps |
2509 | D094FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2510 | D094INXC | 2049.0 | Drizzle, reference center of input image (X) |
2511 | D094INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2512 | D094OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2513 | D094OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2514 | D094SECP | False | Drizzle, there are no secondary geometric param |
2515 | D095VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2516 | D095GEOM | Header WCS | Drizzle, source of geometric information |
2517 | D095DATA | cos02_93_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
2518 | D095DEXP | 225.0 | Drizzle, input image exposure time (s) |
2519 | D095OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2520 | D095OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2521 | D095OUCO | Drizzle, output context image | |
2522 | D095MASK | cos02_93_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
2523 | D095WTSC | 390736.0 | Drizzle, weighting factor for input image |
2524 | D095KERN | square | Drizzle, form of weight distribution kernel |
2525 | D095PIXF | 0.8 | Drizzle, linear size of drop |
2526 | D095COEF | cos02_93_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
2527 | D095XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2528 | D095YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2529 | D095LAM | 555.0 | Drizzle, wavelength applied for transformation |
2530 | D095EXKY | exptime | Drizzle, exposure keyword name in input image |
2531 | D095INUN | counts | Drizzle, units of input image - counts or cps |
2532 | D095OUUN | cps | Drizzle, units of output image - counts or cps |
2533 | D095FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2534 | D095INXC | 2049.0 | Drizzle, reference center of input image (X) |
2535 | D095INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2536 | D095OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2537 | D095OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2538 | D095SECP | False | Drizzle, there are no secondary geometric param |
2539 | D096VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2540 | D096GEOM | Header WCS | Drizzle, source of geometric information |
2541 | D096DATA | cos02_93_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
2542 | D096DEXP | 407.0 | Drizzle, input image exposure time (s) |
2543 | D096OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2544 | D096OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2545 | D096OUCO | Drizzle, output context image | |
2546 | D096MASK | cos02_93_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
2547 | D096WTSC | 1278483.0 | Drizzle, weighting factor for input image |
2548 | D096KERN | square | Drizzle, form of weight distribution kernel |
2549 | D096PIXF | 0.8 | Drizzle, linear size of drop |
2550 | D096COEF | cos02_93_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
2551 | D096XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2552 | D096YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2553 | D096LAM | 555.0 | Drizzle, wavelength applied for transformation |
2554 | D096EXKY | exptime | Drizzle, exposure keyword name in input image |
2555 | D096INUN | counts | Drizzle, units of input image - counts or cps |
2556 | D096OUUN | cps | Drizzle, units of output image - counts or cps |
2557 | D096FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2558 | D096INXC | 2049.0 | Drizzle, reference center of input image (X) |
2559 | D096INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2560 | D096OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2561 | D096OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2562 | D096SECP | False | Drizzle, there are no secondary geometric param |
2563 | D097VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2564 | D097GEOM | Header WCS | Drizzle, source of geometric information |
2565 | D097DATA | cos02_94_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
2566 | D097DEXP | 225.0 | Drizzle, input image exposure time (s) |
2567 | D097OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2568 | D097OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2569 | D097OUCO | Drizzle, output context image | |
2570 | D097MASK | cos02_94_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
2571 | D097WTSC | 390737.1 | Drizzle, weighting factor for input image |
2572 | D097KERN | square | Drizzle, form of weight distribution kernel |
2573 | D097PIXF | 0.8 | Drizzle, linear size of drop |
2574 | D097COEF | cos02_94_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
2575 | D097XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2576 | D097YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2577 | D097LAM | 555.0 | Drizzle, wavelength applied for transformation |
2578 | D097EXKY | exptime | Drizzle, exposure keyword name in input image |
2579 | D097INUN | counts | Drizzle, units of input image - counts or cps |
2580 | D097OUUN | cps | Drizzle, units of output image - counts or cps |
2581 | D097FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2582 | D097INXC | 2049.0 | Drizzle, reference center of input image (X) |
2583 | D097INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2584 | D097OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2585 | D097OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2586 | D097SECP | False | Drizzle, there are no secondary geometric param |
2587 | D098VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2588 | D098GEOM | Header WCS | Drizzle, source of geometric information |
2589 | D098DATA | cos02_94_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
2590 | D098DEXP | 225.0 | Drizzle, input image exposure time (s) |
2591 | D098OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2592 | D098OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2593 | D098OUCO | Drizzle, output context image | |
2594 | D098MASK | cos02_94_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
2595 | D098WTSC | 390737.1 | Drizzle, weighting factor for input image |
2596 | D098KERN | square | Drizzle, form of weight distribution kernel |
2597 | D098PIXF | 0.8 | Drizzle, linear size of drop |
2598 | D098COEF | cos02_94_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
2599 | D098XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2600 | D098YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2601 | D098LAM | 555.0 | Drizzle, wavelength applied for transformation |
2602 | D098EXKY | exptime | Drizzle, exposure keyword name in input image |
2603 | D098INUN | counts | Drizzle, units of input image - counts or cps |
2604 | D098OUUN | cps | Drizzle, units of output image - counts or cps |
2605 | D098FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2606 | D098INXC | 2049.0 | Drizzle, reference center of input image (X) |
2607 | D098INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2608 | D098OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2609 | D098OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2610 | D098SECP | False | Drizzle, there are no secondary geometric param |
2611 | D099VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2612 | D099GEOM | Header WCS | Drizzle, source of geometric information |
2613 | D099DATA | cos02_94_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
2614 | D099DEXP | 407.0 | Drizzle, input image exposure time (s) |
2615 | D099OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2616 | D099OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2617 | D099OUCO | Drizzle, output context image | |
2618 | D099MASK | cos02_94_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
2619 | D099WTSC | 1278491.0 | Drizzle, weighting factor for input image |
2620 | D099KERN | square | Drizzle, form of weight distribution kernel |
2621 | D099PIXF | 0.8 | Drizzle, linear size of drop |
2622 | D099COEF | cos02_94_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
2623 | D099XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2624 | D099YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2625 | D099LAM | 555.0 | Drizzle, wavelength applied for transformation |
2626 | D099EXKY | exptime | Drizzle, exposure keyword name in input image |
2627 | D099INUN | counts | Drizzle, units of input image - counts or cps |
2628 | D099OUUN | cps | Drizzle, units of output image - counts or cps |
2629 | D099FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2630 | D099INXC | 2049.0 | Drizzle, reference center of input image (X) |
2631 | D099INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2632 | D099OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2633 | D099OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2634 | D099SECP | False | Drizzle, there are no secondary geometric param |
2635 | D100VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2636 | D100GEOM | Header WCS | Drizzle, source of geometric information |
2637 | D100DATA | cos02_94_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
2638 | D100DEXP | 407.0 | Drizzle, input image exposure time (s) |
2639 | D100OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2640 | D100OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2641 | D100OUCO | Drizzle, output context image | |
2642 | D100MASK | cos02_94_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
2643 | D100WTSC | 1278491.0 | Drizzle, weighting factor for input image |
2644 | D100KERN | square | Drizzle, form of weight distribution kernel |
2645 | D100PIXF | 0.8 | Drizzle, linear size of drop |
2646 | D100COEF | cos02_94_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
2647 | D100XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2648 | D100YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2649 | D100LAM | 555.0 | Drizzle, wavelength applied for transformation |
2650 | D100EXKY | exptime | Drizzle, exposure keyword name in input image |
2651 | D100INUN | counts | Drizzle, units of input image - counts or cps |
2652 | D100OUUN | cps | Drizzle, units of output image - counts or cps |
2653 | D100FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2654 | D100INXC | 2049.0 | Drizzle, reference center of input image (X) |
2655 | D100INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2656 | D100OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2657 | D100OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2658 | D100SECP | False | Drizzle, there are no secondary geometric param |
2659 | PC1_1 | -8.333333e-06 | Coordinate transformation matrix element |
2660 | PC2_2 | 8.333333e-06 | Coordinate transformation matrix element |
2661 | CDELT1 | 1.0 | [deg] Coordinate increment at reference point |
2662 | CDELT2 | 1.0 | [deg] Coordinate increment at reference point |
2663 | CUNIT1 | deg | Units of coordinate increment and value |
2664 | CUNIT2 | deg | Units of coordinate increment and value |
2665 | LONPOLE | 180.0 | [deg] Native longitude of celestial pole |
2666 | LATPOLE | 2.200973097 | [deg] Native latitude of celestial pole |
2667 | MJDREF | 0.0 | [d] MJD of fiducial time |
2668 | MJD-OBS | 55906.0 | [d] MJD of observation |
2669 | RADESYS | FK5 | Equatorial coordinate system |
2670 | O_EXT_NM | O | r |
2671 | ORIG_FLE | hlsp_candels_hst_hst_candels-v1.0_acs_f606w_drz.fits | Original imag |
2672 | ORIG_EXT | 0 | Extension in original file. |
Example 4: Add the data and write to a file#
So that’s the header. Now we just need to add the data to the dictionary. We can use any descriptive key we like. Maybe we should call it data
.
myfile['data'] = data # Equivalent to myfile.tree['data'] = data
myfile['data']
array([[-6.6392368e-04, -7.4554735e-04, 4.8087438e-04, ...,
5.0681373e-03, 3.0521965e-03, 1.8753707e-03],
[-2.0862564e-03, -1.8097271e-03, 2.6454803e-05, ...,
3.0450651e-03, -9.7416568e-04, 2.4262909e-04],
[-1.3179937e-03, -3.5285766e-03, -1.8192229e-03, ...,
3.1758491e-03, 1.6773099e-04, 2.3124062e-03],
...,
[-1.9475160e-03, -3.0709282e-03, 9.3518662e-05, ...,
1.3050702e-03, -3.7302810e-03, 9.8174601e-04],
[-1.1018811e-03, 5.1750882e-05, 2.0913549e-03, ...,
1.2541392e-03, 1.9218342e-03, 8.1874104e-03],
[ 6.1663929e-03, 6.2804343e-03, 5.8753230e-03, ...,
1.7368054e-03, -2.3874418e-04, 3.9537032e-03]], dtype='>f4')
type(myfile)
myfile.info()
root (AsdfObject)
├─OBJECT (tuple) ...
├─ORIGIN (tuple) ...
├─DATE (tuple) ...
├─DATAMIN (tuple) ...
├─DATAMAX (tuple) ...
├─CRPIX1 (tuple) ...
├─CRVAL1 (tuple) ...
├─CTYPE1 (tuple) ...
├─CD1_1 (tuple) ...
├─CD2_1 (tuple) ...
├─CRPIX2 (tuple) ...
├─CRVAL2 (tuple) ...
├─CTYPE2 (tuple) ...
├─CD1_2 (tuple) ...
├─CD2_2 (tuple) ...
├─ (tuple) ...
├─TELESCOP (tuple) ...
├─INSTRUME (tuple) ...
├─EQUINOX (tuple) ...
├─ROOTNAME (tuple) ...
├─IMAGETYP (tuple) ...
└─2653 not shown
Some nodes not shown.
myfile.write_to('myfile.asdf')
Read the asdf file from disk and look at the tree and the data
ff = asdf.open('myfile.asdf')
ff.tree
{'asdf_library': {'author': 'The ASDF Developers',
'homepage': 'http://github.com/asdf-format/asdf',
'name': 'asdf',
'version': '3.0.1'},
'history': {'extensions': [{'extension_class': 'asdf.extension._manifest.ManifestExtension',
'extension_uri': 'asdf://asdf-format.org/core/extensions/core-1.5.0',
'software': {'name': 'asdf', 'version': '3.0.1'}}]},
'': ['', ''],
'APERTURE': ['WFC', 'aperture name'],
'ASN_ID': ['JBOA28010', 'unique identifier assigned to association'],
'ASN_MTYP': ['EXP-DTH', 'Role of the Member in the Association'],
'ASN_TAB': ['jboa28010_asn.fits', 'name of the association table'],
'ATODCORR': ['OMIT', 'correct for A to D conversion errors'],
'ATODGNA': [2.02, 'calibrated gain for amplifier A'],
'ATODGNB': [1.886, 'calibrated gain for amplifier B'],
'ATODGNC': [2.017, 'calibrated gain for amplifier C'],
'ATODGND': [2.0109999, 'calibrated gain for amplifier D'],
'ATODTAB': ['jref$t3n1116mj_a2d.fits', 'analog to digital correction file'],
'A_0_2': [2.26194120304176e-06, ''],
'A_0_3': [6.51050854317125e-11, ''],
'A_0_4': [1.35191449346299e-13, ''],
'A_1_1': [-7.5302905463753e-06, ''],
'A_1_2': [-5.2539201413375e-10, ''],
'A_1_3': [-1.4269338401366e-14, ''],
'A_2_0': [8.51886870532632e-06, ''],
'A_2_1': [-1.0714004130419e-10, ''],
'A_2_2': [9.70199603291834e-14, ''],
'A_3_0': [-4.6936360210189e-10, ''],
'A_3_1': [3.80059786170717e-14, ''],
'A_4_0': [1.83627862287182e-14, ''],
'A_ORDER': [4, ''],
'BADINPDQ': [0, 'data quality flag bits to reject'],
'BIASCORR': ['COMPLETE', 'Subtract bias image'],
'BIASFILE': ['jref$vbh1844rj_bia.fits', 'bias image file name'],
'BIASLEVA': [2088.5564, 'bias level for amplifier A'],
'BIASLEVB': [2140.5024, 'bias level for amplifier B'],
'BIASLEVC': [2208.7419, 'bias level for amplifier C'],
'BIASLEVD': [2296.7388, 'bias level for amplifier D'],
'BINAXIS1': [1, 'axis1 data bin size in unbinned detector pixels'],
'BINAXIS2': [1, 'axis2 data bin size in unbinned detector pixels'],
'BLEVCORR': ['COMPLETE', 'subtract bias level computed from overscan img'],
'BPIXTAB': ['jref$t3n1116nj_bpx.fits', 'bad pixel table'],
'BSTRCORR': ['COMPLETE', ''],
'BUNIT': ['ELECTRONS', 'brightness units'],
'B_0_2': [-9.7985788387639e-06, ''],
'B_0_3': [-4.1421499542394e-10, ''],
'B_0_4': [-1.5248974790417e-13, ''],
'B_1_1': [6.42569986264533e-06, ''],
'B_1_2': [-3.0354276197375e-11, ''],
'B_1_3': [2.75911271664302e-14, ''],
'B_2_0': [-2.9658922285423e-06, ''],
'B_2_1': [-4.4034927976003e-10, ''],
'B_2_2': [-1.0403607372429e-13, ''],
'B_3_0': [9.00334210115821e-11, ''],
'B_3_1': [-3.8363933112663e-14, ''],
'B_4_0': [-1.6913942054528e-14, ''],
'B_ORDER': [4, ''],
'CAL_VER': ['5.1.1 (27-Apr-2010)', 'CALACS code version'],
'CBLKSIZ': [0, 'size of compression block in 2-byte words'],
'CCDAMP': ['ABCD', 'CCD Amplifier Readout Configuration'],
'CCDCHIP': [1, 'CCD chip (1 or 2)'],
'CCDGAIN': [2.0, 'commanded gain of CCD'],
'CCDOFSTA': [1, 'commanded CCD bias offset for amplifier A'],
'CCDOFSTB': [1, 'commanded CCD bias offset for amplifier B'],
'CCDOFSTC': [1, 'commanded CCD bias offset for amplifier C'],
'CCDOFSTD': [1, 'commanded CCD bias offset for amplifier D'],
'CCDTAB': ['jref$uc82140bj_ccd.fits', 'CCD calibration parameters'],
'CD1_1': [-8.333333e-06, ''],
'CD1_2': [0.0, ''],
'CD2_1': [0.0, ''],
'CD2_2': [8.333333e-06, ''],
'CDELT1': [1.0, '[deg] Coordinate increment at reference point'],
'CDELT2': [1.0, '[deg] Coordinate increment at reference point'],
'CENTERA1': [2073, 'subarray axis1 center pt in unbinned dect. pix'],
'CENTERA2': [1035, 'subarray axis2 center pt in unbinned dect. pix'],
'CFLTFILE': ['N/A', 'Coronagraphic spot image'],
'COMPTAB': ['mtab$vb71653dm_tmc.fits', 'the HST components table'],
'COMPTYP': ['None', 'compression type performed (Partial/Full/None)'],
'CRCORR': ['OMIT', 'combine observations to reject cosmic rays'],
'CRMASK': [False, 'flag CR-rejected pixels in input files (T/F)'],
'CRPIX1': [-2552.5, 'Pixel coordinate of reference point'],
'CRPIX2': [-22248.5, 'Pixel coordinate of reference point'],
'CRRADIUS': [0.0, 'rejection propagation radius (pixels)'],
'CRREJTAB': ['jref$n4e12511j_crr.fits', 'cosmic ray rejection parameters'],
'CRSIGMAS': ['', 'statistical rejection criteria'],
'CRSPLIT': [1, 'number of cosmic ray split exposures'],
'CRTHRESH': [0.0, 'rejection propagation threshold'],
'CRVAL1': [150.1163213, '[deg] Coordinate value at reference point'],
'CRVAL2': [2.200973097, '[deg] Coordinate value at reference point'],
'CTEDIR': ['NONE', 'CTE measurement direction: serial or parallel'],
'CTEIMAGE': ['NONE', 'type of Charge Transfer Image, if applicable'],
'CTYPE1': ['RA---TAN', 'Right ascension, gnomonic projection'],
'CTYPE2': ['DEC--TAN', 'Declination, gnomonic projection'],
'CUNIT1': ['deg', 'Units of coordinate increment and value'],
'CUNIT2': ['deg', 'Units of coordinate increment and value'],
'D001COEF': ['cos01_28_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D001DATA': ['cos01_28_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D001DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D001EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D001FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D001GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D001INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D001INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D001INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D001KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D001LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D001MASK': ['cos01_28_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D001OUCO': ['', 'Drizzle, output context image'],
'D001OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D001OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D001OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D001OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D001OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D001PIXF': [0.8, 'Drizzle, linear size of drop'],
'D001SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D001VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D001WTSC': [583770.1, 'Drizzle, weighting factor for input image'],
'D001XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D001YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D002COEF': ['cos01_28_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D002DATA': ['cos01_28_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D002DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D002EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D002FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D002GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D002INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D002INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D002INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D002KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D002LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D002MASK': ['cos01_28_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D002OUCO': ['', 'Drizzle, output context image'],
'D002OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D002OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D002OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D002OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D002OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D002PIXF': [0.8, 'Drizzle, linear size of drop'],
'D002SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D002VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D002WTSC': [3858213.0, 'Drizzle, weighting factor for input image'],
'D002XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D002YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D003COEF': ['cos01_29_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D003DATA': ['cos01_29_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D003DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D003EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D003FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D003GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D003INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D003INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D003INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D003KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D003LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D003MASK': ['cos01_29_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D003OUCO': ['', 'Drizzle, output context image'],
'D003OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D003OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D003OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D003OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D003OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D003PIXF': [0.8, 'Drizzle, linear size of drop'],
'D003SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D003VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D003WTSC': [583802.2, 'Drizzle, weighting factor for input image'],
'D003XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D003YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D004COEF': ['cos01_29_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D004DATA': ['cos01_29_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D004DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D004EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D004FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D004GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D004INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D004INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D004INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D004KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D004LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D004MASK': ['cos01_29_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D004OUCO': ['', 'Drizzle, output context image'],
'D004OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D004OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D004OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D004OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D004OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D004PIXF': [0.8, 'Drizzle, linear size of drop'],
'D004SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D004VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D004WTSC': [3858522.0, 'Drizzle, weighting factor for input image'],
'D004XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D004YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D005COEF': ['cos01_30_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D005DATA': ['cos01_30_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D005DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D005EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D005FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D005GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D005INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D005INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D005INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D005KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D005LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D005MASK': ['cos01_30_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D005OUCO': ['', 'Drizzle, output context image'],
'D005OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D005OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D005OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D005OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D005OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D005PIXF': [0.8, 'Drizzle, linear size of drop'],
'D005SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D005VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D005WTSC': [583802.4, 'Drizzle, weighting factor for input image'],
'D005XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D005YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D006COEF': ['cos01_30_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D006DATA': ['cos01_30_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D006DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D006EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D006FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D006GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D006INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D006INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D006INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D006KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D006LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D006MASK': ['cos01_30_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D006OUCO': ['', 'Drizzle, output context image'],
'D006OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D006OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D006OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D006OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D006OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D006PIXF': [0.8, 'Drizzle, linear size of drop'],
'D006SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D006VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D006WTSC': [3858522.0, 'Drizzle, weighting factor for input image'],
'D006XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D006YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D007COEF': ['cos01_32_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D007DATA': ['cos01_32_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D007DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D007EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D007FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D007GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D007INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D007INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D007INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D007KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D007LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D007MASK': ['cos01_32_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D007OUCO': ['', 'Drizzle, output context image'],
'D007OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D007OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D007OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D007OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D007OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D007PIXF': [0.8, 'Drizzle, linear size of drop'],
'D007SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D007VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D007WTSC': [583801.9, 'Drizzle, weighting factor for input image'],
'D007XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D007YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D008COEF': ['cos01_32_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D008DATA': ['cos01_32_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D008DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D008EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D008FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D008GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D008INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D008INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D008INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D008KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D008LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D008MASK': ['cos01_32_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D008OUCO': ['', 'Drizzle, output context image'],
'D008OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D008OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D008OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D008OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D008OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D008PIXF': [0.8, 'Drizzle, linear size of drop'],
'D008SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D008VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D008WTSC': [3858506.0, 'Drizzle, weighting factor for input image'],
'D008XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D008YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D009COEF': ['cos01_33_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D009DATA': ['cos01_33_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'],
'D009DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D009EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D009FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D009GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D009INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D009INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D009INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D009KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D009LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D009MASK': ['cos01_33_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D009OUCO': ['', 'Drizzle, output context image'],
'D009OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D009OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D009OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D009OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D009OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D009PIXF': [0.8, 'Drizzle, linear size of drop'],
'D009SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D009VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D009WTSC': [583803.6, 'Drizzle, weighting factor for input image'],
'D009XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D009YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D010COEF': ['cos01_33_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D010DATA': ['cos01_33_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D010DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D010EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D010FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D010GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D010INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D010INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D010INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D010KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D010LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D010MASK': ['cos01_33_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D010OUCO': ['', 'Drizzle, output context image'],
'D010OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D010OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D010OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D010OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D010OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D010PIXF': [0.8, 'Drizzle, linear size of drop'],
'D010SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D010VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D010WTSC': [583803.6, 'Drizzle, weighting factor for input image'],
'D010XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D010YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D011COEF': ['cos01_33_f606w_2_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D011DATA': ['cos01_33_f606w_2_flt_sci1_final.fits',
'Drizzle, input data image'],
'D011DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D011EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D011FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D011GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D011INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D011INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D011INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D011KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D011LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D011MASK': ['cos01_33_f606w_2_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D011OUCO': ['', 'Drizzle, output context image'],
'D011OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D011OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D011OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D011OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D011OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D011PIXF': [0.8, 'Drizzle, linear size of drop'],
'D011SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D011VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D011WTSC': [3858528.0, 'Drizzle, weighting factor for input image'],
'D011XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D011YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D012COEF': ['cos01_33_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D012DATA': ['cos01_33_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D012DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D012EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D012FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D012GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D012INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D012INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D012INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D012KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D012LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D012MASK': ['cos01_33_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D012OUCO': ['', 'Drizzle, output context image'],
'D012OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D012OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D012OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D012OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D012OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D012PIXF': [0.8, 'Drizzle, linear size of drop'],
'D012SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D012VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D012WTSC': [3858528.0, 'Drizzle, weighting factor for input image'],
'D012XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D012YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D013COEF': ['cos01_34_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D013DATA': ['cos01_34_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'],
'D013DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D013EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D013FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D013GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D013INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D013INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D013INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D013KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D013LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D013MASK': ['cos01_34_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D013OUCO': ['', 'Drizzle, output context image'],
'D013OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D013OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D013OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D013OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D013OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D013PIXF': [0.8, 'Drizzle, linear size of drop'],
'D013SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D013VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D013WTSC': [583803.6, 'Drizzle, weighting factor for input image'],
'D013XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D013YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D014COEF': ['cos01_34_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D014DATA': ['cos01_34_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D014DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D014EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D014FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D014GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D014INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D014INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D014INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D014KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D014LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D014MASK': ['cos01_34_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D014OUCO': ['', 'Drizzle, output context image'],
'D014OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D014OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D014OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D014OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D014OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D014PIXF': [0.8, 'Drizzle, linear size of drop'],
'D014SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D014VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D014WTSC': [583803.6, 'Drizzle, weighting factor for input image'],
'D014XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D014YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D015COEF': ['cos01_34_f606w_2_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D015DATA': ['cos01_34_f606w_2_flt_sci1_final.fits',
'Drizzle, input data image'],
'D015DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D015EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D015FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D015GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D015INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D015INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D015INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D015KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D015LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D015MASK': ['cos01_34_f606w_2_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D015OUCO': ['', 'Drizzle, output context image'],
'D015OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D015OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D015OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D015OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D015OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D015PIXF': [0.8, 'Drizzle, linear size of drop'],
'D015SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D015VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D015WTSC': [3858529.0, 'Drizzle, weighting factor for input image'],
'D015XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D015YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D016COEF': ['cos01_34_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D016DATA': ['cos01_34_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D016DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D016EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D016FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D016GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D016INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D016INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D016INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D016KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D016LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D016MASK': ['cos01_34_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D016OUCO': ['', 'Drizzle, output context image'],
'D016OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D016OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D016OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D016OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D016OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D016PIXF': [0.8, 'Drizzle, linear size of drop'],
'D016SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D016VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D016WTSC': [3858529.0, 'Drizzle, weighting factor for input image'],
'D016XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D016YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D017COEF': ['cos01_36_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D017DATA': ['cos01_36_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D017DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D017EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D017FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D017GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D017INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D017INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D017INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D017KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D017LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D017MASK': ['cos01_36_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D017OUCO': ['', 'Drizzle, output context image'],
'D017OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D017OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D017OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D017OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D017OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D017PIXF': [0.8, 'Drizzle, linear size of drop'],
'D017SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D017VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D017WTSC': [583804.3, 'Drizzle, weighting factor for input image'],
'D017XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D017YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D018COEF': ['cos01_36_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D018DATA': ['cos01_36_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D018DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D018EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D018FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D018GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D018INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D018INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D018INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D018KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D018LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D018MASK': ['cos01_36_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D018OUCO': ['', 'Drizzle, output context image'],
'D018OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D018OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D018OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D018OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D018OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D018PIXF': [0.8, 'Drizzle, linear size of drop'],
'D018SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D018VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D018WTSC': [3858532.0, 'Drizzle, weighting factor for input image'],
'D018XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D018YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D019COEF': ['cos01_37_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D019DATA': ['cos01_37_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'],
'D019DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D019EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D019FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D019GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D019INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D019INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D019INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D019KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D019LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D019MASK': ['cos01_37_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D019OUCO': ['', 'Drizzle, output context image'],
'D019OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D019OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D019OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D019OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D019OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D019PIXF': [0.8, 'Drizzle, linear size of drop'],
'D019SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D019VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D019WTSC': [583796.7, 'Drizzle, weighting factor for input image'],
'D019XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D019YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D020COEF': ['cos01_37_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D020DATA': ['cos01_37_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D020DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D020EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D020FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D020GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D020INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D020INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D020INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D020KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D020LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D020MASK': ['cos01_37_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D020OUCO': ['', 'Drizzle, output context image'],
'D020OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D020OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D020OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D020OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D020OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D020PIXF': [0.8, 'Drizzle, linear size of drop'],
'D020SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D020VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D020WTSC': [583796.7, 'Drizzle, weighting factor for input image'],
'D020XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D020YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D021COEF': ['cos01_37_f606w_2_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D021DATA': ['cos01_37_f606w_2_flt_sci1_final.fits',
'Drizzle, input data image'],
'D021DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D021EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D021FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D021GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D021INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D021INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D021INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D021KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D021LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D021MASK': ['cos01_37_f606w_2_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D021OUCO': ['', 'Drizzle, output context image'],
'D021OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D021OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D021OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D021OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D021OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D021PIXF': [0.8, 'Drizzle, linear size of drop'],
'D021SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D021VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D021WTSC': [3858427.0, 'Drizzle, weighting factor for input image'],
'D021XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D021YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D022COEF': ['cos01_37_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D022DATA': ['cos01_37_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D022DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D022EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D022FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D022GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D022INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D022INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D022INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D022KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D022LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D022MASK': ['cos01_37_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D022OUCO': ['', 'Drizzle, output context image'],
'D022OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D022OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D022OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D022OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D022OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D022PIXF': [0.8, 'Drizzle, linear size of drop'],
'D022SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D022VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D022WTSC': [3858427.0, 'Drizzle, weighting factor for input image'],
'D022XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D022YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D023COEF': ['cos01_38_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D023DATA': ['cos01_38_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'],
'D023DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D023EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D023FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D023GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D023INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D023INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D023INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D023KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D023LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D023MASK': ['cos01_38_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D023OUCO': ['', 'Drizzle, output context image'],
'D023OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D023OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D023OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D023OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D023OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D023PIXF': [0.8, 'Drizzle, linear size of drop'],
'D023SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D023VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D023WTSC': [583805.7, 'Drizzle, weighting factor for input image'],
'D023XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D023YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D024COEF': ['cos01_38_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D024DATA': ['cos01_38_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D024DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D024EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D024FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D024GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D024INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D024INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D024INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D024KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D024LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D024MASK': ['cos01_38_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D024OUCO': ['', 'Drizzle, output context image'],
'D024OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D024OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D024OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D024OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D024OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D024PIXF': [0.8, 'Drizzle, linear size of drop'],
'D024SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D024VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D024WTSC': [583805.7, 'Drizzle, weighting factor for input image'],
'D024XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D024YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D025COEF': ['cos01_38_f606w_2_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D025DATA': ['cos01_38_f606w_2_flt_sci1_final.fits',
'Drizzle, input data image'],
'D025DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D025EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D025FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D025GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D025INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D025INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D025INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D025KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D025LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D025MASK': ['cos01_38_f606w_2_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D025OUCO': ['', 'Drizzle, output context image'],
'D025OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D025OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D025OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D025OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D025OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D025PIXF': [0.8, 'Drizzle, linear size of drop'],
'D025SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D025VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D025WTSC': [3858539.0, 'Drizzle, weighting factor for input image'],
'D025XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D025YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D026COEF': ['cos01_38_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D026DATA': ['cos01_38_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D026DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D026EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D026FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D026GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D026INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D026INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D026INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D026KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D026LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D026MASK': ['cos01_38_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D026OUCO': ['', 'Drizzle, output context image'],
'D026OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D026OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D026OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D026OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D026OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D026PIXF': [0.8, 'Drizzle, linear size of drop'],
'D026SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D026VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D026WTSC': [3858539.0, 'Drizzle, weighting factor for input image'],
'D026XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D026YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D027COEF': ['cos01_40_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D027DATA': ['cos01_40_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D027DEXP': [225.0, 'Drizzle, input image exposure time (s)'],
'D027EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D027FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D027GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D027INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D027INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D027INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D027KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D027LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D027MASK': ['cos01_40_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D027OUCO': ['', 'Drizzle, output context image'],
'D027OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D027OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D027OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D027OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D027OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D027PIXF': [0.8, 'Drizzle, linear size of drop'],
'D027SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D027VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D027WTSC': [390803.6, 'Drizzle, weighting factor for input image'],
'D027XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D027YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D028COEF': ['cos01_40_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D028DATA': ['cos01_40_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D028DEXP': [407.0, 'Drizzle, input image exposure time (s)'],
'D028EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D028FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D028GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D028INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D028INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D028INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D028KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D028LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D028MASK': ['cos01_40_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D028OUCO': ['', 'Drizzle, output context image'],
'D028OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D028OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D028OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D028OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D028OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D028PIXF': [0.8, 'Drizzle, linear size of drop'],
'D028SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D028VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D028WTSC': [1278684.0, 'Drizzle, weighting factor for input image'],
'D028XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D028YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D029COEF': ['cos01_41_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D029DATA': ['cos01_41_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'],
'D029DEXP': [225.0, 'Drizzle, input image exposure time (s)'],
'D029EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D029FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D029GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D029INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D029INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D029INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D029KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D029LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D029MASK': ['cos01_41_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D029OUCO': ['', 'Drizzle, output context image'],
'D029OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D029OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D029OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D029OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D029OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D029PIXF': [0.8, 'Drizzle, linear size of drop'],
'D029SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D029VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D029WTSC': [390813.4, 'Drizzle, weighting factor for input image'],
'D029XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D029YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D030COEF': ['cos01_41_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D030DATA': ['cos01_41_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D030DEXP': [225.0, 'Drizzle, input image exposure time (s)'],
'D030EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D030FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D030GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D030INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D030INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D030INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D030KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D030LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D030MASK': ['cos01_41_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D030OUCO': ['', 'Drizzle, output context image'],
'D030OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D030OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D030OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D030OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D030OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D030PIXF': [0.8, 'Drizzle, linear size of drop'],
'D030SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D030VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D030WTSC': [390813.4, 'Drizzle, weighting factor for input image'],
'D030XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D030YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D031COEF': ['cos01_41_f606w_2_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D031DATA': ['cos01_41_f606w_2_flt_sci1_final.fits',
'Drizzle, input data image'],
'D031DEXP': [407.0, 'Drizzle, input image exposure time (s)'],
'D031EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D031FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D031GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D031INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D031INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D031INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D031KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D031LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D031MASK': ['cos01_41_f606w_2_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D031OUCO': ['', 'Drizzle, output context image'],
'D031OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D031OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D031OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D031OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D031OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D031PIXF': [0.8, 'Drizzle, linear size of drop'],
'D031SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D031VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D031WTSC': [1278740.0, 'Drizzle, weighting factor for input image'],
'D031XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D031YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D032COEF': ['cos01_41_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D032DATA': ['cos01_41_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D032DEXP': [407.0, 'Drizzle, input image exposure time (s)'],
'D032EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D032FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D032GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D032INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D032INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D032INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D032KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D032LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D032MASK': ['cos01_41_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D032OUCO': ['', 'Drizzle, output context image'],
'D032OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D032OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D032OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D032OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D032OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D032PIXF': [0.8, 'Drizzle, linear size of drop'],
'D032SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D032VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D032WTSC': [1278740.0, 'Drizzle, weighting factor for input image'],
'D032XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D032YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D033COEF': ['cos01_42_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D033DATA': ['cos01_42_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'],
'D033DEXP': [225.0, 'Drizzle, input image exposure time (s)'],
'D033EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D033FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D033GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D033INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D033INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D033INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D033KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D033LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D033MASK': ['cos01_42_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D033OUCO': ['', 'Drizzle, output context image'],
'D033OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D033OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D033OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D033OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D033OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D033PIXF': [0.8, 'Drizzle, linear size of drop'],
'D033SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D033VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D033WTSC': [390813.7, 'Drizzle, weighting factor for input image'],
'D033XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D033YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D034COEF': ['cos01_42_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D034DATA': ['cos01_42_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D034DEXP': [225.0, 'Drizzle, input image exposure time (s)'],
'D034EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D034FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D034GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D034INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D034INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D034INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D034KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D034LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D034MASK': ['cos01_42_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D034OUCO': ['', 'Drizzle, output context image'],
'D034OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D034OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D034OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D034OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D034OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D034PIXF': [0.8, 'Drizzle, linear size of drop'],
'D034SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D034VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D034WTSC': [390813.7, 'Drizzle, weighting factor for input image'],
'D034XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D034YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D035COEF': ['cos01_42_f606w_2_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D035DATA': ['cos01_42_f606w_2_flt_sci1_final.fits',
'Drizzle, input data image'],
'D035DEXP': [407.0, 'Drizzle, input image exposure time (s)'],
'D035EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D035FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D035GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D035INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D035INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D035INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D035KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D035LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D035MASK': ['cos01_42_f606w_2_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D035OUCO': ['', 'Drizzle, output context image'],
'D035OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D035OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D035OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D035OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D035OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D035PIXF': [0.8, 'Drizzle, linear size of drop'],
'D035SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D035VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D035WTSC': [1278741.0, 'Drizzle, weighting factor for input image'],
'D035XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D035YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D036COEF': ['cos01_42_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D036DATA': ['cos01_42_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D036DEXP': [407.0, 'Drizzle, input image exposure time (s)'],
'D036EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D036FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D036GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D036INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D036INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D036INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D036KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D036LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D036MASK': ['cos01_42_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D036OUCO': ['', 'Drizzle, output context image'],
'D036OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D036OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D036OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D036OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D036OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D036PIXF': [0.8, 'Drizzle, linear size of drop'],
'D036SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D036VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D036WTSC': [1278741.0, 'Drizzle, weighting factor for input image'],
'D036XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D036YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D037COEF': ['cos01_45_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D037DATA': ['cos01_45_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'],
'D037DEXP': [225.0, 'Drizzle, input image exposure time (s)'],
'D037EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D037FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D037GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D037INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D037INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D037INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D037KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D037LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D037MASK': ['cos01_45_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D037OUCO': ['', 'Drizzle, output context image'],
'D037OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D037OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D037OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D037OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D037OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D037PIXF': [0.8, 'Drizzle, linear size of drop'],
'D037SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D037VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D037WTSC': [390814.3, 'Drizzle, weighting factor for input image'],
'D037XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D037YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D038COEF': ['cos01_45_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D038DATA': ['cos01_45_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D038DEXP': [225.0, 'Drizzle, input image exposure time (s)'],
'D038EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D038FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D038GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D038INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D038INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D038INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D038KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D038LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D038MASK': ['cos01_45_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D038OUCO': ['', 'Drizzle, output context image'],
'D038OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D038OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D038OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D038OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D038OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D038PIXF': [0.8, 'Drizzle, linear size of drop'],
'D038SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D038VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D038WTSC': [390814.3, 'Drizzle, weighting factor for input image'],
...}
plt.imshow(ff['data'])
<matplotlib.image.AxesImage at 0x7ff2a5bbdd10>
Example 5: Storing multiple extensions#
The perspicacious reader will have noticed that the previous examples only dealt with extension 1 of the FITS file, leaving the primary header out of the ASDF file. There is no prescribed way to arrange the multiple extensions of a FITS file into an ASDF file. One option would be to create a separate dictionary for each extension and then make a dictionary of these, e.g.:
ext1, ext2 = dict(**header0), dict(**header1)
tree = {'ext1':ext1, 'ext2':ext2}
In this case, that would be a bit silly, because the only information of potential value in the ASDF file might be the ORIGIN, DATE, PROC_VER, RA_OBJ
and DEC_OBJ
. However, looking at the extension, there is an ORIGIN
there that will conflict with the ORIGIN
. (Somewhat amusingly, they have different meanings, according to the comments.)
header0
SIMPLE = T / conforms to FITS standard
BITPIX = 8 / array data type
NAXIS = 0 / number of array dimensions
EXTEND = T
ORIGIN = 'STScI/MAST' / institution responsible for creating this file
DATE = '2023-12-20' / file creation date
PROCVER = '0.10.0 ' / software version
RA_OBJ = 150.0946 / [deg] right ascension
DEC_OBJ = 2.38681 / [deg] declination
CHECKSUM= 'Wj6BZg6AWg6AWg6A' / HDU checksum updated 2023-12-20T17:59:45
DATASUM = '0 ' / data unit checksum updated 2023-12-20T17:59:45
One solution to the naming conflict might be to stuff this extra information into its own namespace, as a sub-item of the original dictionary.
keywords = ['ORIGIN', 'DATE', 'PROCVER', 'RA_OBJ', 'DEC_OBJ']
primary_header = {}
for card in header0.cards:
if card[0] in keywords:
primary_header[card[0]] = (card[1], card[2])
ff.tree['primary_header'] = primary_header
ff.tree
{'asdf_library': {'author': 'The ASDF Developers',
'homepage': 'http://github.com/asdf-format/asdf',
'name': 'asdf',
'version': '3.0.1'},
'history': {'extensions': [{'extension_class': 'asdf.extension._manifest.ManifestExtension',
'extension_uri': 'asdf://asdf-format.org/core/extensions/core-1.5.0',
'software': {'name': 'asdf', 'version': '3.0.1'}}]},
'': ['', ''],
'APERTURE': ['WFC', 'aperture name'],
'ASN_ID': ['JBOA28010', 'unique identifier assigned to association'],
'ASN_MTYP': ['EXP-DTH', 'Role of the Member in the Association'],
'ASN_TAB': ['jboa28010_asn.fits', 'name of the association table'],
'ATODCORR': ['OMIT', 'correct for A to D conversion errors'],
'ATODGNA': [2.02, 'calibrated gain for amplifier A'],
'ATODGNB': [1.886, 'calibrated gain for amplifier B'],
'ATODGNC': [2.017, 'calibrated gain for amplifier C'],
'ATODGND': [2.0109999, 'calibrated gain for amplifier D'],
'ATODTAB': ['jref$t3n1116mj_a2d.fits', 'analog to digital correction file'],
'A_0_2': [2.26194120304176e-06, ''],
'A_0_3': [6.51050854317125e-11, ''],
'A_0_4': [1.35191449346299e-13, ''],
'A_1_1': [-7.5302905463753e-06, ''],
'A_1_2': [-5.2539201413375e-10, ''],
'A_1_3': [-1.4269338401366e-14, ''],
'A_2_0': [8.51886870532632e-06, ''],
'A_2_1': [-1.0714004130419e-10, ''],
'A_2_2': [9.70199603291834e-14, ''],
'A_3_0': [-4.6936360210189e-10, ''],
'A_3_1': [3.80059786170717e-14, ''],
'A_4_0': [1.83627862287182e-14, ''],
'A_ORDER': [4, ''],
'BADINPDQ': [0, 'data quality flag bits to reject'],
'BIASCORR': ['COMPLETE', 'Subtract bias image'],
'BIASFILE': ['jref$vbh1844rj_bia.fits', 'bias image file name'],
'BIASLEVA': [2088.5564, 'bias level for amplifier A'],
'BIASLEVB': [2140.5024, 'bias level for amplifier B'],
'BIASLEVC': [2208.7419, 'bias level for amplifier C'],
'BIASLEVD': [2296.7388, 'bias level for amplifier D'],
'BINAXIS1': [1, 'axis1 data bin size in unbinned detector pixels'],
'BINAXIS2': [1, 'axis2 data bin size in unbinned detector pixels'],
'BLEVCORR': ['COMPLETE', 'subtract bias level computed from overscan img'],
'BPIXTAB': ['jref$t3n1116nj_bpx.fits', 'bad pixel table'],
'BSTRCORR': ['COMPLETE', ''],
'BUNIT': ['ELECTRONS', 'brightness units'],
'B_0_2': [-9.7985788387639e-06, ''],
'B_0_3': [-4.1421499542394e-10, ''],
'B_0_4': [-1.5248974790417e-13, ''],
'B_1_1': [6.42569986264533e-06, ''],
'B_1_2': [-3.0354276197375e-11, ''],
'B_1_3': [2.75911271664302e-14, ''],
'B_2_0': [-2.9658922285423e-06, ''],
'B_2_1': [-4.4034927976003e-10, ''],
'B_2_2': [-1.0403607372429e-13, ''],
'B_3_0': [9.00334210115821e-11, ''],
'B_3_1': [-3.8363933112663e-14, ''],
'B_4_0': [-1.6913942054528e-14, ''],
'B_ORDER': [4, ''],
'CAL_VER': ['5.1.1 (27-Apr-2010)', 'CALACS code version'],
'CBLKSIZ': [0, 'size of compression block in 2-byte words'],
'CCDAMP': ['ABCD', 'CCD Amplifier Readout Configuration'],
'CCDCHIP': [1, 'CCD chip (1 or 2)'],
'CCDGAIN': [2.0, 'commanded gain of CCD'],
'CCDOFSTA': [1, 'commanded CCD bias offset for amplifier A'],
'CCDOFSTB': [1, 'commanded CCD bias offset for amplifier B'],
'CCDOFSTC': [1, 'commanded CCD bias offset for amplifier C'],
'CCDOFSTD': [1, 'commanded CCD bias offset for amplifier D'],
'CCDTAB': ['jref$uc82140bj_ccd.fits', 'CCD calibration parameters'],
'CD1_1': [-8.333333e-06, ''],
'CD1_2': [0.0, ''],
'CD2_1': [0.0, ''],
'CD2_2': [8.333333e-06, ''],
'CDELT1': [1.0, '[deg] Coordinate increment at reference point'],
'CDELT2': [1.0, '[deg] Coordinate increment at reference point'],
'CENTERA1': [2073, 'subarray axis1 center pt in unbinned dect. pix'],
'CENTERA2': [1035, 'subarray axis2 center pt in unbinned dect. pix'],
'CFLTFILE': ['N/A', 'Coronagraphic spot image'],
'COMPTAB': ['mtab$vb71653dm_tmc.fits', 'the HST components table'],
'COMPTYP': ['None', 'compression type performed (Partial/Full/None)'],
'CRCORR': ['OMIT', 'combine observations to reject cosmic rays'],
'CRMASK': [False, 'flag CR-rejected pixels in input files (T/F)'],
'CRPIX1': [-2552.5, 'Pixel coordinate of reference point'],
'CRPIX2': [-22248.5, 'Pixel coordinate of reference point'],
'CRRADIUS': [0.0, 'rejection propagation radius (pixels)'],
'CRREJTAB': ['jref$n4e12511j_crr.fits', 'cosmic ray rejection parameters'],
'CRSIGMAS': ['', 'statistical rejection criteria'],
'CRSPLIT': [1, 'number of cosmic ray split exposures'],
'CRTHRESH': [0.0, 'rejection propagation threshold'],
'CRVAL1': [150.1163213, '[deg] Coordinate value at reference point'],
'CRVAL2': [2.200973097, '[deg] Coordinate value at reference point'],
'CTEDIR': ['NONE', 'CTE measurement direction: serial or parallel'],
'CTEIMAGE': ['NONE', 'type of Charge Transfer Image, if applicable'],
'CTYPE1': ['RA---TAN', 'Right ascension, gnomonic projection'],
'CTYPE2': ['DEC--TAN', 'Declination, gnomonic projection'],
'CUNIT1': ['deg', 'Units of coordinate increment and value'],
'CUNIT2': ['deg', 'Units of coordinate increment and value'],
'D001COEF': ['cos01_28_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D001DATA': ['cos01_28_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D001DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D001EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D001FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D001GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D001INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D001INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D001INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D001KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D001LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D001MASK': ['cos01_28_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D001OUCO': ['', 'Drizzle, output context image'],
'D001OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D001OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D001OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D001OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D001OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D001PIXF': [0.8, 'Drizzle, linear size of drop'],
'D001SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D001VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D001WTSC': [583770.1, 'Drizzle, weighting factor for input image'],
'D001XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D001YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D002COEF': ['cos01_28_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D002DATA': ['cos01_28_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D002DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D002EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D002FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D002GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D002INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D002INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D002INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D002KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D002LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D002MASK': ['cos01_28_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D002OUCO': ['', 'Drizzle, output context image'],
'D002OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D002OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D002OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D002OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D002OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D002PIXF': [0.8, 'Drizzle, linear size of drop'],
'D002SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D002VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D002WTSC': [3858213.0, 'Drizzle, weighting factor for input image'],
'D002XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D002YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D003COEF': ['cos01_29_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D003DATA': ['cos01_29_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D003DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D003EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D003FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D003GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D003INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D003INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D003INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D003KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D003LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D003MASK': ['cos01_29_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D003OUCO': ['', 'Drizzle, output context image'],
'D003OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D003OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D003OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D003OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D003OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D003PIXF': [0.8, 'Drizzle, linear size of drop'],
'D003SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D003VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D003WTSC': [583802.2, 'Drizzle, weighting factor for input image'],
'D003XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D003YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D004COEF': ['cos01_29_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D004DATA': ['cos01_29_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D004DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D004EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D004FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D004GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D004INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D004INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D004INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D004KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D004LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D004MASK': ['cos01_29_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D004OUCO': ['', 'Drizzle, output context image'],
'D004OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D004OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D004OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D004OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D004OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D004PIXF': [0.8, 'Drizzle, linear size of drop'],
'D004SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D004VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D004WTSC': [3858522.0, 'Drizzle, weighting factor for input image'],
'D004XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D004YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D005COEF': ['cos01_30_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D005DATA': ['cos01_30_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D005DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D005EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D005FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D005GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D005INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D005INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D005INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D005KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D005LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D005MASK': ['cos01_30_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D005OUCO': ['', 'Drizzle, output context image'],
'D005OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D005OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D005OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D005OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D005OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D005PIXF': [0.8, 'Drizzle, linear size of drop'],
'D005SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D005VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D005WTSC': [583802.4, 'Drizzle, weighting factor for input image'],
'D005XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D005YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D006COEF': ['cos01_30_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D006DATA': ['cos01_30_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D006DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D006EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D006FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D006GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D006INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D006INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D006INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D006KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D006LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D006MASK': ['cos01_30_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D006OUCO': ['', 'Drizzle, output context image'],
'D006OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D006OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D006OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D006OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D006OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D006PIXF': [0.8, 'Drizzle, linear size of drop'],
'D006SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D006VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D006WTSC': [3858522.0, 'Drizzle, weighting factor for input image'],
'D006XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D006YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D007COEF': ['cos01_32_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D007DATA': ['cos01_32_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D007DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D007EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D007FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D007GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D007INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D007INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D007INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D007KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D007LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D007MASK': ['cos01_32_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D007OUCO': ['', 'Drizzle, output context image'],
'D007OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D007OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D007OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D007OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D007OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D007PIXF': [0.8, 'Drizzle, linear size of drop'],
'D007SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D007VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D007WTSC': [583801.9, 'Drizzle, weighting factor for input image'],
'D007XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D007YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D008COEF': ['cos01_32_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D008DATA': ['cos01_32_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D008DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D008EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D008FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D008GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D008INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D008INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D008INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D008KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D008LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D008MASK': ['cos01_32_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D008OUCO': ['', 'Drizzle, output context image'],
'D008OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D008OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D008OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D008OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D008OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D008PIXF': [0.8, 'Drizzle, linear size of drop'],
'D008SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D008VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D008WTSC': [3858506.0, 'Drizzle, weighting factor for input image'],
'D008XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D008YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D009COEF': ['cos01_33_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D009DATA': ['cos01_33_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'],
'D009DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D009EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D009FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D009GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D009INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D009INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D009INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D009KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D009LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D009MASK': ['cos01_33_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D009OUCO': ['', 'Drizzle, output context image'],
'D009OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D009OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D009OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D009OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D009OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D009PIXF': [0.8, 'Drizzle, linear size of drop'],
'D009SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D009VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D009WTSC': [583803.6, 'Drizzle, weighting factor for input image'],
'D009XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D009YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D010COEF': ['cos01_33_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D010DATA': ['cos01_33_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D010DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D010EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D010FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D010GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D010INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D010INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D010INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D010KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D010LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D010MASK': ['cos01_33_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D010OUCO': ['', 'Drizzle, output context image'],
'D010OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D010OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D010OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D010OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D010OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D010PIXF': [0.8, 'Drizzle, linear size of drop'],
'D010SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D010VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D010WTSC': [583803.6, 'Drizzle, weighting factor for input image'],
'D010XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D010YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D011COEF': ['cos01_33_f606w_2_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D011DATA': ['cos01_33_f606w_2_flt_sci1_final.fits',
'Drizzle, input data image'],
'D011DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D011EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D011FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D011GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D011INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D011INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D011INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D011KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D011LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D011MASK': ['cos01_33_f606w_2_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D011OUCO': ['', 'Drizzle, output context image'],
'D011OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D011OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D011OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D011OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D011OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D011PIXF': [0.8, 'Drizzle, linear size of drop'],
'D011SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D011VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D011WTSC': [3858528.0, 'Drizzle, weighting factor for input image'],
'D011XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D011YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D012COEF': ['cos01_33_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D012DATA': ['cos01_33_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D012DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D012EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D012FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D012GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D012INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D012INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D012INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D012KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D012LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D012MASK': ['cos01_33_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D012OUCO': ['', 'Drizzle, output context image'],
'D012OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D012OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D012OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D012OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D012OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D012PIXF': [0.8, 'Drizzle, linear size of drop'],
'D012SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D012VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D012WTSC': [3858528.0, 'Drizzle, weighting factor for input image'],
'D012XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D012YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D013COEF': ['cos01_34_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D013DATA': ['cos01_34_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'],
'D013DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D013EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D013FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D013GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D013INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D013INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D013INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D013KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D013LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D013MASK': ['cos01_34_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D013OUCO': ['', 'Drizzle, output context image'],
'D013OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D013OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D013OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D013OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D013OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D013PIXF': [0.8, 'Drizzle, linear size of drop'],
'D013SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D013VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D013WTSC': [583803.6, 'Drizzle, weighting factor for input image'],
'D013XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D013YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D014COEF': ['cos01_34_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D014DATA': ['cos01_34_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D014DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D014EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D014FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D014GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D014INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D014INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D014INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D014KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D014LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D014MASK': ['cos01_34_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D014OUCO': ['', 'Drizzle, output context image'],
'D014OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D014OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D014OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D014OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D014OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D014PIXF': [0.8, 'Drizzle, linear size of drop'],
'D014SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D014VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D014WTSC': [583803.6, 'Drizzle, weighting factor for input image'],
'D014XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D014YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D015COEF': ['cos01_34_f606w_2_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D015DATA': ['cos01_34_f606w_2_flt_sci1_final.fits',
'Drizzle, input data image'],
'D015DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D015EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D015FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D015GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D015INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D015INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D015INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D015KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D015LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D015MASK': ['cos01_34_f606w_2_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D015OUCO': ['', 'Drizzle, output context image'],
'D015OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D015OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D015OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D015OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D015OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D015PIXF': [0.8, 'Drizzle, linear size of drop'],
'D015SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D015VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D015WTSC': [3858529.0, 'Drizzle, weighting factor for input image'],
'D015XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D015YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D016COEF': ['cos01_34_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D016DATA': ['cos01_34_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D016DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D016EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D016FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D016GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D016INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D016INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D016INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D016KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D016LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D016MASK': ['cos01_34_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D016OUCO': ['', 'Drizzle, output context image'],
'D016OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D016OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D016OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D016OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D016OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D016PIXF': [0.8, 'Drizzle, linear size of drop'],
'D016SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D016VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D016WTSC': [3858529.0, 'Drizzle, weighting factor for input image'],
'D016XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D016YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D017COEF': ['cos01_36_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D017DATA': ['cos01_36_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D017DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D017EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D017FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D017GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D017INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D017INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D017INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D017KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D017LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D017MASK': ['cos01_36_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D017OUCO': ['', 'Drizzle, output context image'],
'D017OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D017OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D017OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D017OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D017OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D017PIXF': [0.8, 'Drizzle, linear size of drop'],
'D017SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D017VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D017WTSC': [583804.3, 'Drizzle, weighting factor for input image'],
'D017XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D017YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D018COEF': ['cos01_36_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D018DATA': ['cos01_36_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D018DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D018EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D018FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D018GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D018INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D018INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D018INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D018KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D018LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D018MASK': ['cos01_36_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D018OUCO': ['', 'Drizzle, output context image'],
'D018OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D018OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D018OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D018OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D018OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D018PIXF': [0.8, 'Drizzle, linear size of drop'],
'D018SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D018VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D018WTSC': [3858532.0, 'Drizzle, weighting factor for input image'],
'D018XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D018YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D019COEF': ['cos01_37_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D019DATA': ['cos01_37_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'],
'D019DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D019EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D019FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D019GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D019INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D019INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D019INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D019KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D019LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D019MASK': ['cos01_37_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D019OUCO': ['', 'Drizzle, output context image'],
'D019OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D019OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D019OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D019OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D019OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D019PIXF': [0.8, 'Drizzle, linear size of drop'],
'D019SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D019VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D019WTSC': [583796.7, 'Drizzle, weighting factor for input image'],
'D019XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D019YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D020COEF': ['cos01_37_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D020DATA': ['cos01_37_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D020DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D020EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D020FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D020GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D020INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D020INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D020INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D020KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D020LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D020MASK': ['cos01_37_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D020OUCO': ['', 'Drizzle, output context image'],
'D020OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D020OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D020OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D020OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D020OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D020PIXF': [0.8, 'Drizzle, linear size of drop'],
'D020SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D020VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D020WTSC': [583796.7, 'Drizzle, weighting factor for input image'],
'D020XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D020YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D021COEF': ['cos01_37_f606w_2_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D021DATA': ['cos01_37_f606w_2_flt_sci1_final.fits',
'Drizzle, input data image'],
'D021DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D021EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D021FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D021GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D021INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D021INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D021INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D021KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D021LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D021MASK': ['cos01_37_f606w_2_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D021OUCO': ['', 'Drizzle, output context image'],
'D021OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D021OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D021OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D021OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D021OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D021PIXF': [0.8, 'Drizzle, linear size of drop'],
'D021SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D021VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D021WTSC': [3858427.0, 'Drizzle, weighting factor for input image'],
'D021XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D021YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D022COEF': ['cos01_37_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D022DATA': ['cos01_37_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D022DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D022EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D022FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D022GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D022INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D022INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D022INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D022KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D022LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D022MASK': ['cos01_37_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D022OUCO': ['', 'Drizzle, output context image'],
'D022OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D022OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D022OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D022OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D022OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D022PIXF': [0.8, 'Drizzle, linear size of drop'],
'D022SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D022VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D022WTSC': [3858427.0, 'Drizzle, weighting factor for input image'],
'D022XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D022YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D023COEF': ['cos01_38_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D023DATA': ['cos01_38_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'],
'D023DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D023EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D023FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D023GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D023INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D023INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D023INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D023KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D023LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D023MASK': ['cos01_38_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D023OUCO': ['', 'Drizzle, output context image'],
'D023OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D023OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D023OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D023OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D023OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D023PIXF': [0.8, 'Drizzle, linear size of drop'],
'D023SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D023VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D023WTSC': [583805.7, 'Drizzle, weighting factor for input image'],
'D023XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D023YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D024COEF': ['cos01_38_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D024DATA': ['cos01_38_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D024DEXP': [275.0, 'Drizzle, input image exposure time (s)'],
'D024EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D024FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D024GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D024INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D024INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D024INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D024KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D024LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D024MASK': ['cos01_38_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D024OUCO': ['', 'Drizzle, output context image'],
'D024OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D024OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D024OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D024OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D024OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D024PIXF': [0.8, 'Drizzle, linear size of drop'],
'D024SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D024VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D024WTSC': [583805.7, 'Drizzle, weighting factor for input image'],
'D024XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D024YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D025COEF': ['cos01_38_f606w_2_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D025DATA': ['cos01_38_f606w_2_flt_sci1_final.fits',
'Drizzle, input data image'],
'D025DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D025EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D025FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D025GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D025INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D025INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D025INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D025KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D025LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D025MASK': ['cos01_38_f606w_2_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D025OUCO': ['', 'Drizzle, output context image'],
'D025OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D025OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D025OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D025OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D025OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D025PIXF': [0.8, 'Drizzle, linear size of drop'],
'D025SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D025VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D025WTSC': [3858539.0, 'Drizzle, weighting factor for input image'],
'D025XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D025YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D026COEF': ['cos01_38_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D026DATA': ['cos01_38_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D026DEXP': [707.0, 'Drizzle, input image exposure time (s)'],
'D026EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D026FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D026GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D026INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D026INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D026INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D026KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D026LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D026MASK': ['cos01_38_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D026OUCO': ['', 'Drizzle, output context image'],
'D026OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D026OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D026OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D026OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D026OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D026PIXF': [0.8, 'Drizzle, linear size of drop'],
'D026SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D026VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D026WTSC': [3858539.0, 'Drizzle, weighting factor for input image'],
'D026XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D026YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D027COEF': ['cos01_40_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D027DATA': ['cos01_40_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D027DEXP': [225.0, 'Drizzle, input image exposure time (s)'],
'D027EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D027FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D027GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D027INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D027INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D027INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D027KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D027LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D027MASK': ['cos01_40_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D027OUCO': ['', 'Drizzle, output context image'],
'D027OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D027OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D027OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D027OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D027OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D027PIXF': [0.8, 'Drizzle, linear size of drop'],
'D027SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D027VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D027WTSC': [390803.6, 'Drizzle, weighting factor for input image'],
'D027XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D027YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D028COEF': ['cos01_40_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D028DATA': ['cos01_40_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D028DEXP': [407.0, 'Drizzle, input image exposure time (s)'],
'D028EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D028FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D028GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D028INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D028INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D028INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D028KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D028LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D028MASK': ['cos01_40_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D028OUCO': ['', 'Drizzle, output context image'],
'D028OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D028OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D028OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D028OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D028OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D028PIXF': [0.8, 'Drizzle, linear size of drop'],
'D028SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D028VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D028WTSC': [1278684.0, 'Drizzle, weighting factor for input image'],
'D028XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D028YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D029COEF': ['cos01_41_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D029DATA': ['cos01_41_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'],
'D029DEXP': [225.0, 'Drizzle, input image exposure time (s)'],
'D029EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D029FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D029GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D029INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D029INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D029INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D029KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D029LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D029MASK': ['cos01_41_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D029OUCO': ['', 'Drizzle, output context image'],
'D029OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D029OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D029OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D029OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D029OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D029PIXF': [0.8, 'Drizzle, linear size of drop'],
'D029SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D029VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D029WTSC': [390813.4, 'Drizzle, weighting factor for input image'],
'D029XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D029YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D030COEF': ['cos01_41_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D030DATA': ['cos01_41_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D030DEXP': [225.0, 'Drizzle, input image exposure time (s)'],
'D030EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D030FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D030GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D030INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D030INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D030INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D030KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D030LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D030MASK': ['cos01_41_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D030OUCO': ['', 'Drizzle, output context image'],
'D030OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D030OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D030OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D030OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D030OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D030PIXF': [0.8, 'Drizzle, linear size of drop'],
'D030SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D030VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D030WTSC': [390813.4, 'Drizzle, weighting factor for input image'],
'D030XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D030YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D031COEF': ['cos01_41_f606w_2_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D031DATA': ['cos01_41_f606w_2_flt_sci1_final.fits',
'Drizzle, input data image'],
'D031DEXP': [407.0, 'Drizzle, input image exposure time (s)'],
'D031EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D031FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D031GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D031INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D031INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D031INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D031KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D031LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D031MASK': ['cos01_41_f606w_2_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D031OUCO': ['', 'Drizzle, output context image'],
'D031OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D031OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D031OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D031OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D031OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D031PIXF': [0.8, 'Drizzle, linear size of drop'],
'D031SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D031VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D031WTSC': [1278740.0, 'Drizzle, weighting factor for input image'],
'D031XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D031YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D032COEF': ['cos01_41_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D032DATA': ['cos01_41_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D032DEXP': [407.0, 'Drizzle, input image exposure time (s)'],
'D032EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D032FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D032GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D032INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D032INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D032INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D032KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D032LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D032MASK': ['cos01_41_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D032OUCO': ['', 'Drizzle, output context image'],
'D032OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D032OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D032OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D032OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D032OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D032PIXF': [0.8, 'Drizzle, linear size of drop'],
'D032SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D032VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D032WTSC': [1278740.0, 'Drizzle, weighting factor for input image'],
'D032XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D032YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D033COEF': ['cos01_42_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D033DATA': ['cos01_42_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'],
'D033DEXP': [225.0, 'Drizzle, input image exposure time (s)'],
'D033EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D033FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D033GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D033INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D033INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D033INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D033KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D033LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D033MASK': ['cos01_42_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D033OUCO': ['', 'Drizzle, output context image'],
'D033OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D033OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D033OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D033OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D033OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D033PIXF': [0.8, 'Drizzle, linear size of drop'],
'D033SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D033VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D033WTSC': [390813.7, 'Drizzle, weighting factor for input image'],
'D033XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D033YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D034COEF': ['cos01_42_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D034DATA': ['cos01_42_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D034DEXP': [225.0, 'Drizzle, input image exposure time (s)'],
'D034EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D034FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D034GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D034INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D034INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D034INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D034KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D034LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D034MASK': ['cos01_42_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D034OUCO': ['', 'Drizzle, output context image'],
'D034OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D034OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D034OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D034OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D034OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D034PIXF': [0.8, 'Drizzle, linear size of drop'],
'D034SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D034VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D034WTSC': [390813.7, 'Drizzle, weighting factor for input image'],
'D034XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D034YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D035COEF': ['cos01_42_f606w_2_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D035DATA': ['cos01_42_f606w_2_flt_sci1_final.fits',
'Drizzle, input data image'],
'D035DEXP': [407.0, 'Drizzle, input image exposure time (s)'],
'D035EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D035FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D035GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D035INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D035INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D035INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D035KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D035LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D035MASK': ['cos01_42_f606w_2_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D035OUCO': ['', 'Drizzle, output context image'],
'D035OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D035OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D035OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D035OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D035OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D035PIXF': [0.8, 'Drizzle, linear size of drop'],
'D035SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D035VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D035WTSC': [1278741.0, 'Drizzle, weighting factor for input image'],
'D035XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D035YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D036COEF': ['cos01_42_f606w_2_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D036DATA': ['cos01_42_f606w_2_flt_sci2_final.fits',
'Drizzle, input data image'],
'D036DEXP': [407.0, 'Drizzle, input image exposure time (s)'],
'D036EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D036FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D036GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D036INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D036INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D036INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D036KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D036LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D036MASK': ['cos01_42_f606w_2_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D036OUCO': ['', 'Drizzle, output context image'],
'D036OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D036OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D036OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D036OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D036OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D036PIXF': [0.8, 'Drizzle, linear size of drop'],
'D036SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D036VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D036WTSC': [1278741.0, 'Drizzle, weighting factor for input image'],
'D036XGIM': ['jref$qbu16424j_dxy.fits[DX,2]',
'Drizzle, X distortion image name'],
'D036YGIM': ['jref$qbu16424j_dxy.fits[DY,2]',
'Drizzle, Y distortion image name'],
'D037COEF': ['cos01_45_f606w_1_flt_coeffs2.dat',
'Drizzle, coefficients file name'],
'D037DATA': ['cos01_45_f606w_1_flt_sci1_final.fits',
'Drizzle, input data image'],
'D037DEXP': [225.0, 'Drizzle, input image exposure time (s)'],
'D037EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D037FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D037GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D037INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D037INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D037INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D037KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D037LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D037MASK': ['cos01_45_f606w_1_flt_wht1_final.fits',
'Drizzle, input weighting imag'],
'D037OUCO': ['', 'Drizzle, output context image'],
'D037OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D037OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D037OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D037OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D037OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D037PIXF': [0.8, 'Drizzle, linear size of drop'],
'D037SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D037VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D037WTSC': [390814.3, 'Drizzle, weighting factor for input image'],
'D037XGIM': ['jref$qbu16424j_dxy.fits[DX,1]',
'Drizzle, X distortion image name'],
'D037YGIM': ['jref$qbu16424j_dxy.fits[DY,1]',
'Drizzle, Y distortion image name'],
'D038COEF': ['cos01_45_f606w_1_flt_coeffs1.dat',
'Drizzle, coefficients file name'],
'D038DATA': ['cos01_45_f606w_1_flt_sci2_final.fits',
'Drizzle, input data image'],
'D038DEXP': [225.0, 'Drizzle, input image exposure time (s)'],
'D038EXKY': ['exptime', 'Drizzle, exposure keyword name in input image'],
'D038FVAL': ['INDEF', 'Drizzle, fill value for zero weight output pixe'],
'D038GEOM': ['Header WCS', 'Drizzle, source of geometric information'],
'D038INUN': ['counts', 'Drizzle, units of input image - counts or cps'],
'D038INXC': [2049.0, 'Drizzle, reference center of input image (X)'],
'D038INYC': [1025.0, 'Drizzle, reference center of input image (Y)'],
'D038KERN': ['square', 'Drizzle, form of weight distribution kernel'],
'D038LAM': [555.0, 'Drizzle, wavelength applied for transformation'],
'D038MASK': ['cos01_45_f606w_1_flt_wht2_final.fits',
'Drizzle, input weighting imag'],
'D038OUCO': ['', 'Drizzle, output context image'],
'D038OUDA': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh',
'Drizzle,'],
'D038OUUN': ['cps', 'Drizzle, units of output image - counts or cps'],
'D038OUWE': ['tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh',
'Drizzle,'],
'D038OUXC': [7001.0, 'Drizzle, reference center of output image (X)'],
'D038OUYC': [7201.0, 'Drizzle, reference center of output image (Y)'],
'D038PIXF': [0.8, 'Drizzle, linear size of drop'],
'D038SECP': [False, 'Drizzle, there are no secondary geometric param'],
'D038VER': ['WDRIZZLE Version 3.4.2 (Jul 3rd 2006)', 'Drizzle, task version'],
'D038WTSC': [390814.3, 'Drizzle, weighting factor for input image'],
...}
Example 6: Converting from FITS WCS keywords to a gwcs object#
This is a bit complicated, and not particularly advantageous for this example.
The generalized world-coordinate system, gwcs package is built to support complex mappings between detector coordinates and coordinates. In this case it’s overkill. But it does illustrate saving a complex data object to an asdf
file. The gwcs
package extends asdf to specify the wcs
object. In doing so, it makes extensive use of the transforms that are defined in the asdf standard.
This example follows the instructions in the gwcs documentation. There is no rotation in this example, so we can follow the example that makes use of convenience function wcs_from_fiducial
.
Down the road there should be some convenience methods for converting common FITS WCSs and dealing gracefully with the (unfortunately quite common) inconsistencies.
For convenience, let’s use and astropy wcs object to grab the world-coordinate system information. This particular example reveals a problem that is quite common in FITS files: redundant and potentially inconsistent WCS information. In this case, the file is using both the PC matrix approach and the CD matrix approach. We’ll take the PC matrix as “truth”.
fitswcs = WCS(header1)
print(fitswcs)
INFO:
Inconsistent SIP distortion information is present in the FITS header and the WCS object:
SIP coefficients were detected, but CTYPE is missing a "-SIP" suffix.
astropy.wcs is using the SIP distortion coefficients,
therefore the coordinates calculated here might be incorrect.
If you do not want to apply the SIP distortion coefficients,
please remove the SIP coefficients from the FITS header or the
WCS object. As an example, if the image is already distortion-corrected
(e.g., drizzled) then distortion components should not apply and the SIP
coefficients should be removed.
While the SIP distortion coefficients are being applied here, if that was indeed the intent,
for consistency please append "-SIP" to the CTYPE in the FITS header or the WCS object.
[astropy.wcs.wcs]
WCS Keywords
Number of WCS axes: 2
CTYPE : 'RA---TAN' 'DEC--TAN'
CRVAL : 150.1163213 2.200973097
CRPIX : -2552.5 -22248.5
PC1_1 PC1_2 : -8.333333e-06 0.0
PC2_1 PC2_2 : 0.0 8.333333e-06
CDELT : 1.0 1.0
NAXIS : 100 100
/usr/share/miniconda/lib/python3.11/site-packages/astropy/wcs/wcs.py:3124: RuntimeWarning: cdelt will be ignored since cd is present
description.append(s.format(*self.wcs.cdelt))
Grab some values from the wcs for improved readability of cells further down
crval1, crval2 = fitswcs.wcs.crval
cunit1, cunit2 = [u.Unit(cu) for cu in fitswcs.wcs.cunit]
pcmatrix = fitswcs.wcs.pc
cunit1, cunit2
(Unit("deg"), Unit("deg"))
To create a WCS from a pointing on the sky, as a minimum pass a sky coordinate and a projection to the function.
fiducial = coord.SkyCoord(crval1*cunit1, crval2*cunit2, frame='icrs')
tan = models.Pix2Sky_TAN()
Create a pipeline for the coordinate transformations. In this case apply a shift and then a rescaling. The function wcs_from_fiducial
prepends these onto the sky projection.
trans = models.Shift(-crval1) & models.Shift(-crval2) |\
models.Scale(-pcmatrix[0, 0]) & models.Scale(pcmatrix[1, 1])
wcsobj = wcs_from_fiducial(fiducial, projection=tan, transform=trans)
wcsobj
<WCS(output_frame=CelestialFrame, input_frame=None, forward_transform=Model: CompoundModel
Inputs: ('x0', 'x1')
Outputs: ('alpha_C', 'delta_C')
Model set size: 1
Expression: [0] & [1] | [2] & [3] | [4] | [5]
Components:
[0]: <Shift(offset=-150.1163213)>
[1]: <Shift(offset=-2.2009731)>
[2]: <Scale(factor=0.00000833)>
[3]: <Scale(factor=0.00000833)>
[4]: <Pix2Sky_Gnomonic()>
[5]: <RotateNative2Celestial(lon=150.1163213 deg, lat=2.2009731 deg, lon_pole=180. deg)>
Parameters:
offset_0 offset_1 factor_2 ... lon_5 lat_5 lon_pole_5
... deg deg deg
------------ ------------ ------------ ... ----------- ----------- ----------
-150.1163213 -2.200973097 8.333333e-06 ... 150.1163213 2.200973097 180.0)>
Get rid of the now obsolete FITS WCS keywords from the ASDF header. It’s blissfully short, and one could argue devoid of almost anything useful.
fits_wcs_keywords = [
'CRPIX1', 'CRVAL1', 'CTYPE1', 'CD1_1', 'CD2_1', 'CRPIX2', 'CRVAL2',
'CTYPE2', 'CD1_2', 'CD2_2', 'WCSAXES', 'PC1_1', 'PC2_2', 'CDELT1',
'CDELT2', 'CUNIT1', 'CUNIT2', 'LONPOLE', 'LATPOLE', 'RADESYS']
[ff.tree.pop(old_kw, None) for old_kw in fits_wcs_keywords]
[[-2552.5, 'Pixel coordinate of reference point'],
[150.1163213, '[deg] Coordinate value at reference point'],
['RA---TAN', 'Right ascension, gnomonic projection'],
[-8.333333e-06, ''],
[0.0, ''],
[-22248.5, 'Pixel coordinate of reference point'],
[2.200973097, '[deg] Coordinate value at reference point'],
['DEC--TAN', 'Declination, gnomonic projection'],
[0.0, ''],
[8.333333e-06, ''],
[2, 'Number of coordinate axes'],
[-8.333333e-06, 'Coordinate transformation matrix element'],
[8.333333e-06, 'Coordinate transformation matrix element'],
[1.0, '[deg] Coordinate increment at reference point'],
[1.0, '[deg] Coordinate increment at reference point'],
['deg', 'Units of coordinate increment and value'],
['deg', 'Units of coordinate increment and value'],
[180.0, '[deg] Native longitude of celestial pole'],
[2.200973097, '[deg] Native latitude of celestial pole'],
['FK5', 'Equatorial coordinate system']]
Add the wcs object to the tree. The gwcs
package takes care of the machinery for serializing this object to ASDF.
ff.tree['wcs'] = wcsobj
t = tree_to_table(ff.tree)
t.show_in_notebook()
An error occured 0
An error occured 0
An error occured 0
An error occured 'WCS' object is not subscriptable
idx | key | value | comment or data structure |
---|---|---|---|
0 | asdf_library | None | {'author': 'The ASDF Developers', 'homepage': 'http://github.com/asdf-format/asdf', 'name': 'asdf', 'version': '3.0.1'} |
1 | history | None | {'extensions': [{'extension_class': 'asdf.extension._manifest.ManifestExtension', 'extension_uri': 'asdf://asdf-format.org/core/extensions/core-1.5.0', 'software': {'name': 'asdf', 'version': '3.0.1'}}]} |
2 | |||
3 | APERTURE | WFC | aperture name |
4 | ASN_ID | JBOA28010 | unique identifier assigned to association |
5 | ASN_MTYP | EXP-DTH | Role of the Member in the Association |
6 | ASN_TAB | jboa28010_asn.fits | name of the association table |
7 | ATODCORR | OMIT | correct for A to D conversion errors |
8 | ATODGNA | 2.02 | calibrated gain for amplifier A |
9 | ATODGNB | 1.886 | calibrated gain for amplifier B |
10 | ATODGNC | 2.017 | calibrated gain for amplifier C |
11 | ATODGND | 2.0109999 | calibrated gain for amplifier D |
12 | ATODTAB | jref$t3n1116mj_a2d.fits | analog to digital correction file |
13 | A_0_2 | 2.26194120304176e-06 | |
14 | A_0_3 | 6.51050854317125e-11 | |
15 | A_0_4 | 1.35191449346299e-13 | |
16 | A_1_1 | -7.5302905463753e-06 | |
17 | A_1_2 | -5.2539201413375e-10 | |
18 | A_1_3 | -1.4269338401366e-14 | |
19 | A_2_0 | 8.51886870532632e-06 | |
20 | A_2_1 | -1.0714004130419e-10 | |
21 | A_2_2 | 9.70199603291834e-14 | |
22 | A_3_0 | -4.6936360210189e-10 | |
23 | A_3_1 | 3.80059786170717e-14 | |
24 | A_4_0 | 1.83627862287182e-14 | |
25 | A_ORDER | 4 | |
26 | BADINPDQ | 0 | data quality flag bits to reject |
27 | BIASCORR | COMPLETE | Subtract bias image |
28 | BIASFILE | jref$vbh1844rj_bia.fits | bias image file name |
29 | BIASLEVA | 2088.5564 | bias level for amplifier A |
30 | BIASLEVB | 2140.5024 | bias level for amplifier B |
31 | BIASLEVC | 2208.7419 | bias level for amplifier C |
32 | BIASLEVD | 2296.7388 | bias level for amplifier D |
33 | BINAXIS1 | 1 | axis1 data bin size in unbinned detector pixels |
34 | BINAXIS2 | 1 | axis2 data bin size in unbinned detector pixels |
35 | BLEVCORR | COMPLETE | subtract bias level computed from overscan img |
36 | BPIXTAB | jref$t3n1116nj_bpx.fits | bad pixel table |
37 | BSTRCORR | COMPLETE | |
38 | BUNIT | ELECTRONS | brightness units |
39 | B_0_2 | -9.7985788387639e-06 | |
40 | B_0_3 | -4.1421499542394e-10 | |
41 | B_0_4 | -1.5248974790417e-13 | |
42 | B_1_1 | 6.42569986264533e-06 | |
43 | B_1_2 | -3.0354276197375e-11 | |
44 | B_1_3 | 2.75911271664302e-14 | |
45 | B_2_0 | -2.9658922285423e-06 | |
46 | B_2_1 | -4.4034927976003e-10 | |
47 | B_2_2 | -1.0403607372429e-13 | |
48 | B_3_0 | 9.00334210115821e-11 | |
49 | B_3_1 | -3.8363933112663e-14 | |
50 | B_4_0 | -1.6913942054528e-14 | |
51 | B_ORDER | 4 | |
52 | CAL_VER | 5.1.1 (27-Apr-2010) | CALACS code version |
53 | CBLKSIZ | 0 | size of compression block in 2-byte words |
54 | CCDAMP | ABCD | CCD Amplifier Readout Configuration |
55 | CCDCHIP | 1 | CCD chip (1 or 2) |
56 | CCDGAIN | 2.0 | commanded gain of CCD |
57 | CCDOFSTA | 1 | commanded CCD bias offset for amplifier A |
58 | CCDOFSTB | 1 | commanded CCD bias offset for amplifier B |
59 | CCDOFSTC | 1 | commanded CCD bias offset for amplifier C |
60 | CCDOFSTD | 1 | commanded CCD bias offset for amplifier D |
61 | CCDTAB | jref$uc82140bj_ccd.fits | CCD calibration parameters |
62 | CENTERA1 | 2073 | subarray axis1 center pt in unbinned dect. pix |
63 | CENTERA2 | 1035 | subarray axis2 center pt in unbinned dect. pix |
64 | CFLTFILE | N/A | Coronagraphic spot image |
65 | COMPTAB | mtab$vb71653dm_tmc.fits | the HST components table |
66 | COMPTYP | None | compression type performed (Partial/Full/None) |
67 | CRCORR | OMIT | combine observations to reject cosmic rays |
68 | CRMASK | False | flag CR-rejected pixels in input files (T/F) |
69 | CRRADIUS | 0.0 | rejection propagation radius (pixels) |
70 | CRREJTAB | jref$n4e12511j_crr.fits | cosmic ray rejection parameters |
71 | CRSIGMAS | statistical rejection criteria | |
72 | CRSPLIT | 1 | number of cosmic ray split exposures |
73 | CRTHRESH | 0.0 | rejection propagation threshold |
74 | CTEDIR | NONE | CTE measurement direction: serial or parallel |
75 | CTEIMAGE | NONE | type of Charge Transfer Image, if applicable |
76 | D001COEF | cos01_28_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
77 | D001DATA | cos01_28_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
78 | D001DEXP | 275.0 | Drizzle, input image exposure time (s) |
79 | D001EXKY | exptime | Drizzle, exposure keyword name in input image |
80 | D001FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
81 | D001GEOM | Header WCS | Drizzle, source of geometric information |
82 | D001INUN | counts | Drizzle, units of input image - counts or cps |
83 | D001INXC | 2049.0 | Drizzle, reference center of input image (X) |
84 | D001INYC | 1025.0 | Drizzle, reference center of input image (Y) |
85 | D001KERN | square | Drizzle, form of weight distribution kernel |
86 | D001LAM | 555.0 | Drizzle, wavelength applied for transformation |
87 | D001MASK | cos01_28_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
88 | D001OUCO | Drizzle, output context image | |
89 | D001OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
90 | D001OUUN | cps | Drizzle, units of output image - counts or cps |
91 | D001OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
92 | D001OUXC | 7001.0 | Drizzle, reference center of output image (X) |
93 | D001OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
94 | D001PIXF | 0.8 | Drizzle, linear size of drop |
95 | D001SECP | False | Drizzle, there are no secondary geometric param |
96 | D001VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
97 | D001WTSC | 583770.1 | Drizzle, weighting factor for input image |
98 | D001XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
99 | D001YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
100 | D002COEF | cos01_28_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
101 | D002DATA | cos01_28_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
102 | D002DEXP | 707.0 | Drizzle, input image exposure time (s) |
103 | D002EXKY | exptime | Drizzle, exposure keyword name in input image |
104 | D002FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
105 | D002GEOM | Header WCS | Drizzle, source of geometric information |
106 | D002INUN | counts | Drizzle, units of input image - counts or cps |
107 | D002INXC | 2049.0 | Drizzle, reference center of input image (X) |
108 | D002INYC | 1025.0 | Drizzle, reference center of input image (Y) |
109 | D002KERN | square | Drizzle, form of weight distribution kernel |
110 | D002LAM | 555.0 | Drizzle, wavelength applied for transformation |
111 | D002MASK | cos01_28_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
112 | D002OUCO | Drizzle, output context image | |
113 | D002OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
114 | D002OUUN | cps | Drizzle, units of output image - counts or cps |
115 | D002OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
116 | D002OUXC | 7001.0 | Drizzle, reference center of output image (X) |
117 | D002OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
118 | D002PIXF | 0.8 | Drizzle, linear size of drop |
119 | D002SECP | False | Drizzle, there are no secondary geometric param |
120 | D002VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
121 | D002WTSC | 3858213.0 | Drizzle, weighting factor for input image |
122 | D002XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
123 | D002YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
124 | D003COEF | cos01_29_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
125 | D003DATA | cos01_29_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
126 | D003DEXP | 275.0 | Drizzle, input image exposure time (s) |
127 | D003EXKY | exptime | Drizzle, exposure keyword name in input image |
128 | D003FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
129 | D003GEOM | Header WCS | Drizzle, source of geometric information |
130 | D003INUN | counts | Drizzle, units of input image - counts or cps |
131 | D003INXC | 2049.0 | Drizzle, reference center of input image (X) |
132 | D003INYC | 1025.0 | Drizzle, reference center of input image (Y) |
133 | D003KERN | square | Drizzle, form of weight distribution kernel |
134 | D003LAM | 555.0 | Drizzle, wavelength applied for transformation |
135 | D003MASK | cos01_29_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
136 | D003OUCO | Drizzle, output context image | |
137 | D003OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
138 | D003OUUN | cps | Drizzle, units of output image - counts or cps |
139 | D003OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
140 | D003OUXC | 7001.0 | Drizzle, reference center of output image (X) |
141 | D003OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
142 | D003PIXF | 0.8 | Drizzle, linear size of drop |
143 | D003SECP | False | Drizzle, there are no secondary geometric param |
144 | D003VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
145 | D003WTSC | 583802.2 | Drizzle, weighting factor for input image |
146 | D003XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
147 | D003YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
148 | D004COEF | cos01_29_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
149 | D004DATA | cos01_29_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
150 | D004DEXP | 707.0 | Drizzle, input image exposure time (s) |
151 | D004EXKY | exptime | Drizzle, exposure keyword name in input image |
152 | D004FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
153 | D004GEOM | Header WCS | Drizzle, source of geometric information |
154 | D004INUN | counts | Drizzle, units of input image - counts or cps |
155 | D004INXC | 2049.0 | Drizzle, reference center of input image (X) |
156 | D004INYC | 1025.0 | Drizzle, reference center of input image (Y) |
157 | D004KERN | square | Drizzle, form of weight distribution kernel |
158 | D004LAM | 555.0 | Drizzle, wavelength applied for transformation |
159 | D004MASK | cos01_29_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
160 | D004OUCO | Drizzle, output context image | |
161 | D004OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
162 | D004OUUN | cps | Drizzle, units of output image - counts or cps |
163 | D004OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
164 | D004OUXC | 7001.0 | Drizzle, reference center of output image (X) |
165 | D004OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
166 | D004PIXF | 0.8 | Drizzle, linear size of drop |
167 | D004SECP | False | Drizzle, there are no secondary geometric param |
168 | D004VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
169 | D004WTSC | 3858522.0 | Drizzle, weighting factor for input image |
170 | D004XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
171 | D004YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
172 | D005COEF | cos01_30_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
173 | D005DATA | cos01_30_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
174 | D005DEXP | 275.0 | Drizzle, input image exposure time (s) |
175 | D005EXKY | exptime | Drizzle, exposure keyword name in input image |
176 | D005FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
177 | D005GEOM | Header WCS | Drizzle, source of geometric information |
178 | D005INUN | counts | Drizzle, units of input image - counts or cps |
179 | D005INXC | 2049.0 | Drizzle, reference center of input image (X) |
180 | D005INYC | 1025.0 | Drizzle, reference center of input image (Y) |
181 | D005KERN | square | Drizzle, form of weight distribution kernel |
182 | D005LAM | 555.0 | Drizzle, wavelength applied for transformation |
183 | D005MASK | cos01_30_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
184 | D005OUCO | Drizzle, output context image | |
185 | D005OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
186 | D005OUUN | cps | Drizzle, units of output image - counts or cps |
187 | D005OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
188 | D005OUXC | 7001.0 | Drizzle, reference center of output image (X) |
189 | D005OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
190 | D005PIXF | 0.8 | Drizzle, linear size of drop |
191 | D005SECP | False | Drizzle, there are no secondary geometric param |
192 | D005VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
193 | D005WTSC | 583802.4 | Drizzle, weighting factor for input image |
194 | D005XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
195 | D005YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
196 | D006COEF | cos01_30_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
197 | D006DATA | cos01_30_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
198 | D006DEXP | 707.0 | Drizzle, input image exposure time (s) |
199 | D006EXKY | exptime | Drizzle, exposure keyword name in input image |
200 | D006FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
201 | D006GEOM | Header WCS | Drizzle, source of geometric information |
202 | D006INUN | counts | Drizzle, units of input image - counts or cps |
203 | D006INXC | 2049.0 | Drizzle, reference center of input image (X) |
204 | D006INYC | 1025.0 | Drizzle, reference center of input image (Y) |
205 | D006KERN | square | Drizzle, form of weight distribution kernel |
206 | D006LAM | 555.0 | Drizzle, wavelength applied for transformation |
207 | D006MASK | cos01_30_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
208 | D006OUCO | Drizzle, output context image | |
209 | D006OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
210 | D006OUUN | cps | Drizzle, units of output image - counts or cps |
211 | D006OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
212 | D006OUXC | 7001.0 | Drizzle, reference center of output image (X) |
213 | D006OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
214 | D006PIXF | 0.8 | Drizzle, linear size of drop |
215 | D006SECP | False | Drizzle, there are no secondary geometric param |
216 | D006VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
217 | D006WTSC | 3858522.0 | Drizzle, weighting factor for input image |
218 | D006XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
219 | D006YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
220 | D007COEF | cos01_32_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
221 | D007DATA | cos01_32_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
222 | D007DEXP | 275.0 | Drizzle, input image exposure time (s) |
223 | D007EXKY | exptime | Drizzle, exposure keyword name in input image |
224 | D007FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
225 | D007GEOM | Header WCS | Drizzle, source of geometric information |
226 | D007INUN | counts | Drizzle, units of input image - counts or cps |
227 | D007INXC | 2049.0 | Drizzle, reference center of input image (X) |
228 | D007INYC | 1025.0 | Drizzle, reference center of input image (Y) |
229 | D007KERN | square | Drizzle, form of weight distribution kernel |
230 | D007LAM | 555.0 | Drizzle, wavelength applied for transformation |
231 | D007MASK | cos01_32_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
232 | D007OUCO | Drizzle, output context image | |
233 | D007OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
234 | D007OUUN | cps | Drizzle, units of output image - counts or cps |
235 | D007OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
236 | D007OUXC | 7001.0 | Drizzle, reference center of output image (X) |
237 | D007OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
238 | D007PIXF | 0.8 | Drizzle, linear size of drop |
239 | D007SECP | False | Drizzle, there are no secondary geometric param |
240 | D007VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
241 | D007WTSC | 583801.9 | Drizzle, weighting factor for input image |
242 | D007XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
243 | D007YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
244 | D008COEF | cos01_32_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
245 | D008DATA | cos01_32_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
246 | D008DEXP | 707.0 | Drizzle, input image exposure time (s) |
247 | D008EXKY | exptime | Drizzle, exposure keyword name in input image |
248 | D008FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
249 | D008GEOM | Header WCS | Drizzle, source of geometric information |
250 | D008INUN | counts | Drizzle, units of input image - counts or cps |
251 | D008INXC | 2049.0 | Drizzle, reference center of input image (X) |
252 | D008INYC | 1025.0 | Drizzle, reference center of input image (Y) |
253 | D008KERN | square | Drizzle, form of weight distribution kernel |
254 | D008LAM | 555.0 | Drizzle, wavelength applied for transformation |
255 | D008MASK | cos01_32_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
256 | D008OUCO | Drizzle, output context image | |
257 | D008OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
258 | D008OUUN | cps | Drizzle, units of output image - counts or cps |
259 | D008OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
260 | D008OUXC | 7001.0 | Drizzle, reference center of output image (X) |
261 | D008OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
262 | D008PIXF | 0.8 | Drizzle, linear size of drop |
263 | D008SECP | False | Drizzle, there are no secondary geometric param |
264 | D008VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
265 | D008WTSC | 3858506.0 | Drizzle, weighting factor for input image |
266 | D008XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
267 | D008YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
268 | D009COEF | cos01_33_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
269 | D009DATA | cos01_33_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
270 | D009DEXP | 275.0 | Drizzle, input image exposure time (s) |
271 | D009EXKY | exptime | Drizzle, exposure keyword name in input image |
272 | D009FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
273 | D009GEOM | Header WCS | Drizzle, source of geometric information |
274 | D009INUN | counts | Drizzle, units of input image - counts or cps |
275 | D009INXC | 2049.0 | Drizzle, reference center of input image (X) |
276 | D009INYC | 1025.0 | Drizzle, reference center of input image (Y) |
277 | D009KERN | square | Drizzle, form of weight distribution kernel |
278 | D009LAM | 555.0 | Drizzle, wavelength applied for transformation |
279 | D009MASK | cos01_33_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
280 | D009OUCO | Drizzle, output context image | |
281 | D009OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
282 | D009OUUN | cps | Drizzle, units of output image - counts or cps |
283 | D009OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
284 | D009OUXC | 7001.0 | Drizzle, reference center of output image (X) |
285 | D009OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
286 | D009PIXF | 0.8 | Drizzle, linear size of drop |
287 | D009SECP | False | Drizzle, there are no secondary geometric param |
288 | D009VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
289 | D009WTSC | 583803.6 | Drizzle, weighting factor for input image |
290 | D009XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
291 | D009YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
292 | D010COEF | cos01_33_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
293 | D010DATA | cos01_33_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
294 | D010DEXP | 275.0 | Drizzle, input image exposure time (s) |
295 | D010EXKY | exptime | Drizzle, exposure keyword name in input image |
296 | D010FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
297 | D010GEOM | Header WCS | Drizzle, source of geometric information |
298 | D010INUN | counts | Drizzle, units of input image - counts or cps |
299 | D010INXC | 2049.0 | Drizzle, reference center of input image (X) |
300 | D010INYC | 1025.0 | Drizzle, reference center of input image (Y) |
301 | D010KERN | square | Drizzle, form of weight distribution kernel |
302 | D010LAM | 555.0 | Drizzle, wavelength applied for transformation |
303 | D010MASK | cos01_33_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
304 | D010OUCO | Drizzle, output context image | |
305 | D010OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
306 | D010OUUN | cps | Drizzle, units of output image - counts or cps |
307 | D010OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
308 | D010OUXC | 7001.0 | Drizzle, reference center of output image (X) |
309 | D010OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
310 | D010PIXF | 0.8 | Drizzle, linear size of drop |
311 | D010SECP | False | Drizzle, there are no secondary geometric param |
312 | D010VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
313 | D010WTSC | 583803.6 | Drizzle, weighting factor for input image |
314 | D010XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
315 | D010YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
316 | D011COEF | cos01_33_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
317 | D011DATA | cos01_33_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
318 | D011DEXP | 707.0 | Drizzle, input image exposure time (s) |
319 | D011EXKY | exptime | Drizzle, exposure keyword name in input image |
320 | D011FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
321 | D011GEOM | Header WCS | Drizzle, source of geometric information |
322 | D011INUN | counts | Drizzle, units of input image - counts or cps |
323 | D011INXC | 2049.0 | Drizzle, reference center of input image (X) |
324 | D011INYC | 1025.0 | Drizzle, reference center of input image (Y) |
325 | D011KERN | square | Drizzle, form of weight distribution kernel |
326 | D011LAM | 555.0 | Drizzle, wavelength applied for transformation |
327 | D011MASK | cos01_33_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
328 | D011OUCO | Drizzle, output context image | |
329 | D011OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
330 | D011OUUN | cps | Drizzle, units of output image - counts or cps |
331 | D011OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
332 | D011OUXC | 7001.0 | Drizzle, reference center of output image (X) |
333 | D011OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
334 | D011PIXF | 0.8 | Drizzle, linear size of drop |
335 | D011SECP | False | Drizzle, there are no secondary geometric param |
336 | D011VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
337 | D011WTSC | 3858528.0 | Drizzle, weighting factor for input image |
338 | D011XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
339 | D011YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
340 | D012COEF | cos01_33_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
341 | D012DATA | cos01_33_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
342 | D012DEXP | 707.0 | Drizzle, input image exposure time (s) |
343 | D012EXKY | exptime | Drizzle, exposure keyword name in input image |
344 | D012FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
345 | D012GEOM | Header WCS | Drizzle, source of geometric information |
346 | D012INUN | counts | Drizzle, units of input image - counts or cps |
347 | D012INXC | 2049.0 | Drizzle, reference center of input image (X) |
348 | D012INYC | 1025.0 | Drizzle, reference center of input image (Y) |
349 | D012KERN | square | Drizzle, form of weight distribution kernel |
350 | D012LAM | 555.0 | Drizzle, wavelength applied for transformation |
351 | D012MASK | cos01_33_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
352 | D012OUCO | Drizzle, output context image | |
353 | D012OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
354 | D012OUUN | cps | Drizzle, units of output image - counts or cps |
355 | D012OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
356 | D012OUXC | 7001.0 | Drizzle, reference center of output image (X) |
357 | D012OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
358 | D012PIXF | 0.8 | Drizzle, linear size of drop |
359 | D012SECP | False | Drizzle, there are no secondary geometric param |
360 | D012VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
361 | D012WTSC | 3858528.0 | Drizzle, weighting factor for input image |
362 | D012XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
363 | D012YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
364 | D013COEF | cos01_34_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
365 | D013DATA | cos01_34_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
366 | D013DEXP | 275.0 | Drizzle, input image exposure time (s) |
367 | D013EXKY | exptime | Drizzle, exposure keyword name in input image |
368 | D013FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
369 | D013GEOM | Header WCS | Drizzle, source of geometric information |
370 | D013INUN | counts | Drizzle, units of input image - counts or cps |
371 | D013INXC | 2049.0 | Drizzle, reference center of input image (X) |
372 | D013INYC | 1025.0 | Drizzle, reference center of input image (Y) |
373 | D013KERN | square | Drizzle, form of weight distribution kernel |
374 | D013LAM | 555.0 | Drizzle, wavelength applied for transformation |
375 | D013MASK | cos01_34_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
376 | D013OUCO | Drizzle, output context image | |
377 | D013OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
378 | D013OUUN | cps | Drizzle, units of output image - counts or cps |
379 | D013OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
380 | D013OUXC | 7001.0 | Drizzle, reference center of output image (X) |
381 | D013OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
382 | D013PIXF | 0.8 | Drizzle, linear size of drop |
383 | D013SECP | False | Drizzle, there are no secondary geometric param |
384 | D013VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
385 | D013WTSC | 583803.6 | Drizzle, weighting factor for input image |
386 | D013XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
387 | D013YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
388 | D014COEF | cos01_34_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
389 | D014DATA | cos01_34_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
390 | D014DEXP | 275.0 | Drizzle, input image exposure time (s) |
391 | D014EXKY | exptime | Drizzle, exposure keyword name in input image |
392 | D014FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
393 | D014GEOM | Header WCS | Drizzle, source of geometric information |
394 | D014INUN | counts | Drizzle, units of input image - counts or cps |
395 | D014INXC | 2049.0 | Drizzle, reference center of input image (X) |
396 | D014INYC | 1025.0 | Drizzle, reference center of input image (Y) |
397 | D014KERN | square | Drizzle, form of weight distribution kernel |
398 | D014LAM | 555.0 | Drizzle, wavelength applied for transformation |
399 | D014MASK | cos01_34_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
400 | D014OUCO | Drizzle, output context image | |
401 | D014OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
402 | D014OUUN | cps | Drizzle, units of output image - counts or cps |
403 | D014OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
404 | D014OUXC | 7001.0 | Drizzle, reference center of output image (X) |
405 | D014OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
406 | D014PIXF | 0.8 | Drizzle, linear size of drop |
407 | D014SECP | False | Drizzle, there are no secondary geometric param |
408 | D014VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
409 | D014WTSC | 583803.6 | Drizzle, weighting factor for input image |
410 | D014XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
411 | D014YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
412 | D015COEF | cos01_34_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
413 | D015DATA | cos01_34_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
414 | D015DEXP | 707.0 | Drizzle, input image exposure time (s) |
415 | D015EXKY | exptime | Drizzle, exposure keyword name in input image |
416 | D015FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
417 | D015GEOM | Header WCS | Drizzle, source of geometric information |
418 | D015INUN | counts | Drizzle, units of input image - counts or cps |
419 | D015INXC | 2049.0 | Drizzle, reference center of input image (X) |
420 | D015INYC | 1025.0 | Drizzle, reference center of input image (Y) |
421 | D015KERN | square | Drizzle, form of weight distribution kernel |
422 | D015LAM | 555.0 | Drizzle, wavelength applied for transformation |
423 | D015MASK | cos01_34_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
424 | D015OUCO | Drizzle, output context image | |
425 | D015OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
426 | D015OUUN | cps | Drizzle, units of output image - counts or cps |
427 | D015OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
428 | D015OUXC | 7001.0 | Drizzle, reference center of output image (X) |
429 | D015OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
430 | D015PIXF | 0.8 | Drizzle, linear size of drop |
431 | D015SECP | False | Drizzle, there are no secondary geometric param |
432 | D015VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
433 | D015WTSC | 3858529.0 | Drizzle, weighting factor for input image |
434 | D015XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
435 | D015YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
436 | D016COEF | cos01_34_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
437 | D016DATA | cos01_34_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
438 | D016DEXP | 707.0 | Drizzle, input image exposure time (s) |
439 | D016EXKY | exptime | Drizzle, exposure keyword name in input image |
440 | D016FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
441 | D016GEOM | Header WCS | Drizzle, source of geometric information |
442 | D016INUN | counts | Drizzle, units of input image - counts or cps |
443 | D016INXC | 2049.0 | Drizzle, reference center of input image (X) |
444 | D016INYC | 1025.0 | Drizzle, reference center of input image (Y) |
445 | D016KERN | square | Drizzle, form of weight distribution kernel |
446 | D016LAM | 555.0 | Drizzle, wavelength applied for transformation |
447 | D016MASK | cos01_34_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
448 | D016OUCO | Drizzle, output context image | |
449 | D016OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
450 | D016OUUN | cps | Drizzle, units of output image - counts or cps |
451 | D016OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
452 | D016OUXC | 7001.0 | Drizzle, reference center of output image (X) |
453 | D016OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
454 | D016PIXF | 0.8 | Drizzle, linear size of drop |
455 | D016SECP | False | Drizzle, there are no secondary geometric param |
456 | D016VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
457 | D016WTSC | 3858529.0 | Drizzle, weighting factor for input image |
458 | D016XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
459 | D016YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
460 | D017COEF | cos01_36_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
461 | D017DATA | cos01_36_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
462 | D017DEXP | 275.0 | Drizzle, input image exposure time (s) |
463 | D017EXKY | exptime | Drizzle, exposure keyword name in input image |
464 | D017FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
465 | D017GEOM | Header WCS | Drizzle, source of geometric information |
466 | D017INUN | counts | Drizzle, units of input image - counts or cps |
467 | D017INXC | 2049.0 | Drizzle, reference center of input image (X) |
468 | D017INYC | 1025.0 | Drizzle, reference center of input image (Y) |
469 | D017KERN | square | Drizzle, form of weight distribution kernel |
470 | D017LAM | 555.0 | Drizzle, wavelength applied for transformation |
471 | D017MASK | cos01_36_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
472 | D017OUCO | Drizzle, output context image | |
473 | D017OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
474 | D017OUUN | cps | Drizzle, units of output image - counts or cps |
475 | D017OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
476 | D017OUXC | 7001.0 | Drizzle, reference center of output image (X) |
477 | D017OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
478 | D017PIXF | 0.8 | Drizzle, linear size of drop |
479 | D017SECP | False | Drizzle, there are no secondary geometric param |
480 | D017VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
481 | D017WTSC | 583804.3 | Drizzle, weighting factor for input image |
482 | D017XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
483 | D017YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
484 | D018COEF | cos01_36_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
485 | D018DATA | cos01_36_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
486 | D018DEXP | 707.0 | Drizzle, input image exposure time (s) |
487 | D018EXKY | exptime | Drizzle, exposure keyword name in input image |
488 | D018FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
489 | D018GEOM | Header WCS | Drizzle, source of geometric information |
490 | D018INUN | counts | Drizzle, units of input image - counts or cps |
491 | D018INXC | 2049.0 | Drizzle, reference center of input image (X) |
492 | D018INYC | 1025.0 | Drizzle, reference center of input image (Y) |
493 | D018KERN | square | Drizzle, form of weight distribution kernel |
494 | D018LAM | 555.0 | Drizzle, wavelength applied for transformation |
495 | D018MASK | cos01_36_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
496 | D018OUCO | Drizzle, output context image | |
497 | D018OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
498 | D018OUUN | cps | Drizzle, units of output image - counts or cps |
499 | D018OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
500 | D018OUXC | 7001.0 | Drizzle, reference center of output image (X) |
501 | D018OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
502 | D018PIXF | 0.8 | Drizzle, linear size of drop |
503 | D018SECP | False | Drizzle, there are no secondary geometric param |
504 | D018VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
505 | D018WTSC | 3858532.0 | Drizzle, weighting factor for input image |
506 | D018XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
507 | D018YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
508 | D019COEF | cos01_37_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
509 | D019DATA | cos01_37_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
510 | D019DEXP | 275.0 | Drizzle, input image exposure time (s) |
511 | D019EXKY | exptime | Drizzle, exposure keyword name in input image |
512 | D019FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
513 | D019GEOM | Header WCS | Drizzle, source of geometric information |
514 | D019INUN | counts | Drizzle, units of input image - counts or cps |
515 | D019INXC | 2049.0 | Drizzle, reference center of input image (X) |
516 | D019INYC | 1025.0 | Drizzle, reference center of input image (Y) |
517 | D019KERN | square | Drizzle, form of weight distribution kernel |
518 | D019LAM | 555.0 | Drizzle, wavelength applied for transformation |
519 | D019MASK | cos01_37_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
520 | D019OUCO | Drizzle, output context image | |
521 | D019OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
522 | D019OUUN | cps | Drizzle, units of output image - counts or cps |
523 | D019OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
524 | D019OUXC | 7001.0 | Drizzle, reference center of output image (X) |
525 | D019OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
526 | D019PIXF | 0.8 | Drizzle, linear size of drop |
527 | D019SECP | False | Drizzle, there are no secondary geometric param |
528 | D019VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
529 | D019WTSC | 583796.7 | Drizzle, weighting factor for input image |
530 | D019XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
531 | D019YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
532 | D020COEF | cos01_37_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
533 | D020DATA | cos01_37_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
534 | D020DEXP | 275.0 | Drizzle, input image exposure time (s) |
535 | D020EXKY | exptime | Drizzle, exposure keyword name in input image |
536 | D020FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
537 | D020GEOM | Header WCS | Drizzle, source of geometric information |
538 | D020INUN | counts | Drizzle, units of input image - counts or cps |
539 | D020INXC | 2049.0 | Drizzle, reference center of input image (X) |
540 | D020INYC | 1025.0 | Drizzle, reference center of input image (Y) |
541 | D020KERN | square | Drizzle, form of weight distribution kernel |
542 | D020LAM | 555.0 | Drizzle, wavelength applied for transformation |
543 | D020MASK | cos01_37_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
544 | D020OUCO | Drizzle, output context image | |
545 | D020OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
546 | D020OUUN | cps | Drizzle, units of output image - counts or cps |
547 | D020OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
548 | D020OUXC | 7001.0 | Drizzle, reference center of output image (X) |
549 | D020OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
550 | D020PIXF | 0.8 | Drizzle, linear size of drop |
551 | D020SECP | False | Drizzle, there are no secondary geometric param |
552 | D020VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
553 | D020WTSC | 583796.7 | Drizzle, weighting factor for input image |
554 | D020XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
555 | D020YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
556 | D021COEF | cos01_37_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
557 | D021DATA | cos01_37_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
558 | D021DEXP | 707.0 | Drizzle, input image exposure time (s) |
559 | D021EXKY | exptime | Drizzle, exposure keyword name in input image |
560 | D021FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
561 | D021GEOM | Header WCS | Drizzle, source of geometric information |
562 | D021INUN | counts | Drizzle, units of input image - counts or cps |
563 | D021INXC | 2049.0 | Drizzle, reference center of input image (X) |
564 | D021INYC | 1025.0 | Drizzle, reference center of input image (Y) |
565 | D021KERN | square | Drizzle, form of weight distribution kernel |
566 | D021LAM | 555.0 | Drizzle, wavelength applied for transformation |
567 | D021MASK | cos01_37_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
568 | D021OUCO | Drizzle, output context image | |
569 | D021OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
570 | D021OUUN | cps | Drizzle, units of output image - counts or cps |
571 | D021OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
572 | D021OUXC | 7001.0 | Drizzle, reference center of output image (X) |
573 | D021OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
574 | D021PIXF | 0.8 | Drizzle, linear size of drop |
575 | D021SECP | False | Drizzle, there are no secondary geometric param |
576 | D021VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
577 | D021WTSC | 3858427.0 | Drizzle, weighting factor for input image |
578 | D021XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
579 | D021YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
580 | D022COEF | cos01_37_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
581 | D022DATA | cos01_37_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
582 | D022DEXP | 707.0 | Drizzle, input image exposure time (s) |
583 | D022EXKY | exptime | Drizzle, exposure keyword name in input image |
584 | D022FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
585 | D022GEOM | Header WCS | Drizzle, source of geometric information |
586 | D022INUN | counts | Drizzle, units of input image - counts or cps |
587 | D022INXC | 2049.0 | Drizzle, reference center of input image (X) |
588 | D022INYC | 1025.0 | Drizzle, reference center of input image (Y) |
589 | D022KERN | square | Drizzle, form of weight distribution kernel |
590 | D022LAM | 555.0 | Drizzle, wavelength applied for transformation |
591 | D022MASK | cos01_37_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
592 | D022OUCO | Drizzle, output context image | |
593 | D022OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
594 | D022OUUN | cps | Drizzle, units of output image - counts or cps |
595 | D022OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
596 | D022OUXC | 7001.0 | Drizzle, reference center of output image (X) |
597 | D022OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
598 | D022PIXF | 0.8 | Drizzle, linear size of drop |
599 | D022SECP | False | Drizzle, there are no secondary geometric param |
600 | D022VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
601 | D022WTSC | 3858427.0 | Drizzle, weighting factor for input image |
602 | D022XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
603 | D022YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
604 | D023COEF | cos01_38_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
605 | D023DATA | cos01_38_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
606 | D023DEXP | 275.0 | Drizzle, input image exposure time (s) |
607 | D023EXKY | exptime | Drizzle, exposure keyword name in input image |
608 | D023FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
609 | D023GEOM | Header WCS | Drizzle, source of geometric information |
610 | D023INUN | counts | Drizzle, units of input image - counts or cps |
611 | D023INXC | 2049.0 | Drizzle, reference center of input image (X) |
612 | D023INYC | 1025.0 | Drizzle, reference center of input image (Y) |
613 | D023KERN | square | Drizzle, form of weight distribution kernel |
614 | D023LAM | 555.0 | Drizzle, wavelength applied for transformation |
615 | D023MASK | cos01_38_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
616 | D023OUCO | Drizzle, output context image | |
617 | D023OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
618 | D023OUUN | cps | Drizzle, units of output image - counts or cps |
619 | D023OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
620 | D023OUXC | 7001.0 | Drizzle, reference center of output image (X) |
621 | D023OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
622 | D023PIXF | 0.8 | Drizzle, linear size of drop |
623 | D023SECP | False | Drizzle, there are no secondary geometric param |
624 | D023VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
625 | D023WTSC | 583805.7 | Drizzle, weighting factor for input image |
626 | D023XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
627 | D023YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
628 | D024COEF | cos01_38_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
629 | D024DATA | cos01_38_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
630 | D024DEXP | 275.0 | Drizzle, input image exposure time (s) |
631 | D024EXKY | exptime | Drizzle, exposure keyword name in input image |
632 | D024FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
633 | D024GEOM | Header WCS | Drizzle, source of geometric information |
634 | D024INUN | counts | Drizzle, units of input image - counts or cps |
635 | D024INXC | 2049.0 | Drizzle, reference center of input image (X) |
636 | D024INYC | 1025.0 | Drizzle, reference center of input image (Y) |
637 | D024KERN | square | Drizzle, form of weight distribution kernel |
638 | D024LAM | 555.0 | Drizzle, wavelength applied for transformation |
639 | D024MASK | cos01_38_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
640 | D024OUCO | Drizzle, output context image | |
641 | D024OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
642 | D024OUUN | cps | Drizzle, units of output image - counts or cps |
643 | D024OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
644 | D024OUXC | 7001.0 | Drizzle, reference center of output image (X) |
645 | D024OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
646 | D024PIXF | 0.8 | Drizzle, linear size of drop |
647 | D024SECP | False | Drizzle, there are no secondary geometric param |
648 | D024VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
649 | D024WTSC | 583805.7 | Drizzle, weighting factor for input image |
650 | D024XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
651 | D024YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
652 | D025COEF | cos01_38_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
653 | D025DATA | cos01_38_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
654 | D025DEXP | 707.0 | Drizzle, input image exposure time (s) |
655 | D025EXKY | exptime | Drizzle, exposure keyword name in input image |
656 | D025FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
657 | D025GEOM | Header WCS | Drizzle, source of geometric information |
658 | D025INUN | counts | Drizzle, units of input image - counts or cps |
659 | D025INXC | 2049.0 | Drizzle, reference center of input image (X) |
660 | D025INYC | 1025.0 | Drizzle, reference center of input image (Y) |
661 | D025KERN | square | Drizzle, form of weight distribution kernel |
662 | D025LAM | 555.0 | Drizzle, wavelength applied for transformation |
663 | D025MASK | cos01_38_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
664 | D025OUCO | Drizzle, output context image | |
665 | D025OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
666 | D025OUUN | cps | Drizzle, units of output image - counts or cps |
667 | D025OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
668 | D025OUXC | 7001.0 | Drizzle, reference center of output image (X) |
669 | D025OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
670 | D025PIXF | 0.8 | Drizzle, linear size of drop |
671 | D025SECP | False | Drizzle, there are no secondary geometric param |
672 | D025VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
673 | D025WTSC | 3858539.0 | Drizzle, weighting factor for input image |
674 | D025XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
675 | D025YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
676 | D026COEF | cos01_38_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
677 | D026DATA | cos01_38_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
678 | D026DEXP | 707.0 | Drizzle, input image exposure time (s) |
679 | D026EXKY | exptime | Drizzle, exposure keyword name in input image |
680 | D026FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
681 | D026GEOM | Header WCS | Drizzle, source of geometric information |
682 | D026INUN | counts | Drizzle, units of input image - counts or cps |
683 | D026INXC | 2049.0 | Drizzle, reference center of input image (X) |
684 | D026INYC | 1025.0 | Drizzle, reference center of input image (Y) |
685 | D026KERN | square | Drizzle, form of weight distribution kernel |
686 | D026LAM | 555.0 | Drizzle, wavelength applied for transformation |
687 | D026MASK | cos01_38_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
688 | D026OUCO | Drizzle, output context image | |
689 | D026OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
690 | D026OUUN | cps | Drizzle, units of output image - counts or cps |
691 | D026OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
692 | D026OUXC | 7001.0 | Drizzle, reference center of output image (X) |
693 | D026OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
694 | D026PIXF | 0.8 | Drizzle, linear size of drop |
695 | D026SECP | False | Drizzle, there are no secondary geometric param |
696 | D026VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
697 | D026WTSC | 3858539.0 | Drizzle, weighting factor for input image |
698 | D026XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
699 | D026YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
700 | D027COEF | cos01_40_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
701 | D027DATA | cos01_40_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
702 | D027DEXP | 225.0 | Drizzle, input image exposure time (s) |
703 | D027EXKY | exptime | Drizzle, exposure keyword name in input image |
704 | D027FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
705 | D027GEOM | Header WCS | Drizzle, source of geometric information |
706 | D027INUN | counts | Drizzle, units of input image - counts or cps |
707 | D027INXC | 2049.0 | Drizzle, reference center of input image (X) |
708 | D027INYC | 1025.0 | Drizzle, reference center of input image (Y) |
709 | D027KERN | square | Drizzle, form of weight distribution kernel |
710 | D027LAM | 555.0 | Drizzle, wavelength applied for transformation |
711 | D027MASK | cos01_40_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
712 | D027OUCO | Drizzle, output context image | |
713 | D027OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
714 | D027OUUN | cps | Drizzle, units of output image - counts or cps |
715 | D027OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
716 | D027OUXC | 7001.0 | Drizzle, reference center of output image (X) |
717 | D027OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
718 | D027PIXF | 0.8 | Drizzle, linear size of drop |
719 | D027SECP | False | Drizzle, there are no secondary geometric param |
720 | D027VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
721 | D027WTSC | 390803.6 | Drizzle, weighting factor for input image |
722 | D027XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
723 | D027YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
724 | D028COEF | cos01_40_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
725 | D028DATA | cos01_40_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
726 | D028DEXP | 407.0 | Drizzle, input image exposure time (s) |
727 | D028EXKY | exptime | Drizzle, exposure keyword name in input image |
728 | D028FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
729 | D028GEOM | Header WCS | Drizzle, source of geometric information |
730 | D028INUN | counts | Drizzle, units of input image - counts or cps |
731 | D028INXC | 2049.0 | Drizzle, reference center of input image (X) |
732 | D028INYC | 1025.0 | Drizzle, reference center of input image (Y) |
733 | D028KERN | square | Drizzle, form of weight distribution kernel |
734 | D028LAM | 555.0 | Drizzle, wavelength applied for transformation |
735 | D028MASK | cos01_40_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
736 | D028OUCO | Drizzle, output context image | |
737 | D028OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
738 | D028OUUN | cps | Drizzle, units of output image - counts or cps |
739 | D028OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
740 | D028OUXC | 7001.0 | Drizzle, reference center of output image (X) |
741 | D028OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
742 | D028PIXF | 0.8 | Drizzle, linear size of drop |
743 | D028SECP | False | Drizzle, there are no secondary geometric param |
744 | D028VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
745 | D028WTSC | 1278684.0 | Drizzle, weighting factor for input image |
746 | D028XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
747 | D028YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
748 | D029COEF | cos01_41_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
749 | D029DATA | cos01_41_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
750 | D029DEXP | 225.0 | Drizzle, input image exposure time (s) |
751 | D029EXKY | exptime | Drizzle, exposure keyword name in input image |
752 | D029FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
753 | D029GEOM | Header WCS | Drizzle, source of geometric information |
754 | D029INUN | counts | Drizzle, units of input image - counts or cps |
755 | D029INXC | 2049.0 | Drizzle, reference center of input image (X) |
756 | D029INYC | 1025.0 | Drizzle, reference center of input image (Y) |
757 | D029KERN | square | Drizzle, form of weight distribution kernel |
758 | D029LAM | 555.0 | Drizzle, wavelength applied for transformation |
759 | D029MASK | cos01_41_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
760 | D029OUCO | Drizzle, output context image | |
761 | D029OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
762 | D029OUUN | cps | Drizzle, units of output image - counts or cps |
763 | D029OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
764 | D029OUXC | 7001.0 | Drizzle, reference center of output image (X) |
765 | D029OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
766 | D029PIXF | 0.8 | Drizzle, linear size of drop |
767 | D029SECP | False | Drizzle, there are no secondary geometric param |
768 | D029VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
769 | D029WTSC | 390813.4 | Drizzle, weighting factor for input image |
770 | D029XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
771 | D029YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
772 | D030COEF | cos01_41_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
773 | D030DATA | cos01_41_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
774 | D030DEXP | 225.0 | Drizzle, input image exposure time (s) |
775 | D030EXKY | exptime | Drizzle, exposure keyword name in input image |
776 | D030FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
777 | D030GEOM | Header WCS | Drizzle, source of geometric information |
778 | D030INUN | counts | Drizzle, units of input image - counts or cps |
779 | D030INXC | 2049.0 | Drizzle, reference center of input image (X) |
780 | D030INYC | 1025.0 | Drizzle, reference center of input image (Y) |
781 | D030KERN | square | Drizzle, form of weight distribution kernel |
782 | D030LAM | 555.0 | Drizzle, wavelength applied for transformation |
783 | D030MASK | cos01_41_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
784 | D030OUCO | Drizzle, output context image | |
785 | D030OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
786 | D030OUUN | cps | Drizzle, units of output image - counts or cps |
787 | D030OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
788 | D030OUXC | 7001.0 | Drizzle, reference center of output image (X) |
789 | D030OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
790 | D030PIXF | 0.8 | Drizzle, linear size of drop |
791 | D030SECP | False | Drizzle, there are no secondary geometric param |
792 | D030VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
793 | D030WTSC | 390813.4 | Drizzle, weighting factor for input image |
794 | D030XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
795 | D030YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
796 | D031COEF | cos01_41_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
797 | D031DATA | cos01_41_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
798 | D031DEXP | 407.0 | Drizzle, input image exposure time (s) |
799 | D031EXKY | exptime | Drizzle, exposure keyword name in input image |
800 | D031FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
801 | D031GEOM | Header WCS | Drizzle, source of geometric information |
802 | D031INUN | counts | Drizzle, units of input image - counts or cps |
803 | D031INXC | 2049.0 | Drizzle, reference center of input image (X) |
804 | D031INYC | 1025.0 | Drizzle, reference center of input image (Y) |
805 | D031KERN | square | Drizzle, form of weight distribution kernel |
806 | D031LAM | 555.0 | Drizzle, wavelength applied for transformation |
807 | D031MASK | cos01_41_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
808 | D031OUCO | Drizzle, output context image | |
809 | D031OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
810 | D031OUUN | cps | Drizzle, units of output image - counts or cps |
811 | D031OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
812 | D031OUXC | 7001.0 | Drizzle, reference center of output image (X) |
813 | D031OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
814 | D031PIXF | 0.8 | Drizzle, linear size of drop |
815 | D031SECP | False | Drizzle, there are no secondary geometric param |
816 | D031VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
817 | D031WTSC | 1278740.0 | Drizzle, weighting factor for input image |
818 | D031XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
819 | D031YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
820 | D032COEF | cos01_41_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
821 | D032DATA | cos01_41_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
822 | D032DEXP | 407.0 | Drizzle, input image exposure time (s) |
823 | D032EXKY | exptime | Drizzle, exposure keyword name in input image |
824 | D032FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
825 | D032GEOM | Header WCS | Drizzle, source of geometric information |
826 | D032INUN | counts | Drizzle, units of input image - counts or cps |
827 | D032INXC | 2049.0 | Drizzle, reference center of input image (X) |
828 | D032INYC | 1025.0 | Drizzle, reference center of input image (Y) |
829 | D032KERN | square | Drizzle, form of weight distribution kernel |
830 | D032LAM | 555.0 | Drizzle, wavelength applied for transformation |
831 | D032MASK | cos01_41_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
832 | D032OUCO | Drizzle, output context image | |
833 | D032OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
834 | D032OUUN | cps | Drizzle, units of output image - counts or cps |
835 | D032OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
836 | D032OUXC | 7001.0 | Drizzle, reference center of output image (X) |
837 | D032OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
838 | D032PIXF | 0.8 | Drizzle, linear size of drop |
839 | D032SECP | False | Drizzle, there are no secondary geometric param |
840 | D032VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
841 | D032WTSC | 1278740.0 | Drizzle, weighting factor for input image |
842 | D032XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
843 | D032YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
844 | D033COEF | cos01_42_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
845 | D033DATA | cos01_42_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
846 | D033DEXP | 225.0 | Drizzle, input image exposure time (s) |
847 | D033EXKY | exptime | Drizzle, exposure keyword name in input image |
848 | D033FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
849 | D033GEOM | Header WCS | Drizzle, source of geometric information |
850 | D033INUN | counts | Drizzle, units of input image - counts or cps |
851 | D033INXC | 2049.0 | Drizzle, reference center of input image (X) |
852 | D033INYC | 1025.0 | Drizzle, reference center of input image (Y) |
853 | D033KERN | square | Drizzle, form of weight distribution kernel |
854 | D033LAM | 555.0 | Drizzle, wavelength applied for transformation |
855 | D033MASK | cos01_42_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
856 | D033OUCO | Drizzle, output context image | |
857 | D033OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
858 | D033OUUN | cps | Drizzle, units of output image - counts or cps |
859 | D033OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
860 | D033OUXC | 7001.0 | Drizzle, reference center of output image (X) |
861 | D033OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
862 | D033PIXF | 0.8 | Drizzle, linear size of drop |
863 | D033SECP | False | Drizzle, there are no secondary geometric param |
864 | D033VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
865 | D033WTSC | 390813.7 | Drizzle, weighting factor for input image |
866 | D033XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
867 | D033YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
868 | D034COEF | cos01_42_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
869 | D034DATA | cos01_42_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
870 | D034DEXP | 225.0 | Drizzle, input image exposure time (s) |
871 | D034EXKY | exptime | Drizzle, exposure keyword name in input image |
872 | D034FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
873 | D034GEOM | Header WCS | Drizzle, source of geometric information |
874 | D034INUN | counts | Drizzle, units of input image - counts or cps |
875 | D034INXC | 2049.0 | Drizzle, reference center of input image (X) |
876 | D034INYC | 1025.0 | Drizzle, reference center of input image (Y) |
877 | D034KERN | square | Drizzle, form of weight distribution kernel |
878 | D034LAM | 555.0 | Drizzle, wavelength applied for transformation |
879 | D034MASK | cos01_42_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
880 | D034OUCO | Drizzle, output context image | |
881 | D034OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
882 | D034OUUN | cps | Drizzle, units of output image - counts or cps |
883 | D034OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
884 | D034OUXC | 7001.0 | Drizzle, reference center of output image (X) |
885 | D034OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
886 | D034PIXF | 0.8 | Drizzle, linear size of drop |
887 | D034SECP | False | Drizzle, there are no secondary geometric param |
888 | D034VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
889 | D034WTSC | 390813.7 | Drizzle, weighting factor for input image |
890 | D034XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
891 | D034YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
892 | D035COEF | cos01_42_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
893 | D035DATA | cos01_42_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
894 | D035DEXP | 407.0 | Drizzle, input image exposure time (s) |
895 | D035EXKY | exptime | Drizzle, exposure keyword name in input image |
896 | D035FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
897 | D035GEOM | Header WCS | Drizzle, source of geometric information |
898 | D035INUN | counts | Drizzle, units of input image - counts or cps |
899 | D035INXC | 2049.0 | Drizzle, reference center of input image (X) |
900 | D035INYC | 1025.0 | Drizzle, reference center of input image (Y) |
901 | D035KERN | square | Drizzle, form of weight distribution kernel |
902 | D035LAM | 555.0 | Drizzle, wavelength applied for transformation |
903 | D035MASK | cos01_42_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
904 | D035OUCO | Drizzle, output context image | |
905 | D035OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
906 | D035OUUN | cps | Drizzle, units of output image - counts or cps |
907 | D035OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
908 | D035OUXC | 7001.0 | Drizzle, reference center of output image (X) |
909 | D035OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
910 | D035PIXF | 0.8 | Drizzle, linear size of drop |
911 | D035SECP | False | Drizzle, there are no secondary geometric param |
912 | D035VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
913 | D035WTSC | 1278741.0 | Drizzle, weighting factor for input image |
914 | D035XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
915 | D035YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
916 | D036COEF | cos01_42_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
917 | D036DATA | cos01_42_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
918 | D036DEXP | 407.0 | Drizzle, input image exposure time (s) |
919 | D036EXKY | exptime | Drizzle, exposure keyword name in input image |
920 | D036FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
921 | D036GEOM | Header WCS | Drizzle, source of geometric information |
922 | D036INUN | counts | Drizzle, units of input image - counts or cps |
923 | D036INXC | 2049.0 | Drizzle, reference center of input image (X) |
924 | D036INYC | 1025.0 | Drizzle, reference center of input image (Y) |
925 | D036KERN | square | Drizzle, form of weight distribution kernel |
926 | D036LAM | 555.0 | Drizzle, wavelength applied for transformation |
927 | D036MASK | cos01_42_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
928 | D036OUCO | Drizzle, output context image | |
929 | D036OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
930 | D036OUUN | cps | Drizzle, units of output image - counts or cps |
931 | D036OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
932 | D036OUXC | 7001.0 | Drizzle, reference center of output image (X) |
933 | D036OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
934 | D036PIXF | 0.8 | Drizzle, linear size of drop |
935 | D036SECP | False | Drizzle, there are no secondary geometric param |
936 | D036VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
937 | D036WTSC | 1278741.0 | Drizzle, weighting factor for input image |
938 | D036XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
939 | D036YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
940 | D037COEF | cos01_45_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
941 | D037DATA | cos01_45_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
942 | D037DEXP | 225.0 | Drizzle, input image exposure time (s) |
943 | D037EXKY | exptime | Drizzle, exposure keyword name in input image |
944 | D037FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
945 | D037GEOM | Header WCS | Drizzle, source of geometric information |
946 | D037INUN | counts | Drizzle, units of input image - counts or cps |
947 | D037INXC | 2049.0 | Drizzle, reference center of input image (X) |
948 | D037INYC | 1025.0 | Drizzle, reference center of input image (Y) |
949 | D037KERN | square | Drizzle, form of weight distribution kernel |
950 | D037LAM | 555.0 | Drizzle, wavelength applied for transformation |
951 | D037MASK | cos01_45_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
952 | D037OUCO | Drizzle, output context image | |
953 | D037OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
954 | D037OUUN | cps | Drizzle, units of output image - counts or cps |
955 | D037OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
956 | D037OUXC | 7001.0 | Drizzle, reference center of output image (X) |
957 | D037OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
958 | D037PIXF | 0.8 | Drizzle, linear size of drop |
959 | D037SECP | False | Drizzle, there are no secondary geometric param |
960 | D037VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
961 | D037WTSC | 390814.3 | Drizzle, weighting factor for input image |
962 | D037XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
963 | D037YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
964 | D038COEF | cos01_45_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
965 | D038DATA | cos01_45_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
966 | D038DEXP | 225.0 | Drizzle, input image exposure time (s) |
967 | D038EXKY | exptime | Drizzle, exposure keyword name in input image |
968 | D038FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
969 | D038GEOM | Header WCS | Drizzle, source of geometric information |
970 | D038INUN | counts | Drizzle, units of input image - counts or cps |
971 | D038INXC | 2049.0 | Drizzle, reference center of input image (X) |
972 | D038INYC | 1025.0 | Drizzle, reference center of input image (Y) |
973 | D038KERN | square | Drizzle, form of weight distribution kernel |
974 | D038LAM | 555.0 | Drizzle, wavelength applied for transformation |
975 | D038MASK | cos01_45_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
976 | D038OUCO | Drizzle, output context image | |
977 | D038OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
978 | D038OUUN | cps | Drizzle, units of output image - counts or cps |
979 | D038OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
980 | D038OUXC | 7001.0 | Drizzle, reference center of output image (X) |
981 | D038OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
982 | D038PIXF | 0.8 | Drizzle, linear size of drop |
983 | D038SECP | False | Drizzle, there are no secondary geometric param |
984 | D038VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
985 | D038WTSC | 390814.3 | Drizzle, weighting factor for input image |
986 | D038XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
987 | D038YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
988 | D039COEF | cos01_45_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
989 | D039DATA | cos01_45_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
990 | D039DEXP | 407.0 | Drizzle, input image exposure time (s) |
991 | D039EXKY | exptime | Drizzle, exposure keyword name in input image |
992 | D039FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
993 | D039GEOM | Header WCS | Drizzle, source of geometric information |
994 | D039INUN | counts | Drizzle, units of input image - counts or cps |
995 | D039INXC | 2049.0 | Drizzle, reference center of input image (X) |
996 | D039INYC | 1025.0 | Drizzle, reference center of input image (Y) |
997 | D039KERN | square | Drizzle, form of weight distribution kernel |
998 | D039LAM | 555.0 | Drizzle, wavelength applied for transformation |
999 | D039MASK | cos01_45_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
1000 | D039OUCO | Drizzle, output context image | |
1001 | D039OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1002 | D039OUUN | cps | Drizzle, units of output image - counts or cps |
1003 | D039OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1004 | D039OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1005 | D039OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1006 | D039PIXF | 0.8 | Drizzle, linear size of drop |
1007 | D039SECP | False | Drizzle, there are no secondary geometric param |
1008 | D039VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1009 | D039WTSC | 1278743.0 | Drizzle, weighting factor for input image |
1010 | D039XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1011 | D039YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1012 | D040COEF | cos01_45_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1013 | D040DATA | cos01_45_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1014 | D040DEXP | 407.0 | Drizzle, input image exposure time (s) |
1015 | D040EXKY | exptime | Drizzle, exposure keyword name in input image |
1016 | D040FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1017 | D040GEOM | Header WCS | Drizzle, source of geometric information |
1018 | D040INUN | counts | Drizzle, units of input image - counts or cps |
1019 | D040INXC | 2049.0 | Drizzle, reference center of input image (X) |
1020 | D040INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1021 | D040KERN | square | Drizzle, form of weight distribution kernel |
1022 | D040LAM | 555.0 | Drizzle, wavelength applied for transformation |
1023 | D040MASK | cos01_45_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1024 | D040OUCO | Drizzle, output context image | |
1025 | D040OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1026 | D040OUUN | cps | Drizzle, units of output image - counts or cps |
1027 | D040OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1028 | D040OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1029 | D040OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1030 | D040PIXF | 0.8 | Drizzle, linear size of drop |
1031 | D040SECP | False | Drizzle, there are no secondary geometric param |
1032 | D040VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1033 | D040WTSC | 1278743.0 | Drizzle, weighting factor for input image |
1034 | D040XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1035 | D040YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1036 | D041COEF | cos01_46_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
1037 | D041DATA | cos01_46_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
1038 | D041DEXP | 225.0 | Drizzle, input image exposure time (s) |
1039 | D041EXKY | exptime | Drizzle, exposure keyword name in input image |
1040 | D041FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1041 | D041GEOM | Header WCS | Drizzle, source of geometric information |
1042 | D041INUN | counts | Drizzle, units of input image - counts or cps |
1043 | D041INXC | 2049.0 | Drizzle, reference center of input image (X) |
1044 | D041INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1045 | D041KERN | square | Drizzle, form of weight distribution kernel |
1046 | D041LAM | 555.0 | Drizzle, wavelength applied for transformation |
1047 | D041MASK | cos01_46_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
1048 | D041OUCO | Drizzle, output context image | |
1049 | D041OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1050 | D041OUUN | cps | Drizzle, units of output image - counts or cps |
1051 | D041OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1052 | D041OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1053 | D041OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1054 | D041PIXF | 0.8 | Drizzle, linear size of drop |
1055 | D041SECP | False | Drizzle, there are no secondary geometric param |
1056 | D041VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1057 | D041WTSC | 390814.0 | Drizzle, weighting factor for input image |
1058 | D041XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1059 | D041YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1060 | D042COEF | cos01_46_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1061 | D042DATA | cos01_46_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1062 | D042DEXP | 225.0 | Drizzle, input image exposure time (s) |
1063 | D042EXKY | exptime | Drizzle, exposure keyword name in input image |
1064 | D042FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1065 | D042GEOM | Header WCS | Drizzle, source of geometric information |
1066 | D042INUN | counts | Drizzle, units of input image - counts or cps |
1067 | D042INXC | 2049.0 | Drizzle, reference center of input image (X) |
1068 | D042INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1069 | D042KERN | square | Drizzle, form of weight distribution kernel |
1070 | D042LAM | 555.0 | Drizzle, wavelength applied for transformation |
1071 | D042MASK | cos01_46_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1072 | D042OUCO | Drizzle, output context image | |
1073 | D042OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1074 | D042OUUN | cps | Drizzle, units of output image - counts or cps |
1075 | D042OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1076 | D042OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1077 | D042OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1078 | D042PIXF | 0.8 | Drizzle, linear size of drop |
1079 | D042SECP | False | Drizzle, there are no secondary geometric param |
1080 | D042VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1081 | D042WTSC | 390814.0 | Drizzle, weighting factor for input image |
1082 | D042XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1083 | D042YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1084 | D043COEF | cos01_46_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
1085 | D043DATA | cos01_46_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
1086 | D043DEXP | 407.0 | Drizzle, input image exposure time (s) |
1087 | D043EXKY | exptime | Drizzle, exposure keyword name in input image |
1088 | D043FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1089 | D043GEOM | Header WCS | Drizzle, source of geometric information |
1090 | D043INUN | counts | Drizzle, units of input image - counts or cps |
1091 | D043INXC | 2049.0 | Drizzle, reference center of input image (X) |
1092 | D043INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1093 | D043KERN | square | Drizzle, form of weight distribution kernel |
1094 | D043LAM | 555.0 | Drizzle, wavelength applied for transformation |
1095 | D043MASK | cos01_46_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
1096 | D043OUCO | Drizzle, output context image | |
1097 | D043OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1098 | D043OUUN | cps | Drizzle, units of output image - counts or cps |
1099 | D043OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1100 | D043OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1101 | D043OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1102 | D043PIXF | 0.8 | Drizzle, linear size of drop |
1103 | D043SECP | False | Drizzle, there are no secondary geometric param |
1104 | D043VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1105 | D043WTSC | 1278739.0 | Drizzle, weighting factor for input image |
1106 | D043XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1107 | D043YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1108 | D044COEF | cos01_46_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1109 | D044DATA | cos01_46_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1110 | D044DEXP | 407.0 | Drizzle, input image exposure time (s) |
1111 | D044EXKY | exptime | Drizzle, exposure keyword name in input image |
1112 | D044FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1113 | D044GEOM | Header WCS | Drizzle, source of geometric information |
1114 | D044INUN | counts | Drizzle, units of input image - counts or cps |
1115 | D044INXC | 2049.0 | Drizzle, reference center of input image (X) |
1116 | D044INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1117 | D044KERN | square | Drizzle, form of weight distribution kernel |
1118 | D044LAM | 555.0 | Drizzle, wavelength applied for transformation |
1119 | D044MASK | cos01_46_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1120 | D044OUCO | Drizzle, output context image | |
1121 | D044OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1122 | D044OUUN | cps | Drizzle, units of output image - counts or cps |
1123 | D044OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1124 | D044OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1125 | D044OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1126 | D044PIXF | 0.8 | Drizzle, linear size of drop |
1127 | D044SECP | False | Drizzle, there are no secondary geometric param |
1128 | D044VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1129 | D044WTSC | 1278739.0 | Drizzle, weighting factor for input image |
1130 | D044XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1131 | D044YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1132 | D045COEF | cos01_49_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
1133 | D045DATA | cos01_49_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
1134 | D045DEXP | 225.0 | Drizzle, input image exposure time (s) |
1135 | D045EXKY | exptime | Drizzle, exposure keyword name in input image |
1136 | D045FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1137 | D045GEOM | Header WCS | Drizzle, source of geometric information |
1138 | D045INUN | counts | Drizzle, units of input image - counts or cps |
1139 | D045INXC | 2049.0 | Drizzle, reference center of input image (X) |
1140 | D045INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1141 | D045KERN | square | Drizzle, form of weight distribution kernel |
1142 | D045LAM | 555.0 | Drizzle, wavelength applied for transformation |
1143 | D045MASK | cos01_49_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
1144 | D045OUCO | Drizzle, output context image | |
1145 | D045OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1146 | D045OUUN | cps | Drizzle, units of output image - counts or cps |
1147 | D045OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1148 | D045OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1149 | D045OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1150 | D045PIXF | 0.8 | Drizzle, linear size of drop |
1151 | D045SECP | False | Drizzle, there are no secondary geometric param |
1152 | D045VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1153 | D045WTSC | 390814.1 | Drizzle, weighting factor for input image |
1154 | D045XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1155 | D045YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1156 | D046COEF | cos01_49_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
1157 | D046DATA | cos01_49_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
1158 | D046DEXP | 407.0 | Drizzle, input image exposure time (s) |
1159 | D046EXKY | exptime | Drizzle, exposure keyword name in input image |
1160 | D046FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1161 | D046GEOM | Header WCS | Drizzle, source of geometric information |
1162 | D046INUN | counts | Drizzle, units of input image - counts or cps |
1163 | D046INXC | 2049.0 | Drizzle, reference center of input image (X) |
1164 | D046INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1165 | D046KERN | square | Drizzle, form of weight distribution kernel |
1166 | D046LAM | 555.0 | Drizzle, wavelength applied for transformation |
1167 | D046MASK | cos01_49_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
1168 | D046OUCO | Drizzle, output context image | |
1169 | D046OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1170 | D046OUUN | cps | Drizzle, units of output image - counts or cps |
1171 | D046OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1172 | D046OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1173 | D046OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1174 | D046PIXF | 0.8 | Drizzle, linear size of drop |
1175 | D046SECP | False | Drizzle, there are no secondary geometric param |
1176 | D046VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1177 | D046WTSC | 1278740.0 | Drizzle, weighting factor for input image |
1178 | D046XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1179 | D046YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1180 | D047COEF | cos01_50_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
1181 | D047DATA | cos01_50_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
1182 | D047DEXP | 225.0 | Drizzle, input image exposure time (s) |
1183 | D047EXKY | exptime | Drizzle, exposure keyword name in input image |
1184 | D047FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1185 | D047GEOM | Header WCS | Drizzle, source of geometric information |
1186 | D047INUN | counts | Drizzle, units of input image - counts or cps |
1187 | D047INXC | 2049.0 | Drizzle, reference center of input image (X) |
1188 | D047INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1189 | D047KERN | square | Drizzle, form of weight distribution kernel |
1190 | D047LAM | 555.0 | Drizzle, wavelength applied for transformation |
1191 | D047MASK | cos01_50_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
1192 | D047OUCO | Drizzle, output context image | |
1193 | D047OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1194 | D047OUUN | cps | Drizzle, units of output image - counts or cps |
1195 | D047OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1196 | D047OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1197 | D047OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1198 | D047PIXF | 0.8 | Drizzle, linear size of drop |
1199 | D047SECP | False | Drizzle, there are no secondary geometric param |
1200 | D047VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1201 | D047WTSC | 390814.2 | Drizzle, weighting factor for input image |
1202 | D047XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1203 | D047YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1204 | D048COEF | cos01_50_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1205 | D048DATA | cos01_50_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1206 | D048DEXP | 225.0 | Drizzle, input image exposure time (s) |
1207 | D048EXKY | exptime | Drizzle, exposure keyword name in input image |
1208 | D048FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1209 | D048GEOM | Header WCS | Drizzle, source of geometric information |
1210 | D048INUN | counts | Drizzle, units of input image - counts or cps |
1211 | D048INXC | 2049.0 | Drizzle, reference center of input image (X) |
1212 | D048INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1213 | D048KERN | square | Drizzle, form of weight distribution kernel |
1214 | D048LAM | 555.0 | Drizzle, wavelength applied for transformation |
1215 | D048MASK | cos01_50_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1216 | D048OUCO | Drizzle, output context image | |
1217 | D048OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1218 | D048OUUN | cps | Drizzle, units of output image - counts or cps |
1219 | D048OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1220 | D048OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1221 | D048OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1222 | D048PIXF | 0.8 | Drizzle, linear size of drop |
1223 | D048SECP | False | Drizzle, there are no secondary geometric param |
1224 | D048VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1225 | D048WTSC | 390814.2 | Drizzle, weighting factor for input image |
1226 | D048XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1227 | D048YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1228 | D049COEF | cos01_50_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
1229 | D049DATA | cos01_50_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
1230 | D049DEXP | 407.0 | Drizzle, input image exposure time (s) |
1231 | D049EXKY | exptime | Drizzle, exposure keyword name in input image |
1232 | D049FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1233 | D049GEOM | Header WCS | Drizzle, source of geometric information |
1234 | D049INUN | counts | Drizzle, units of input image - counts or cps |
1235 | D049INXC | 2049.0 | Drizzle, reference center of input image (X) |
1236 | D049INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1237 | D049KERN | square | Drizzle, form of weight distribution kernel |
1238 | D049LAM | 555.0 | Drizzle, wavelength applied for transformation |
1239 | D049MASK | cos01_50_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
1240 | D049OUCO | Drizzle, output context image | |
1241 | D049OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1242 | D049OUUN | cps | Drizzle, units of output image - counts or cps |
1243 | D049OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1244 | D049OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1245 | D049OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1246 | D049PIXF | 0.8 | Drizzle, linear size of drop |
1247 | D049SECP | False | Drizzle, there are no secondary geometric param |
1248 | D049VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1249 | D049WTSC | 1278740.0 | Drizzle, weighting factor for input image |
1250 | D049XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1251 | D049YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1252 | D050COEF | cos01_50_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1253 | D050DATA | cos01_50_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1254 | D050DEXP | 407.0 | Drizzle, input image exposure time (s) |
1255 | D050EXKY | exptime | Drizzle, exposure keyword name in input image |
1256 | D050FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1257 | D050GEOM | Header WCS | Drizzle, source of geometric information |
1258 | D050INUN | counts | Drizzle, units of input image - counts or cps |
1259 | D050INXC | 2049.0 | Drizzle, reference center of input image (X) |
1260 | D050INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1261 | D050KERN | square | Drizzle, form of weight distribution kernel |
1262 | D050LAM | 555.0 | Drizzle, wavelength applied for transformation |
1263 | D050MASK | cos01_50_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1264 | D050OUCO | Drizzle, output context image | |
1265 | D050OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1266 | D050OUUN | cps | Drizzle, units of output image - counts or cps |
1267 | D050OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1268 | D050OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1269 | D050OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1270 | D050PIXF | 0.8 | Drizzle, linear size of drop |
1271 | D050SECP | False | Drizzle, there are no secondary geometric param |
1272 | D050VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1273 | D050WTSC | 1278740.0 | Drizzle, weighting factor for input image |
1274 | D050XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1275 | D050YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1276 | D051COEF | cos02_72_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1277 | D051DATA | cos02_72_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1278 | D051DEXP | 275.0 | Drizzle, input image exposure time (s) |
1279 | D051EXKY | exptime | Drizzle, exposure keyword name in input image |
1280 | D051FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1281 | D051GEOM | Header WCS | Drizzle, source of geometric information |
1282 | D051INUN | counts | Drizzle, units of input image - counts or cps |
1283 | D051INXC | 2049.0 | Drizzle, reference center of input image (X) |
1284 | D051INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1285 | D051KERN | square | Drizzle, form of weight distribution kernel |
1286 | D051LAM | 555.0 | Drizzle, wavelength applied for transformation |
1287 | D051MASK | cos02_72_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1288 | D051OUCO | Drizzle, output context image | |
1289 | D051OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1290 | D051OUUN | cps | Drizzle, units of output image - counts or cps |
1291 | D051OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1292 | D051OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1293 | D051OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1294 | D051PIXF | 0.8 | Drizzle, linear size of drop |
1295 | D051SECP | False | Drizzle, there are no secondary geometric param |
1296 | D051VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1297 | D051WTSC | 583572.3 | Drizzle, weighting factor for input image |
1298 | D051XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1299 | D051YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1300 | D052COEF | cos02_72_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1301 | D052DATA | cos02_72_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1302 | D052DEXP | 407.0 | Drizzle, input image exposure time (s) |
1303 | D052EXKY | exptime | Drizzle, exposure keyword name in input image |
1304 | D052FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1305 | D052GEOM | Header WCS | Drizzle, source of geometric information |
1306 | D052INUN | counts | Drizzle, units of input image - counts or cps |
1307 | D052INXC | 2049.0 | Drizzle, reference center of input image (X) |
1308 | D052INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1309 | D052KERN | square | Drizzle, form of weight distribution kernel |
1310 | D052LAM | 555.0 | Drizzle, wavelength applied for transformation |
1311 | D052MASK | cos02_72_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1312 | D052OUCO | Drizzle, output context image | |
1313 | D052OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1314 | D052OUUN | cps | Drizzle, units of output image - counts or cps |
1315 | D052OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1316 | D052OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1317 | D052OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1318 | D052PIXF | 0.8 | Drizzle, linear size of drop |
1319 | D052SECP | False | Drizzle, there are no secondary geometric param |
1320 | D052VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1321 | D052WTSC | 1278505.0 | Drizzle, weighting factor for input image |
1322 | D052XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1323 | D052YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1324 | D053COEF | cos02_73_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1325 | D053DATA | cos02_73_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1326 | D053DEXP | 275.0 | Drizzle, input image exposure time (s) |
1327 | D053EXKY | exptime | Drizzle, exposure keyword name in input image |
1328 | D053FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1329 | D053GEOM | Header WCS | Drizzle, source of geometric information |
1330 | D053INUN | counts | Drizzle, units of input image - counts or cps |
1331 | D053INXC | 2049.0 | Drizzle, reference center of input image (X) |
1332 | D053INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1333 | D053KERN | square | Drizzle, form of weight distribution kernel |
1334 | D053LAM | 555.0 | Drizzle, wavelength applied for transformation |
1335 | D053MASK | cos02_73_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1336 | D053OUCO | Drizzle, output context image | |
1337 | D053OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1338 | D053OUUN | cps | Drizzle, units of output image - counts or cps |
1339 | D053OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1340 | D053OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1341 | D053OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1342 | D053PIXF | 0.8 | Drizzle, linear size of drop |
1343 | D053SECP | False | Drizzle, there are no secondary geometric param |
1344 | D053VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1345 | D053WTSC | 583662.8 | Drizzle, weighting factor for input image |
1346 | D053XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1347 | D053YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1348 | D054COEF | cos02_73_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1349 | D054DATA | cos02_73_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1350 | D054DEXP | 407.0 | Drizzle, input image exposure time (s) |
1351 | D054EXKY | exptime | Drizzle, exposure keyword name in input image |
1352 | D054FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1353 | D054GEOM | Header WCS | Drizzle, source of geometric information |
1354 | D054INUN | counts | Drizzle, units of input image - counts or cps |
1355 | D054INXC | 2049.0 | Drizzle, reference center of input image (X) |
1356 | D054INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1357 | D054KERN | square | Drizzle, form of weight distribution kernel |
1358 | D054LAM | 555.0 | Drizzle, wavelength applied for transformation |
1359 | D054MASK | cos02_73_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1360 | D054OUCO | Drizzle, output context image | |
1361 | D054OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1362 | D054OUUN | cps | Drizzle, units of output image - counts or cps |
1363 | D054OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1364 | D054OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1365 | D054OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1366 | D054PIXF | 0.8 | Drizzle, linear size of drop |
1367 | D054SECP | False | Drizzle, there are no secondary geometric param |
1368 | D054VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1369 | D054WTSC | 1278391.0 | Drizzle, weighting factor for input image |
1370 | D054XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1371 | D054YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1372 | D055COEF | cos02_74_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1373 | D055DATA | cos02_74_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1374 | D055DEXP | 275.0 | Drizzle, input image exposure time (s) |
1375 | D055EXKY | exptime | Drizzle, exposure keyword name in input image |
1376 | D055FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1377 | D055GEOM | Header WCS | Drizzle, source of geometric information |
1378 | D055INUN | counts | Drizzle, units of input image - counts or cps |
1379 | D055INXC | 2049.0 | Drizzle, reference center of input image (X) |
1380 | D055INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1381 | D055KERN | square | Drizzle, form of weight distribution kernel |
1382 | D055LAM | 555.0 | Drizzle, wavelength applied for transformation |
1383 | D055MASK | cos02_74_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1384 | D055OUCO | Drizzle, output context image | |
1385 | D055OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1386 | D055OUUN | cps | Drizzle, units of output image - counts or cps |
1387 | D055OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1388 | D055OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1389 | D055OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1390 | D055PIXF | 0.8 | Drizzle, linear size of drop |
1391 | D055SECP | False | Drizzle, there are no secondary geometric param |
1392 | D055VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1393 | D055WTSC | 583683.6 | Drizzle, weighting factor for input image |
1394 | D055XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1395 | D055YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1396 | D056COEF | cos02_74_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1397 | D056DATA | cos02_74_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1398 | D056DEXP | 407.0 | Drizzle, input image exposure time (s) |
1399 | D056EXKY | exptime | Drizzle, exposure keyword name in input image |
1400 | D056FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1401 | D056GEOM | Header WCS | Drizzle, source of geometric information |
1402 | D056INUN | counts | Drizzle, units of input image - counts or cps |
1403 | D056INXC | 2049.0 | Drizzle, reference center of input image (X) |
1404 | D056INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1405 | D056KERN | square | Drizzle, form of weight distribution kernel |
1406 | D056LAM | 555.0 | Drizzle, wavelength applied for transformation |
1407 | D056MASK | cos02_74_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1408 | D056OUCO | Drizzle, output context image | |
1409 | D056OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1410 | D056OUUN | cps | Drizzle, units of output image - counts or cps |
1411 | D056OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1412 | D056OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1413 | D056OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1414 | D056PIXF | 0.8 | Drizzle, linear size of drop |
1415 | D056SECP | False | Drizzle, there are no secondary geometric param |
1416 | D056VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1417 | D056WTSC | 1278462.0 | Drizzle, weighting factor for input image |
1418 | D056XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1419 | D056YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1420 | D057COEF | cos02_76_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1421 | D057DATA | cos02_76_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1422 | D057DEXP | 275.0 | Drizzle, input image exposure time (s) |
1423 | D057EXKY | exptime | Drizzle, exposure keyword name in input image |
1424 | D057FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1425 | D057GEOM | Header WCS | Drizzle, source of geometric information |
1426 | D057INUN | counts | Drizzle, units of input image - counts or cps |
1427 | D057INXC | 2049.0 | Drizzle, reference center of input image (X) |
1428 | D057INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1429 | D057KERN | square | Drizzle, form of weight distribution kernel |
1430 | D057LAM | 555.0 | Drizzle, wavelength applied for transformation |
1431 | D057MASK | cos02_76_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1432 | D057OUCO | Drizzle, output context image | |
1433 | D057OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1434 | D057OUUN | cps | Drizzle, units of output image - counts or cps |
1435 | D057OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1436 | D057OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1437 | D057OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1438 | D057PIXF | 0.8 | Drizzle, linear size of drop |
1439 | D057SECP | False | Drizzle, there are no secondary geometric param |
1440 | D057VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1441 | D057WTSC | 583685.8 | Drizzle, weighting factor for input image |
1442 | D057XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1443 | D057YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1444 | D058COEF | cos02_76_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1445 | D058DATA | cos02_76_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1446 | D058DEXP | 407.0 | Drizzle, input image exposure time (s) |
1447 | D058EXKY | exptime | Drizzle, exposure keyword name in input image |
1448 | D058FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1449 | D058GEOM | Header WCS | Drizzle, source of geometric information |
1450 | D058INUN | counts | Drizzle, units of input image - counts or cps |
1451 | D058INXC | 2049.0 | Drizzle, reference center of input image (X) |
1452 | D058INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1453 | D058KERN | square | Drizzle, form of weight distribution kernel |
1454 | D058LAM | 555.0 | Drizzle, wavelength applied for transformation |
1455 | D058MASK | cos02_76_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1456 | D058OUCO | Drizzle, output context image | |
1457 | D058OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1458 | D058OUUN | cps | Drizzle, units of output image - counts or cps |
1459 | D058OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1460 | D058OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1461 | D058OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1462 | D058PIXF | 0.8 | Drizzle, linear size of drop |
1463 | D058SECP | False | Drizzle, there are no secondary geometric param |
1464 | D058VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1465 | D058WTSC | 1278469.0 | Drizzle, weighting factor for input image |
1466 | D058XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1467 | D058YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1468 | D059COEF | cos02_77_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
1469 | D059DATA | cos02_77_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
1470 | D059DEXP | 275.0 | Drizzle, input image exposure time (s) |
1471 | D059EXKY | exptime | Drizzle, exposure keyword name in input image |
1472 | D059FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1473 | D059GEOM | Header WCS | Drizzle, source of geometric information |
1474 | D059INUN | counts | Drizzle, units of input image - counts or cps |
1475 | D059INXC | 2049.0 | Drizzle, reference center of input image (X) |
1476 | D059INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1477 | D059KERN | square | Drizzle, form of weight distribution kernel |
1478 | D059LAM | 555.0 | Drizzle, wavelength applied for transformation |
1479 | D059MASK | cos02_77_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
1480 | D059OUCO | Drizzle, output context image | |
1481 | D059OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1482 | D059OUUN | cps | Drizzle, units of output image - counts or cps |
1483 | D059OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1484 | D059OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1485 | D059OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1486 | D059PIXF | 0.8 | Drizzle, linear size of drop |
1487 | D059SECP | False | Drizzle, there are no secondary geometric param |
1488 | D059VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1489 | D059WTSC | 583685.2 | Drizzle, weighting factor for input image |
1490 | D059XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1491 | D059YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1492 | D060COEF | cos02_77_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1493 | D060DATA | cos02_77_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1494 | D060DEXP | 275.0 | Drizzle, input image exposure time (s) |
1495 | D060EXKY | exptime | Drizzle, exposure keyword name in input image |
1496 | D060FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1497 | D060GEOM | Header WCS | Drizzle, source of geometric information |
1498 | D060INUN | counts | Drizzle, units of input image - counts or cps |
1499 | D060INXC | 2049.0 | Drizzle, reference center of input image (X) |
1500 | D060INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1501 | D060KERN | square | Drizzle, form of weight distribution kernel |
1502 | D060LAM | 555.0 | Drizzle, wavelength applied for transformation |
1503 | D060MASK | cos02_77_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1504 | D060OUCO | Drizzle, output context image | |
1505 | D060OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1506 | D060OUUN | cps | Drizzle, units of output image - counts or cps |
1507 | D060OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1508 | D060OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1509 | D060OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1510 | D060PIXF | 0.8 | Drizzle, linear size of drop |
1511 | D060SECP | False | Drizzle, there are no secondary geometric param |
1512 | D060VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1513 | D060WTSC | 583685.2 | Drizzle, weighting factor for input image |
1514 | D060XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1515 | D060YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1516 | D061COEF | cos02_77_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
1517 | D061DATA | cos02_77_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
1518 | D061DEXP | 407.0 | Drizzle, input image exposure time (s) |
1519 | D061EXKY | exptime | Drizzle, exposure keyword name in input image |
1520 | D061FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1521 | D061GEOM | Header WCS | Drizzle, source of geometric information |
1522 | D061INUN | counts | Drizzle, units of input image - counts or cps |
1523 | D061INXC | 2049.0 | Drizzle, reference center of input image (X) |
1524 | D061INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1525 | D061KERN | square | Drizzle, form of weight distribution kernel |
1526 | D061LAM | 555.0 | Drizzle, wavelength applied for transformation |
1527 | D061MASK | cos02_77_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
1528 | D061OUCO | Drizzle, output context image | |
1529 | D061OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1530 | D061OUUN | cps | Drizzle, units of output image - counts or cps |
1531 | D061OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1532 | D061OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1533 | D061OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1534 | D061PIXF | 0.8 | Drizzle, linear size of drop |
1535 | D061SECP | False | Drizzle, there are no secondary geometric param |
1536 | D061VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1537 | D061WTSC | 1278466.0 | Drizzle, weighting factor for input image |
1538 | D061XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1539 | D061YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1540 | D062COEF | cos02_77_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1541 | D062DATA | cos02_77_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1542 | D062DEXP | 407.0 | Drizzle, input image exposure time (s) |
1543 | D062EXKY | exptime | Drizzle, exposure keyword name in input image |
1544 | D062FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1545 | D062GEOM | Header WCS | Drizzle, source of geometric information |
1546 | D062INUN | counts | Drizzle, units of input image - counts or cps |
1547 | D062INXC | 2049.0 | Drizzle, reference center of input image (X) |
1548 | D062INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1549 | D062KERN | square | Drizzle, form of weight distribution kernel |
1550 | D062LAM | 555.0 | Drizzle, wavelength applied for transformation |
1551 | D062MASK | cos02_77_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1552 | D062OUCO | Drizzle, output context image | |
1553 | D062OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1554 | D062OUUN | cps | Drizzle, units of output image - counts or cps |
1555 | D062OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1556 | D062OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1557 | D062OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1558 | D062PIXF | 0.8 | Drizzle, linear size of drop |
1559 | D062SECP | False | Drizzle, there are no secondary geometric param |
1560 | D062VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1561 | D062WTSC | 1278466.0 | Drizzle, weighting factor for input image |
1562 | D062XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1563 | D062YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1564 | D063COEF | cos02_78_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
1565 | D063DATA | cos02_78_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
1566 | D063DEXP | 275.0 | Drizzle, input image exposure time (s) |
1567 | D063EXKY | exptime | Drizzle, exposure keyword name in input image |
1568 | D063FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1569 | D063GEOM | Header WCS | Drizzle, source of geometric information |
1570 | D063INUN | counts | Drizzle, units of input image - counts or cps |
1571 | D063INXC | 2049.0 | Drizzle, reference center of input image (X) |
1572 | D063INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1573 | D063KERN | square | Drizzle, form of weight distribution kernel |
1574 | D063LAM | 555.0 | Drizzle, wavelength applied for transformation |
1575 | D063MASK | cos02_78_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
1576 | D063OUCO | Drizzle, output context image | |
1577 | D063OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1578 | D063OUUN | cps | Drizzle, units of output image - counts or cps |
1579 | D063OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1580 | D063OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1581 | D063OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1582 | D063PIXF | 0.8 | Drizzle, linear size of drop |
1583 | D063SECP | False | Drizzle, there are no secondary geometric param |
1584 | D063VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1585 | D063WTSC | 583685.3 | Drizzle, weighting factor for input image |
1586 | D063XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1587 | D063YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1588 | D064COEF | cos02_78_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1589 | D064DATA | cos02_78_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1590 | D064DEXP | 275.0 | Drizzle, input image exposure time (s) |
1591 | D064EXKY | exptime | Drizzle, exposure keyword name in input image |
1592 | D064FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1593 | D064GEOM | Header WCS | Drizzle, source of geometric information |
1594 | D064INUN | counts | Drizzle, units of input image - counts or cps |
1595 | D064INXC | 2049.0 | Drizzle, reference center of input image (X) |
1596 | D064INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1597 | D064KERN | square | Drizzle, form of weight distribution kernel |
1598 | D064LAM | 555.0 | Drizzle, wavelength applied for transformation |
1599 | D064MASK | cos02_78_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1600 | D064OUCO | Drizzle, output context image | |
1601 | D064OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1602 | D064OUUN | cps | Drizzle, units of output image - counts or cps |
1603 | D064OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1604 | D064OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1605 | D064OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1606 | D064PIXF | 0.8 | Drizzle, linear size of drop |
1607 | D064SECP | False | Drizzle, there are no secondary geometric param |
1608 | D064VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1609 | D064WTSC | 583685.3 | Drizzle, weighting factor for input image |
1610 | D064XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1611 | D064YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1612 | D065COEF | cos02_78_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
1613 | D065DATA | cos02_78_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
1614 | D065DEXP | 407.0 | Drizzle, input image exposure time (s) |
1615 | D065EXKY | exptime | Drizzle, exposure keyword name in input image |
1616 | D065FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1617 | D065GEOM | Header WCS | Drizzle, source of geometric information |
1618 | D065INUN | counts | Drizzle, units of input image - counts or cps |
1619 | D065INXC | 2049.0 | Drizzle, reference center of input image (X) |
1620 | D065INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1621 | D065KERN | square | Drizzle, form of weight distribution kernel |
1622 | D065LAM | 555.0 | Drizzle, wavelength applied for transformation |
1623 | D065MASK | cos02_78_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
1624 | D065OUCO | Drizzle, output context image | |
1625 | D065OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1626 | D065OUUN | cps | Drizzle, units of output image - counts or cps |
1627 | D065OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1628 | D065OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1629 | D065OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1630 | D065PIXF | 0.8 | Drizzle, linear size of drop |
1631 | D065SECP | False | Drizzle, there are no secondary geometric param |
1632 | D065VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1633 | D065WTSC | 1278466.0 | Drizzle, weighting factor for input image |
1634 | D065XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1635 | D065YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1636 | D066COEF | cos02_78_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1637 | D066DATA | cos02_78_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1638 | D066DEXP | 407.0 | Drizzle, input image exposure time (s) |
1639 | D066EXKY | exptime | Drizzle, exposure keyword name in input image |
1640 | D066FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1641 | D066GEOM | Header WCS | Drizzle, source of geometric information |
1642 | D066INUN | counts | Drizzle, units of input image - counts or cps |
1643 | D066INXC | 2049.0 | Drizzle, reference center of input image (X) |
1644 | D066INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1645 | D066KERN | square | Drizzle, form of weight distribution kernel |
1646 | D066LAM | 555.0 | Drizzle, wavelength applied for transformation |
1647 | D066MASK | cos02_78_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1648 | D066OUCO | Drizzle, output context image | |
1649 | D066OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1650 | D066OUUN | cps | Drizzle, units of output image - counts or cps |
1651 | D066OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1652 | D066OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1653 | D066OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1654 | D066PIXF | 0.8 | Drizzle, linear size of drop |
1655 | D066SECP | False | Drizzle, there are no secondary geometric param |
1656 | D066VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1657 | D066WTSC | 1278466.0 | Drizzle, weighting factor for input image |
1658 | D066XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1659 | D066YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1660 | D067COEF | cos02_80_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1661 | D067DATA | cos02_80_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1662 | D067DEXP | 275.0 | Drizzle, input image exposure time (s) |
1663 | D067EXKY | exptime | Drizzle, exposure keyword name in input image |
1664 | D067FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1665 | D067GEOM | Header WCS | Drizzle, source of geometric information |
1666 | D067INUN | counts | Drizzle, units of input image - counts or cps |
1667 | D067INXC | 2049.0 | Drizzle, reference center of input image (X) |
1668 | D067INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1669 | D067KERN | square | Drizzle, form of weight distribution kernel |
1670 | D067LAM | 555.0 | Drizzle, wavelength applied for transformation |
1671 | D067MASK | cos02_80_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1672 | D067OUCO | Drizzle, output context image | |
1673 | D067OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1674 | D067OUUN | cps | Drizzle, units of output image - counts or cps |
1675 | D067OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1676 | D067OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1677 | D067OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1678 | D067PIXF | 0.8 | Drizzle, linear size of drop |
1679 | D067SECP | False | Drizzle, there are no secondary geometric param |
1680 | D067VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1681 | D067WTSC | 583685.9 | Drizzle, weighting factor for input image |
1682 | D067XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1683 | D067YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1684 | D068COEF | cos02_80_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1685 | D068DATA | cos02_80_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1686 | D068DEXP | 407.0 | Drizzle, input image exposure time (s) |
1687 | D068EXKY | exptime | Drizzle, exposure keyword name in input image |
1688 | D068FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1689 | D068GEOM | Header WCS | Drizzle, source of geometric information |
1690 | D068INUN | counts | Drizzle, units of input image - counts or cps |
1691 | D068INXC | 2049.0 | Drizzle, reference center of input image (X) |
1692 | D068INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1693 | D068KERN | square | Drizzle, form of weight distribution kernel |
1694 | D068LAM | 555.0 | Drizzle, wavelength applied for transformation |
1695 | D068MASK | cos02_80_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1696 | D068OUCO | Drizzle, output context image | |
1697 | D068OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1698 | D068OUUN | cps | Drizzle, units of output image - counts or cps |
1699 | D068OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1700 | D068OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1701 | D068OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1702 | D068PIXF | 0.8 | Drizzle, linear size of drop |
1703 | D068SECP | False | Drizzle, there are no secondary geometric param |
1704 | D068VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1705 | D068WTSC | 1278468.0 | Drizzle, weighting factor for input image |
1706 | D068XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1707 | D068YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1708 | D069COEF | cos02_81_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
1709 | D069DATA | cos02_81_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
1710 | D069DEXP | 275.0 | Drizzle, input image exposure time (s) |
1711 | D069EXKY | exptime | Drizzle, exposure keyword name in input image |
1712 | D069FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1713 | D069GEOM | Header WCS | Drizzle, source of geometric information |
1714 | D069INUN | counts | Drizzle, units of input image - counts or cps |
1715 | D069INXC | 2049.0 | Drizzle, reference center of input image (X) |
1716 | D069INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1717 | D069KERN | square | Drizzle, form of weight distribution kernel |
1718 | D069LAM | 555.0 | Drizzle, wavelength applied for transformation |
1719 | D069MASK | cos02_81_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
1720 | D069OUCO | Drizzle, output context image | |
1721 | D069OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1722 | D069OUUN | cps | Drizzle, units of output image - counts or cps |
1723 | D069OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1724 | D069OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1725 | D069OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1726 | D069PIXF | 0.8 | Drizzle, linear size of drop |
1727 | D069SECP | False | Drizzle, there are no secondary geometric param |
1728 | D069VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1729 | D069WTSC | 583576.4 | Drizzle, weighting factor for input image |
1730 | D069XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1731 | D069YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1732 | D070COEF | cos02_81_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1733 | D070DATA | cos02_81_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1734 | D070DEXP | 275.0 | Drizzle, input image exposure time (s) |
1735 | D070EXKY | exptime | Drizzle, exposure keyword name in input image |
1736 | D070FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1737 | D070GEOM | Header WCS | Drizzle, source of geometric information |
1738 | D070INUN | counts | Drizzle, units of input image - counts or cps |
1739 | D070INXC | 2049.0 | Drizzle, reference center of input image (X) |
1740 | D070INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1741 | D070KERN | square | Drizzle, form of weight distribution kernel |
1742 | D070LAM | 555.0 | Drizzle, wavelength applied for transformation |
1743 | D070MASK | cos02_81_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1744 | D070OUCO | Drizzle, output context image | |
1745 | D070OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1746 | D070OUUN | cps | Drizzle, units of output image - counts or cps |
1747 | D070OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1748 | D070OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1749 | D070OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1750 | D070PIXF | 0.8 | Drizzle, linear size of drop |
1751 | D070SECP | False | Drizzle, there are no secondary geometric param |
1752 | D070VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1753 | D070WTSC | 583576.4 | Drizzle, weighting factor for input image |
1754 | D070XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1755 | D070YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1756 | D071COEF | cos02_81_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
1757 | D071DATA | cos02_81_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
1758 | D071DEXP | 407.0 | Drizzle, input image exposure time (s) |
1759 | D071EXKY | exptime | Drizzle, exposure keyword name in input image |
1760 | D071FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1761 | D071GEOM | Header WCS | Drizzle, source of geometric information |
1762 | D071INUN | counts | Drizzle, units of input image - counts or cps |
1763 | D071INXC | 2049.0 | Drizzle, reference center of input image (X) |
1764 | D071INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1765 | D071KERN | square | Drizzle, form of weight distribution kernel |
1766 | D071LAM | 555.0 | Drizzle, wavelength applied for transformation |
1767 | D071MASK | cos02_81_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
1768 | D071OUCO | Drizzle, output context image | |
1769 | D071OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1770 | D071OUUN | cps | Drizzle, units of output image - counts or cps |
1771 | D071OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1772 | D071OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1773 | D071OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1774 | D071PIXF | 0.8 | Drizzle, linear size of drop |
1775 | D071SECP | False | Drizzle, there are no secondary geometric param |
1776 | D071VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1777 | D071WTSC | 1278511.0 | Drizzle, weighting factor for input image |
1778 | D071XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1779 | D071YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1780 | D072COEF | cos02_81_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1781 | D072DATA | cos02_81_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1782 | D072DEXP | 407.0 | Drizzle, input image exposure time (s) |
1783 | D072EXKY | exptime | Drizzle, exposure keyword name in input image |
1784 | D072FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1785 | D072GEOM | Header WCS | Drizzle, source of geometric information |
1786 | D072INUN | counts | Drizzle, units of input image - counts or cps |
1787 | D072INXC | 2049.0 | Drizzle, reference center of input image (X) |
1788 | D072INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1789 | D072KERN | square | Drizzle, form of weight distribution kernel |
1790 | D072LAM | 555.0 | Drizzle, wavelength applied for transformation |
1791 | D072MASK | cos02_81_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1792 | D072OUCO | Drizzle, output context image | |
1793 | D072OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1794 | D072OUUN | cps | Drizzle, units of output image - counts or cps |
1795 | D072OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1796 | D072OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1797 | D072OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1798 | D072PIXF | 0.8 | Drizzle, linear size of drop |
1799 | D072SECP | False | Drizzle, there are no secondary geometric param |
1800 | D072VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1801 | D072WTSC | 1278511.0 | Drizzle, weighting factor for input image |
1802 | D072XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1803 | D072YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1804 | D073COEF | cos02_82_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
1805 | D073DATA | cos02_82_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
1806 | D073DEXP | 275.0 | Drizzle, input image exposure time (s) |
1807 | D073EXKY | exptime | Drizzle, exposure keyword name in input image |
1808 | D073FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1809 | D073GEOM | Header WCS | Drizzle, source of geometric information |
1810 | D073INUN | counts | Drizzle, units of input image - counts or cps |
1811 | D073INXC | 2049.0 | Drizzle, reference center of input image (X) |
1812 | D073INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1813 | D073KERN | square | Drizzle, form of weight distribution kernel |
1814 | D073LAM | 555.0 | Drizzle, wavelength applied for transformation |
1815 | D073MASK | cos02_82_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
1816 | D073OUCO | Drizzle, output context image | |
1817 | D073OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1818 | D073OUUN | cps | Drizzle, units of output image - counts or cps |
1819 | D073OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1820 | D073OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1821 | D073OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1822 | D073PIXF | 0.8 | Drizzle, linear size of drop |
1823 | D073SECP | False | Drizzle, there are no secondary geometric param |
1824 | D073VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1825 | D073WTSC | 583665.9 | Drizzle, weighting factor for input image |
1826 | D073XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1827 | D073YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1828 | D074COEF | cos02_82_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1829 | D074DATA | cos02_82_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1830 | D074DEXP | 275.0 | Drizzle, input image exposure time (s) |
1831 | D074EXKY | exptime | Drizzle, exposure keyword name in input image |
1832 | D074FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1833 | D074GEOM | Header WCS | Drizzle, source of geometric information |
1834 | D074INUN | counts | Drizzle, units of input image - counts or cps |
1835 | D074INXC | 2049.0 | Drizzle, reference center of input image (X) |
1836 | D074INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1837 | D074KERN | square | Drizzle, form of weight distribution kernel |
1838 | D074LAM | 555.0 | Drizzle, wavelength applied for transformation |
1839 | D074MASK | cos02_82_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1840 | D074OUCO | Drizzle, output context image | |
1841 | D074OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1842 | D074OUUN | cps | Drizzle, units of output image - counts or cps |
1843 | D074OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1844 | D074OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1845 | D074OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1846 | D074PIXF | 0.8 | Drizzle, linear size of drop |
1847 | D074SECP | False | Drizzle, there are no secondary geometric param |
1848 | D074VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1849 | D074WTSC | 583665.9 | Drizzle, weighting factor for input image |
1850 | D074XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1851 | D074YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1852 | D075COEF | cos02_82_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
1853 | D075DATA | cos02_82_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
1854 | D075DEXP | 407.0 | Drizzle, input image exposure time (s) |
1855 | D075EXKY | exptime | Drizzle, exposure keyword name in input image |
1856 | D075FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1857 | D075GEOM | Header WCS | Drizzle, source of geometric information |
1858 | D075INUN | counts | Drizzle, units of input image - counts or cps |
1859 | D075INXC | 2049.0 | Drizzle, reference center of input image (X) |
1860 | D075INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1861 | D075KERN | square | Drizzle, form of weight distribution kernel |
1862 | D075LAM | 555.0 | Drizzle, wavelength applied for transformation |
1863 | D075MASK | cos02_82_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
1864 | D075OUCO | Drizzle, output context image | |
1865 | D075OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1866 | D075OUUN | cps | Drizzle, units of output image - counts or cps |
1867 | D075OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1868 | D075OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1869 | D075OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1870 | D075PIXF | 0.8 | Drizzle, linear size of drop |
1871 | D075SECP | False | Drizzle, there are no secondary geometric param |
1872 | D075VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1873 | D075WTSC | 1278398.0 | Drizzle, weighting factor for input image |
1874 | D075XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1875 | D075YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1876 | D076COEF | cos02_82_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1877 | D076DATA | cos02_82_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1878 | D076DEXP | 407.0 | Drizzle, input image exposure time (s) |
1879 | D076EXKY | exptime | Drizzle, exposure keyword name in input image |
1880 | D076FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1881 | D076GEOM | Header WCS | Drizzle, source of geometric information |
1882 | D076INUN | counts | Drizzle, units of input image - counts or cps |
1883 | D076INXC | 2049.0 | Drizzle, reference center of input image (X) |
1884 | D076INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1885 | D076KERN | square | Drizzle, form of weight distribution kernel |
1886 | D076LAM | 555.0 | Drizzle, wavelength applied for transformation |
1887 | D076MASK | cos02_82_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1888 | D076OUCO | Drizzle, output context image | |
1889 | D076OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1890 | D076OUUN | cps | Drizzle, units of output image - counts or cps |
1891 | D076OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1892 | D076OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1893 | D076OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1894 | D076PIXF | 0.8 | Drizzle, linear size of drop |
1895 | D076SECP | False | Drizzle, there are no secondary geometric param |
1896 | D076VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1897 | D076WTSC | 1278398.0 | Drizzle, weighting factor for input image |
1898 | D076XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1899 | D076YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1900 | D077COEF | cos02_84_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1901 | D077DATA | cos02_84_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1902 | D077DEXP | 225.0 | Drizzle, input image exposure time (s) |
1903 | D077EXKY | exptime | Drizzle, exposure keyword name in input image |
1904 | D077FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1905 | D077GEOM | Header WCS | Drizzle, source of geometric information |
1906 | D077INUN | counts | Drizzle, units of input image - counts or cps |
1907 | D077INXC | 2049.0 | Drizzle, reference center of input image (X) |
1908 | D077INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1909 | D077KERN | square | Drizzle, form of weight distribution kernel |
1910 | D077LAM | 555.0 | Drizzle, wavelength applied for transformation |
1911 | D077MASK | cos02_84_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1912 | D077OUCO | Drizzle, output context image | |
1913 | D077OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1914 | D077OUUN | cps | Drizzle, units of output image - counts or cps |
1915 | D077OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1916 | D077OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1917 | D077OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1918 | D077PIXF | 0.8 | Drizzle, linear size of drop |
1919 | D077SECP | False | Drizzle, there are no secondary geometric param |
1920 | D077VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1921 | D077WTSC | 390733.3 | Drizzle, weighting factor for input image |
1922 | D077XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1923 | D077YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1924 | D078COEF | cos02_84_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
1925 | D078DATA | cos02_84_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
1926 | D078DEXP | 407.0 | Drizzle, input image exposure time (s) |
1927 | D078EXKY | exptime | Drizzle, exposure keyword name in input image |
1928 | D078FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1929 | D078GEOM | Header WCS | Drizzle, source of geometric information |
1930 | D078INUN | counts | Drizzle, units of input image - counts or cps |
1931 | D078INXC | 2049.0 | Drizzle, reference center of input image (X) |
1932 | D078INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1933 | D078KERN | square | Drizzle, form of weight distribution kernel |
1934 | D078LAM | 555.0 | Drizzle, wavelength applied for transformation |
1935 | D078MASK | cos02_84_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
1936 | D078OUCO | Drizzle, output context image | |
1937 | D078OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1938 | D078OUUN | cps | Drizzle, units of output image - counts or cps |
1939 | D078OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1940 | D078OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1941 | D078OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1942 | D078PIXF | 0.8 | Drizzle, linear size of drop |
1943 | D078SECP | False | Drizzle, there are no secondary geometric param |
1944 | D078VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1945 | D078WTSC | 1278475.0 | Drizzle, weighting factor for input image |
1946 | D078XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1947 | D078YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1948 | D079COEF | cos02_85_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
1949 | D079DATA | cos02_85_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
1950 | D079DEXP | 225.0 | Drizzle, input image exposure time (s) |
1951 | D079EXKY | exptime | Drizzle, exposure keyword name in input image |
1952 | D079FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1953 | D079GEOM | Header WCS | Drizzle, source of geometric information |
1954 | D079INUN | counts | Drizzle, units of input image - counts or cps |
1955 | D079INXC | 2049.0 | Drizzle, reference center of input image (X) |
1956 | D079INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1957 | D079KERN | square | Drizzle, form of weight distribution kernel |
1958 | D079LAM | 555.0 | Drizzle, wavelength applied for transformation |
1959 | D079MASK | cos02_85_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
1960 | D079OUCO | Drizzle, output context image | |
1961 | D079OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1962 | D079OUUN | cps | Drizzle, units of output image - counts or cps |
1963 | D079OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1964 | D079OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1965 | D079OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1966 | D079PIXF | 0.8 | Drizzle, linear size of drop |
1967 | D079SECP | False | Drizzle, there are no secondary geometric param |
1968 | D079VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1969 | D079WTSC | 390734.6 | Drizzle, weighting factor for input image |
1970 | D079XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
1971 | D079YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
1972 | D080COEF | cos02_85_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
1973 | D080DATA | cos02_85_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
1974 | D080DEXP | 225.0 | Drizzle, input image exposure time (s) |
1975 | D080EXKY | exptime | Drizzle, exposure keyword name in input image |
1976 | D080FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
1977 | D080GEOM | Header WCS | Drizzle, source of geometric information |
1978 | D080INUN | counts | Drizzle, units of input image - counts or cps |
1979 | D080INXC | 2049.0 | Drizzle, reference center of input image (X) |
1980 | D080INYC | 1025.0 | Drizzle, reference center of input image (Y) |
1981 | D080KERN | square | Drizzle, form of weight distribution kernel |
1982 | D080LAM | 555.0 | Drizzle, wavelength applied for transformation |
1983 | D080MASK | cos02_85_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
1984 | D080OUCO | Drizzle, output context image | |
1985 | D080OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
1986 | D080OUUN | cps | Drizzle, units of output image - counts or cps |
1987 | D080OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
1988 | D080OUXC | 7001.0 | Drizzle, reference center of output image (X) |
1989 | D080OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
1990 | D080PIXF | 0.8 | Drizzle, linear size of drop |
1991 | D080SECP | False | Drizzle, there are no secondary geometric param |
1992 | D080VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
1993 | D080WTSC | 390734.6 | Drizzle, weighting factor for input image |
1994 | D080XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
1995 | D080YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
1996 | D081COEF | cos02_85_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
1997 | D081DATA | cos02_85_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
1998 | D081DEXP | 407.0 | Drizzle, input image exposure time (s) |
1999 | D081EXKY | exptime | Drizzle, exposure keyword name in input image |
2000 | D081FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2001 | D081GEOM | Header WCS | Drizzle, source of geometric information |
2002 | D081INUN | counts | Drizzle, units of input image - counts or cps |
2003 | D081INXC | 2049.0 | Drizzle, reference center of input image (X) |
2004 | D081INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2005 | D081KERN | square | Drizzle, form of weight distribution kernel |
2006 | D081LAM | 555.0 | Drizzle, wavelength applied for transformation |
2007 | D081MASK | cos02_85_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
2008 | D081OUCO | Drizzle, output context image | |
2009 | D081OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2010 | D081OUUN | cps | Drizzle, units of output image - counts or cps |
2011 | D081OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2012 | D081OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2013 | D081OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2014 | D081PIXF | 0.8 | Drizzle, linear size of drop |
2015 | D081SECP | False | Drizzle, there are no secondary geometric param |
2016 | D081VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2017 | D081WTSC | 1278483.0 | Drizzle, weighting factor for input image |
2018 | D081XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2019 | D081YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2020 | D082COEF | cos02_85_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
2021 | D082DATA | cos02_85_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
2022 | D082DEXP | 407.0 | Drizzle, input image exposure time (s) |
2023 | D082EXKY | exptime | Drizzle, exposure keyword name in input image |
2024 | D082FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2025 | D082GEOM | Header WCS | Drizzle, source of geometric information |
2026 | D082INUN | counts | Drizzle, units of input image - counts or cps |
2027 | D082INXC | 2049.0 | Drizzle, reference center of input image (X) |
2028 | D082INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2029 | D082KERN | square | Drizzle, form of weight distribution kernel |
2030 | D082LAM | 555.0 | Drizzle, wavelength applied for transformation |
2031 | D082MASK | cos02_85_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
2032 | D082OUCO | Drizzle, output context image | |
2033 | D082OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2034 | D082OUUN | cps | Drizzle, units of output image - counts or cps |
2035 | D082OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2036 | D082OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2037 | D082OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2038 | D082PIXF | 0.8 | Drizzle, linear size of drop |
2039 | D082SECP | False | Drizzle, there are no secondary geometric param |
2040 | D082VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2041 | D082WTSC | 1278483.0 | Drizzle, weighting factor for input image |
2042 | D082XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2043 | D082YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2044 | D083COEF | cos02_86_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
2045 | D083DATA | cos02_86_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
2046 | D083DEXP | 225.0 | Drizzle, input image exposure time (s) |
2047 | D083EXKY | exptime | Drizzle, exposure keyword name in input image |
2048 | D083FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2049 | D083GEOM | Header WCS | Drizzle, source of geometric information |
2050 | D083INUN | counts | Drizzle, units of input image - counts or cps |
2051 | D083INXC | 2049.0 | Drizzle, reference center of input image (X) |
2052 | D083INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2053 | D083KERN | square | Drizzle, form of weight distribution kernel |
2054 | D083LAM | 555.0 | Drizzle, wavelength applied for transformation |
2055 | D083MASK | cos02_86_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
2056 | D083OUCO | Drizzle, output context image | |
2057 | D083OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2058 | D083OUUN | cps | Drizzle, units of output image - counts or cps |
2059 | D083OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2060 | D083OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2061 | D083OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2062 | D083PIXF | 0.8 | Drizzle, linear size of drop |
2063 | D083SECP | False | Drizzle, there are no secondary geometric param |
2064 | D083VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2065 | D083WTSC | 390660.8 | Drizzle, weighting factor for input image |
2066 | D083XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2067 | D083YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2068 | D084COEF | cos02_86_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
2069 | D084DATA | cos02_86_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
2070 | D084DEXP | 225.0 | Drizzle, input image exposure time (s) |
2071 | D084EXKY | exptime | Drizzle, exposure keyword name in input image |
2072 | D084FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2073 | D084GEOM | Header WCS | Drizzle, source of geometric information |
2074 | D084INUN | counts | Drizzle, units of input image - counts or cps |
2075 | D084INXC | 2049.0 | Drizzle, reference center of input image (X) |
2076 | D084INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2077 | D084KERN | square | Drizzle, form of weight distribution kernel |
2078 | D084LAM | 555.0 | Drizzle, wavelength applied for transformation |
2079 | D084MASK | cos02_86_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
2080 | D084OUCO | Drizzle, output context image | |
2081 | D084OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2082 | D084OUUN | cps | Drizzle, units of output image - counts or cps |
2083 | D084OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2084 | D084OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2085 | D084OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2086 | D084PIXF | 0.8 | Drizzle, linear size of drop |
2087 | D084SECP | False | Drizzle, there are no secondary geometric param |
2088 | D084VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2089 | D084WTSC | 390660.8 | Drizzle, weighting factor for input image |
2090 | D084XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2091 | D084YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2092 | D085COEF | cos02_86_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
2093 | D085DATA | cos02_86_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
2094 | D085DEXP | 407.0 | Drizzle, input image exposure time (s) |
2095 | D085EXKY | exptime | Drizzle, exposure keyword name in input image |
2096 | D085FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2097 | D085GEOM | Header WCS | Drizzle, source of geometric information |
2098 | D085INUN | counts | Drizzle, units of input image - counts or cps |
2099 | D085INXC | 2049.0 | Drizzle, reference center of input image (X) |
2100 | D085INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2101 | D085KERN | square | Drizzle, form of weight distribution kernel |
2102 | D085LAM | 555.0 | Drizzle, wavelength applied for transformation |
2103 | D085MASK | cos02_86_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
2104 | D085OUCO | Drizzle, output context image | |
2105 | D085OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2106 | D085OUUN | cps | Drizzle, units of output image - counts or cps |
2107 | D085OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2108 | D085OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2109 | D085OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2110 | D085PIXF | 0.8 | Drizzle, linear size of drop |
2111 | D085SECP | False | Drizzle, there are no secondary geometric param |
2112 | D085VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2113 | D085WTSC | 1278516.0 | Drizzle, weighting factor for input image |
2114 | D085XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2115 | D085YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2116 | D086COEF | cos02_86_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
2117 | D086DATA | cos02_86_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
2118 | D086DEXP | 407.0 | Drizzle, input image exposure time (s) |
2119 | D086EXKY | exptime | Drizzle, exposure keyword name in input image |
2120 | D086FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2121 | D086GEOM | Header WCS | Drizzle, source of geometric information |
2122 | D086INUN | counts | Drizzle, units of input image - counts or cps |
2123 | D086INXC | 2049.0 | Drizzle, reference center of input image (X) |
2124 | D086INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2125 | D086KERN | square | Drizzle, form of weight distribution kernel |
2126 | D086LAM | 555.0 | Drizzle, wavelength applied for transformation |
2127 | D086MASK | cos02_86_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
2128 | D086OUCO | Drizzle, output context image | |
2129 | D086OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2130 | D086OUUN | cps | Drizzle, units of output image - counts or cps |
2131 | D086OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2132 | D086OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2133 | D086OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2134 | D086PIXF | 0.8 | Drizzle, linear size of drop |
2135 | D086SECP | False | Drizzle, there are no secondary geometric param |
2136 | D086VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2137 | D086WTSC | 1278516.0 | Drizzle, weighting factor for input image |
2138 | D086XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2139 | D086YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2140 | D087COEF | cos02_89_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
2141 | D087DATA | cos02_89_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
2142 | D087DEXP | 225.0 | Drizzle, input image exposure time (s) |
2143 | D087EXKY | exptime | Drizzle, exposure keyword name in input image |
2144 | D087FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2145 | D087GEOM | Header WCS | Drizzle, source of geometric information |
2146 | D087INUN | counts | Drizzle, units of input image - counts or cps |
2147 | D087INXC | 2049.0 | Drizzle, reference center of input image (X) |
2148 | D087INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2149 | D087KERN | square | Drizzle, form of weight distribution kernel |
2150 | D087LAM | 555.0 | Drizzle, wavelength applied for transformation |
2151 | D087MASK | cos02_89_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
2152 | D087OUCO | Drizzle, output context image | |
2153 | D087OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2154 | D087OUUN | cps | Drizzle, units of output image - counts or cps |
2155 | D087OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2156 | D087OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2157 | D087OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2158 | D087PIXF | 0.8 | Drizzle, linear size of drop |
2159 | D087SECP | False | Drizzle, there are no secondary geometric param |
2160 | D087VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2161 | D087WTSC | 390736.4 | Drizzle, weighting factor for input image |
2162 | D087XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2163 | D087YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2164 | D088COEF | cos02_89_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
2165 | D088DATA | cos02_89_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
2166 | D088DEXP | 225.0 | Drizzle, input image exposure time (s) |
2167 | D088EXKY | exptime | Drizzle, exposure keyword name in input image |
2168 | D088FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2169 | D088GEOM | Header WCS | Drizzle, source of geometric information |
2170 | D088INUN | counts | Drizzle, units of input image - counts or cps |
2171 | D088INXC | 2049.0 | Drizzle, reference center of input image (X) |
2172 | D088INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2173 | D088KERN | square | Drizzle, form of weight distribution kernel |
2174 | D088LAM | 555.0 | Drizzle, wavelength applied for transformation |
2175 | D088MASK | cos02_89_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
2176 | D088OUCO | Drizzle, output context image | |
2177 | D088OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2178 | D088OUUN | cps | Drizzle, units of output image - counts or cps |
2179 | D088OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2180 | D088OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2181 | D088OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2182 | D088PIXF | 0.8 | Drizzle, linear size of drop |
2183 | D088SECP | False | Drizzle, there are no secondary geometric param |
2184 | D088VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2185 | D088WTSC | 390736.4 | Drizzle, weighting factor for input image |
2186 | D088XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2187 | D088YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2188 | D089COEF | cos02_89_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
2189 | D089DATA | cos02_89_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
2190 | D089DEXP | 407.0 | Drizzle, input image exposure time (s) |
2191 | D089EXKY | exptime | Drizzle, exposure keyword name in input image |
2192 | D089FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2193 | D089GEOM | Header WCS | Drizzle, source of geometric information |
2194 | D089INUN | counts | Drizzle, units of input image - counts or cps |
2195 | D089INXC | 2049.0 | Drizzle, reference center of input image (X) |
2196 | D089INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2197 | D089KERN | square | Drizzle, form of weight distribution kernel |
2198 | D089LAM | 555.0 | Drizzle, wavelength applied for transformation |
2199 | D089MASK | cos02_89_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
2200 | D089OUCO | Drizzle, output context image | |
2201 | D089OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2202 | D089OUUN | cps | Drizzle, units of output image - counts or cps |
2203 | D089OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2204 | D089OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2205 | D089OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2206 | D089PIXF | 0.8 | Drizzle, linear size of drop |
2207 | D089SECP | False | Drizzle, there are no secondary geometric param |
2208 | D089VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2209 | D089WTSC | 1278490.0 | Drizzle, weighting factor for input image |
2210 | D089XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2211 | D089YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2212 | D090COEF | cos02_89_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
2213 | D090DATA | cos02_89_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
2214 | D090DEXP | 407.0 | Drizzle, input image exposure time (s) |
2215 | D090EXKY | exptime | Drizzle, exposure keyword name in input image |
2216 | D090FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2217 | D090GEOM | Header WCS | Drizzle, source of geometric information |
2218 | D090INUN | counts | Drizzle, units of input image - counts or cps |
2219 | D090INXC | 2049.0 | Drizzle, reference center of input image (X) |
2220 | D090INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2221 | D090KERN | square | Drizzle, form of weight distribution kernel |
2222 | D090LAM | 555.0 | Drizzle, wavelength applied for transformation |
2223 | D090MASK | cos02_89_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
2224 | D090OUCO | Drizzle, output context image | |
2225 | D090OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2226 | D090OUUN | cps | Drizzle, units of output image - counts or cps |
2227 | D090OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2228 | D090OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2229 | D090OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2230 | D090PIXF | 0.8 | Drizzle, linear size of drop |
2231 | D090SECP | False | Drizzle, there are no secondary geometric param |
2232 | D090VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2233 | D090WTSC | 1278490.0 | Drizzle, weighting factor for input image |
2234 | D090XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2235 | D090YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2236 | D091COEF | cos02_90_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
2237 | D091DATA | cos02_90_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
2238 | D091DEXP | 225.0 | Drizzle, input image exposure time (s) |
2239 | D091EXKY | exptime | Drizzle, exposure keyword name in input image |
2240 | D091FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2241 | D091GEOM | Header WCS | Drizzle, source of geometric information |
2242 | D091INUN | counts | Drizzle, units of input image - counts or cps |
2243 | D091INXC | 2049.0 | Drizzle, reference center of input image (X) |
2244 | D091INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2245 | D091KERN | square | Drizzle, form of weight distribution kernel |
2246 | D091LAM | 555.0 | Drizzle, wavelength applied for transformation |
2247 | D091MASK | cos02_90_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
2248 | D091OUCO | Drizzle, output context image | |
2249 | D091OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2250 | D091OUUN | cps | Drizzle, units of output image - counts or cps |
2251 | D091OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2252 | D091OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2253 | D091OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2254 | D091PIXF | 0.8 | Drizzle, linear size of drop |
2255 | D091SECP | False | Drizzle, there are no secondary geometric param |
2256 | D091VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2257 | D091WTSC | 390736.1 | Drizzle, weighting factor for input image |
2258 | D091XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2259 | D091YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2260 | D092COEF | cos02_90_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
2261 | D092DATA | cos02_90_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
2262 | D092DEXP | 225.0 | Drizzle, input image exposure time (s) |
2263 | D092EXKY | exptime | Drizzle, exposure keyword name in input image |
2264 | D092FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2265 | D092GEOM | Header WCS | Drizzle, source of geometric information |
2266 | D092INUN | counts | Drizzle, units of input image - counts or cps |
2267 | D092INXC | 2049.0 | Drizzle, reference center of input image (X) |
2268 | D092INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2269 | D092KERN | square | Drizzle, form of weight distribution kernel |
2270 | D092LAM | 555.0 | Drizzle, wavelength applied for transformation |
2271 | D092MASK | cos02_90_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
2272 | D092OUCO | Drizzle, output context image | |
2273 | D092OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2274 | D092OUUN | cps | Drizzle, units of output image - counts or cps |
2275 | D092OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2276 | D092OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2277 | D092OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2278 | D092PIXF | 0.8 | Drizzle, linear size of drop |
2279 | D092SECP | False | Drizzle, there are no secondary geometric param |
2280 | D092VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2281 | D092WTSC | 390736.1 | Drizzle, weighting factor for input image |
2282 | D092XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2283 | D092YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2284 | D093COEF | cos02_90_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
2285 | D093DATA | cos02_90_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
2286 | D093DEXP | 407.0 | Drizzle, input image exposure time (s) |
2287 | D093EXKY | exptime | Drizzle, exposure keyword name in input image |
2288 | D093FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2289 | D093GEOM | Header WCS | Drizzle, source of geometric information |
2290 | D093INUN | counts | Drizzle, units of input image - counts or cps |
2291 | D093INXC | 2049.0 | Drizzle, reference center of input image (X) |
2292 | D093INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2293 | D093KERN | square | Drizzle, form of weight distribution kernel |
2294 | D093LAM | 555.0 | Drizzle, wavelength applied for transformation |
2295 | D093MASK | cos02_90_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
2296 | D093OUCO | Drizzle, output context image | |
2297 | D093OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2298 | D093OUUN | cps | Drizzle, units of output image - counts or cps |
2299 | D093OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2300 | D093OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2301 | D093OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2302 | D093PIXF | 0.8 | Drizzle, linear size of drop |
2303 | D093SECP | False | Drizzle, there are no secondary geometric param |
2304 | D093VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2305 | D093WTSC | 1278487.0 | Drizzle, weighting factor for input image |
2306 | D093XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2307 | D093YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2308 | D094COEF | cos02_90_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
2309 | D094DATA | cos02_90_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
2310 | D094DEXP | 407.0 | Drizzle, input image exposure time (s) |
2311 | D094EXKY | exptime | Drizzle, exposure keyword name in input image |
2312 | D094FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2313 | D094GEOM | Header WCS | Drizzle, source of geometric information |
2314 | D094INUN | counts | Drizzle, units of input image - counts or cps |
2315 | D094INXC | 2049.0 | Drizzle, reference center of input image (X) |
2316 | D094INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2317 | D094KERN | square | Drizzle, form of weight distribution kernel |
2318 | D094LAM | 555.0 | Drizzle, wavelength applied for transformation |
2319 | D094MASK | cos02_90_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
2320 | D094OUCO | Drizzle, output context image | |
2321 | D094OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2322 | D094OUUN | cps | Drizzle, units of output image - counts or cps |
2323 | D094OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2324 | D094OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2325 | D094OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2326 | D094PIXF | 0.8 | Drizzle, linear size of drop |
2327 | D094SECP | False | Drizzle, there are no secondary geometric param |
2328 | D094VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2329 | D094WTSC | 1278487.0 | Drizzle, weighting factor for input image |
2330 | D094XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2331 | D094YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2332 | D095COEF | cos02_93_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
2333 | D095DATA | cos02_93_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
2334 | D095DEXP | 225.0 | Drizzle, input image exposure time (s) |
2335 | D095EXKY | exptime | Drizzle, exposure keyword name in input image |
2336 | D095FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2337 | D095GEOM | Header WCS | Drizzle, source of geometric information |
2338 | D095INUN | counts | Drizzle, units of input image - counts or cps |
2339 | D095INXC | 2049.0 | Drizzle, reference center of input image (X) |
2340 | D095INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2341 | D095KERN | square | Drizzle, form of weight distribution kernel |
2342 | D095LAM | 555.0 | Drizzle, wavelength applied for transformation |
2343 | D095MASK | cos02_93_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
2344 | D095OUCO | Drizzle, output context image | |
2345 | D095OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2346 | D095OUUN | cps | Drizzle, units of output image - counts or cps |
2347 | D095OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2348 | D095OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2349 | D095OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2350 | D095PIXF | 0.8 | Drizzle, linear size of drop |
2351 | D095SECP | False | Drizzle, there are no secondary geometric param |
2352 | D095VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2353 | D095WTSC | 390736.0 | Drizzle, weighting factor for input image |
2354 | D095XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2355 | D095YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2356 | D096COEF | cos02_93_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
2357 | D096DATA | cos02_93_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
2358 | D096DEXP | 407.0 | Drizzle, input image exposure time (s) |
2359 | D096EXKY | exptime | Drizzle, exposure keyword name in input image |
2360 | D096FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2361 | D096GEOM | Header WCS | Drizzle, source of geometric information |
2362 | D096INUN | counts | Drizzle, units of input image - counts or cps |
2363 | D096INXC | 2049.0 | Drizzle, reference center of input image (X) |
2364 | D096INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2365 | D096KERN | square | Drizzle, form of weight distribution kernel |
2366 | D096LAM | 555.0 | Drizzle, wavelength applied for transformation |
2367 | D096MASK | cos02_93_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
2368 | D096OUCO | Drizzle, output context image | |
2369 | D096OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2370 | D096OUUN | cps | Drizzle, units of output image - counts or cps |
2371 | D096OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2372 | D096OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2373 | D096OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2374 | D096PIXF | 0.8 | Drizzle, linear size of drop |
2375 | D096SECP | False | Drizzle, there are no secondary geometric param |
2376 | D096VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2377 | D096WTSC | 1278483.0 | Drizzle, weighting factor for input image |
2378 | D096XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2379 | D096YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2380 | D097COEF | cos02_94_f606w_1_flt_coeffs2.dat | Drizzle, coefficients file name |
2381 | D097DATA | cos02_94_f606w_1_flt_sci1_final.fits | Drizzle, input data image |
2382 | D097DEXP | 225.0 | Drizzle, input image exposure time (s) |
2383 | D097EXKY | exptime | Drizzle, exposure keyword name in input image |
2384 | D097FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2385 | D097GEOM | Header WCS | Drizzle, source of geometric information |
2386 | D097INUN | counts | Drizzle, units of input image - counts or cps |
2387 | D097INXC | 2049.0 | Drizzle, reference center of input image (X) |
2388 | D097INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2389 | D097KERN | square | Drizzle, form of weight distribution kernel |
2390 | D097LAM | 555.0 | Drizzle, wavelength applied for transformation |
2391 | D097MASK | cos02_94_f606w_1_flt_wht1_final.fits | Drizzle, input weighting imag |
2392 | D097OUCO | Drizzle, output context image | |
2393 | D097OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2394 | D097OUUN | cps | Drizzle, units of output image - counts or cps |
2395 | D097OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2396 | D097OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2397 | D097OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2398 | D097PIXF | 0.8 | Drizzle, linear size of drop |
2399 | D097SECP | False | Drizzle, there are no secondary geometric param |
2400 | D097VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2401 | D097WTSC | 390737.1 | Drizzle, weighting factor for input image |
2402 | D097XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2403 | D097YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2404 | D098COEF | cos02_94_f606w_1_flt_coeffs1.dat | Drizzle, coefficients file name |
2405 | D098DATA | cos02_94_f606w_1_flt_sci2_final.fits | Drizzle, input data image |
2406 | D098DEXP | 225.0 | Drizzle, input image exposure time (s) |
2407 | D098EXKY | exptime | Drizzle, exposure keyword name in input image |
2408 | D098FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2409 | D098GEOM | Header WCS | Drizzle, source of geometric information |
2410 | D098INUN | counts | Drizzle, units of input image - counts or cps |
2411 | D098INXC | 2049.0 | Drizzle, reference center of input image (X) |
2412 | D098INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2413 | D098KERN | square | Drizzle, form of weight distribution kernel |
2414 | D098LAM | 555.0 | Drizzle, wavelength applied for transformation |
2415 | D098MASK | cos02_94_f606w_1_flt_wht2_final.fits | Drizzle, input weighting imag |
2416 | D098OUCO | Drizzle, output context image | |
2417 | D098OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2418 | D098OUUN | cps | Drizzle, units of output image - counts or cps |
2419 | D098OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2420 | D098OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2421 | D098OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2422 | D098PIXF | 0.8 | Drizzle, linear size of drop |
2423 | D098SECP | False | Drizzle, there are no secondary geometric param |
2424 | D098VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2425 | D098WTSC | 390737.1 | Drizzle, weighting factor for input image |
2426 | D098XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2427 | D098YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2428 | D099COEF | cos02_94_f606w_2_flt_coeffs2.dat | Drizzle, coefficients file name |
2429 | D099DATA | cos02_94_f606w_2_flt_sci1_final.fits | Drizzle, input data image |
2430 | D099DEXP | 407.0 | Drizzle, input image exposure time (s) |
2431 | D099EXKY | exptime | Drizzle, exposure keyword name in input image |
2432 | D099FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2433 | D099GEOM | Header WCS | Drizzle, source of geometric information |
2434 | D099INUN | counts | Drizzle, units of input image - counts or cps |
2435 | D099INXC | 2049.0 | Drizzle, reference center of input image (X) |
2436 | D099INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2437 | D099KERN | square | Drizzle, form of weight distribution kernel |
2438 | D099LAM | 555.0 | Drizzle, wavelength applied for transformation |
2439 | D099MASK | cos02_94_f606w_2_flt_wht1_final.fits | Drizzle, input weighting imag |
2440 | D099OUCO | Drizzle, output context image | |
2441 | D099OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2442 | D099OUUN | cps | Drizzle, units of output image - counts or cps |
2443 | D099OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2444 | D099OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2445 | D099OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2446 | D099PIXF | 0.8 | Drizzle, linear size of drop |
2447 | D099SECP | False | Drizzle, there are no secondary geometric param |
2448 | D099VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2449 | D099WTSC | 1278491.0 | Drizzle, weighting factor for input image |
2450 | D099XGIM | jref$qbu16424j_dxy.fits[DX,1] | Drizzle, X distortion image name |
2451 | D099YGIM | jref$qbu16424j_dxy.fits[DY,1] | Drizzle, Y distortion image name |
2452 | D100COEF | cos02_94_f606w_2_flt_coeffs1.dat | Drizzle, coefficients file name |
2453 | D100DATA | cos02_94_f606w_2_flt_sci2_final.fits | Drizzle, input data image |
2454 | D100DEXP | 407.0 | Drizzle, input image exposure time (s) |
2455 | D100EXKY | exptime | Drizzle, exposure keyword name in input image |
2456 | D100FVAL | INDEF | Drizzle, fill value for zero weight output pixe |
2457 | D100GEOM | Header WCS | Drizzle, source of geometric information |
2458 | D100INUN | counts | Drizzle, units of input image - counts or cps |
2459 | D100INXC | 2049.0 | Drizzle, reference center of input image (X) |
2460 | D100INYC | 1025.0 | Drizzle, reference center of input image (Y) |
2461 | D100KERN | square | Drizzle, form of weight distribution kernel |
2462 | D100LAM | 555.0 | Drizzle, wavelength applied for transformation |
2463 | D100MASK | cos02_94_f606w_2_flt_wht2_final.fits | Drizzle, input weighting imag |
2464 | D100OUCO | Drizzle, output context image | |
2465 | D100OUDA | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_drz.hhh | Drizzle, |
2466 | D100OUUN | cps | Drizzle, units of output image - counts or cps |
2467 | D100OUWE | tmpdir221/cos_2epoch_acs_f606w_030mas_v1.0_sect23_wht.hhh | Drizzle, |
2468 | D100OUXC | 7001.0 | Drizzle, reference center of output image (X) |
2469 | D100OUYC | 7201.0 | Drizzle, reference center of output image (Y) |
2470 | D100PIXF | 0.8 | Drizzle, linear size of drop |
2471 | D100SECP | False | Drizzle, there are no secondary geometric param |
2472 | D100VER | WDRIZZLE Version 3.4.2 (Jul 3rd 2006) | Drizzle, task version |
2473 | D100WTSC | 1278491.0 | Drizzle, weighting factor for input image |
2474 | D100XGIM | jref$qbu16424j_dxy.fits[DX,2] | Drizzle, X distortion image name |
2475 | D100YGIM | jref$qbu16424j_dxy.fits[DY,2] | Drizzle, Y distortion image name |
2476 | DARKCORR | COMPLETE | Subtract dark image |
2477 | DARKFILE | jref$vbh18454j_drk.fits | dark image file name |
2478 | DATAMAX | 0.0 | |
2479 | DATAMIN | 0.0 | |
2480 | DATE | 2012-04-10T16:39:27 | Date FITS file was generated |
2481 | DATE-OBS | 2011-12-11 | ISO-8601 time of observation |
2482 | DEC_APER | 2.270881608073 | Declination of aperture reference position |
2483 | DEC_TARG | 2.270881608073 | declination of the target (deg) (J2000) |
2484 | DETECTOR | WFC | detector in use: WFC, HRC, or SBC |
2485 | DFLTFILE | N/A | delta flat field file name |
2486 | DGEOFILE | jref$qbu16424j_dxy.fits | Distortion correction image |
2487 | DIRIMAGE | NONE | direct image for grism or prism exposure |
2488 | DQICORR | COMPLETE | data quality initialization |
2489 | DRIZCORR | PERFORM | drizzle processing |
2490 | EQUINOX | 2000.0 | [yr] Equinox of equatorial coordinates |
2491 | ERRCNT | 1 | number of segments containing errors |
2492 | EXPEND | 55906.55125326 | exposure end time (Modified Julian Date) |
2493 | EXPFLAG | NORMAL | Exposure interruption indicator |
2494 | EXPNAME | jboa28wmq | exposure identifier |
2495 | EXPSCORR | COMPLETE | process individual observations after cr-reject |
2496 | EXPSTART | 55906.54805854 | exposure start time (Modified Julian Date) |
2497 | EXPTIME | 36800.0 | exposure duration (seconds)--calculated |
2498 | FGSLOCK | FINE | commanded FGS lock (FINE,COARSE,GYROS,UNKNOWN) |
2499 | FILLCNT | 1 | number of segments containing fill |
2500 | FILTER1 | F606W | element selected from filter wheel 1 |
2501 | FILTER2 | CLEAR2L | element selected from filter wheel 2 |
2502 | FLASHCUR | OFF | Post flash current: OFF, LOW, MED, HIGH |
2503 | FLASHDUR | 0.0 | Exposure time in seconds: 0.1 to 409.5 |
2504 | FLASHSTA | NOT PERFORMED | Status: SUCCESSFUL, ABORTED, NOT PERFORMED |
2505 | FLATCORR | COMPLETE | flat field data |
2506 | FLSHCORR | OMIT | post flash correction |
2507 | FLSHFILE | N/A | post flash correction file name |
2508 | FW1ERROR | False | filter wheel position error flag |
2509 | FW1OFFST | 0 | computed filter wheel offset |
2510 | FW2ERROR | True | filter wheel position error flag |
2511 | FW2OFFST | -4320 | computed filter wheel offset |
2512 | FWSERROR | False | filter wheel position error flag |
2513 | FWSOFFST | 0 | computed filter wheel offset |
2514 | GOODMAX | 85606.719 | maximum value of good pixels |
2515 | GOODMEAN | 35.94437 | mean value of good pixels |
2516 | GOODMIN | -31.759687 | minimum value of good pixels |
2517 | GRAPHTAB | mtab$v9n1603mm_tmg.fits | the HST graph table |
2518 | GYROMODE | T | number of gyros scheduled, T=3+OBAD |
2519 | IDCSCALE | 0.05 | |
2520 | IDCTAB | jref$v8q1444tj_idc.fits | image distortion correction table |
2521 | IDCTHETA | 0.0 | |
2522 | IDCV2REF | 261.1130981445312 | |
2523 | IDCV3REF | 198.231201171875 | |
2524 | IMAGETYP | EXT | type of exposure identifier |
2525 | IMPHTTAB | jref$vbb18107j_imp.fits | Image Photometry Table |
2526 | INITGUES | initial guess method (MIN or MED) | |
2527 | INSTRUME | ACS | identifier for instrument used to acquire data |
2528 | LFLTFILE | N/A | low order flat |
2529 | LINENUM | 28.002 | proposal logsheet line number |
2530 | LOSTPIX | 0 | #pixels lost due to buffer overflow |
2531 | LRFWAVE | 0.0 | proposed linear ramp filter wavelength |
2532 | LTM1_1 | 1.0 | reciprocal of sampling rate in X |
2533 | LTM2_2 | 1.0 | reciprocal of sampling rate in Y |
2534 | LTV1 | 0.0 | offset in X to subsection start |
2535 | LTV2 | 0.0 | offset in Y to subsection start |
2536 | MDRIZSKY | 32.08782958984375 | Sky value computed by MultiDrizzle |
2537 | MDRIZTAB | jref$ub21537aj_mdz.fits | MultiDrizzle parameter table |
2538 | MEANBLEV | 2114.5295 | average of all bias levels subtracted |
2539 | MEANDARK | 1.2713139 | average of the dark values subtracted |
2540 | MEANEXP | 0.0 | reference exposure time for parameters |
2541 | MEANFLSH | 0.0 | Mean number of counts in post flash exposure |
2542 | MJD-OBS | 55906.0 | [d] MJD of observation |
2543 | MJDREF | 0.0 | [d] MJD of fiducial time |
2544 | MOONANGL | 61.991249 | angle between moon and V1 axis |
2545 | MTFLAG | moving target flag; T if it is a moving target | |
2546 | NCOMBINE | 1 | number of image sets combined during CR rejecti |
2547 | NDRIZIM | 100 | Drizzle, number of images drizzled onto this ou |
2548 | NGOODPIX | 8097343 | number of good pixels |
2549 | NRPTEXP | 1 | number of repeat exposures in set: default 1 |
2550 | OBJECT | COS_2EPOCH_ACS_F606W_030MAS_V1.0_SECT23_DRZ[1/1] | |
2551 | OBSMODE | ACCUM | operating mode |
2552 | OBSTYPE | IMAGING | observation type - imaging or spectroscopic |
2553 | OCTYPE1 | RA---TAN | the coordinate type for the first axis |
2554 | OCTYPE2 | DEC--TAN | the coordinate type for the second axis |
2555 | OCX10 | 0.002270935984783606 | |
2556 | OCX11 | 0.04922343821974121 | |
2557 | OCY10 | 0.0485839959198564 | |
2558 | OCY11 | 0.00213603403929032 | |
2559 | ONAXIS1 | 4096 | Axis length |
2560 | ONAXIS2 | 2048 | Axis length |
2561 | OORIENTA | -54.64776336099293 | position angle of image y axis (deg. e of n) |
2562 | OPUS_VER | OPUS 2011_1h | OPUS software system version number |
2563 | ORIENTAT | -54.67632556350016 | position angle of image y axis (deg. e of n) |
2564 | ORIGIN | NOAO-IRAF FITS Image Kernel July 2003 | FITS file originator |
2565 | ORIG_EXT | 0 | Extension in original file. |
2566 | ORIG_FLE | hlsp_candels_hst_hst_candels-v1.0_acs_f606w_drz.fits | Original imag |
2567 | OSCNTAB | jref$lch1459bj_osc.fits | CCD overscan table |
2568 | O_EXT_NM | O | r |
2569 | P1_ANGLE | 0.0 | angle between sides of parallelogram patt (deg) |
2570 | P1_CENTR | center pattern relative to pointing (yes/no) | |
2571 | P1_FRAME | coordinate frame of primary pattern | |
2572 | P1_LSPAC | 0.0 | line spacing for primary pattern (arc-sec) |
2573 | P1_NPTS | 0 | number of points in primary pattern |
2574 | P1_ORINT | 0.0 | orientation of pattern to coordinate frame (deg |
2575 | P1_PSPAC | 0.0 | point spacing for primary pattern (arc-sec) |
2576 | P1_PURPS | primary pattern purpose | |
2577 | P1_SHAPE | primary pattern shape | |
2578 | PATTERN1 | NONE | primary pattern type |
2579 | PATTSTEP | 0 | position number of this point in the pattern |
2580 | PA_APER | -54.4475 | Position Angle of reference aperture center (de |
2581 | PA_V3 | 128.0 | position angle of V3-axis of HST (deg) |
2582 | PCTECORR | COMPLETE | |
2583 | PCTEFILE | jref$pctefile_101109.fits | |
2584 | PCTEFRAC | 1.289367530158845 | |
2585 | PCTETAB | jref$pctetab_pcte_20110913113559.fits | |
2586 | PFLTFILE | jref$qb12257sj_pfl.fits | pixel to pixel flat field file name |
2587 | PHOTBW | 672.23627 | RMS bandwidth of filter plus detector |
2588 | PHOTCORR | COMPLETE | populate photometric header keywords |
2589 | PHOTFLAM | 7.8624958e-20 | inverse sensitivity, ergs/cm2/Ang/electron |
2590 | PHOTMODE | ACS WFC1 F606W MJD#55906.5481 | observation con |
2591 | PHOTPLAM | 5921.1147 | Pivot wavelength (Angstroms) |
2592 | PHOTTAB | N/A | Photometric throughput table |
2593 | PHOTZPT | -21.1 | ST magnitude zero point |
2594 | PODPSFF | False | podps fill present (T/F) |
2595 | POSTARG1 | 0.0 | POSTARG in axis 1 direction |
2596 | POSTARG2 | 0.0 | POSTARG in axis 2 direction |
2597 | PRIMESI | WFC3 | instrument designated as prime |
2598 | PROCTIME | 55908.85636574 | Pipeline processing time (MJD) |
2599 | PROPAPER | WFC | proposed aperture name |
2600 | PROPOSID | 12440 | PEP proposal identifier |
2601 | PR_INV_F | Sandra | first name of principal investigator |
2602 | PR_INV_L | Faber | last name of principal investigator |
2603 | PR_INV_M | M. | middle name / initial of principal investigat |
2604 | QUADOFFA | 0.190616225 | |
2605 | QUADOFFB | -0.660557125 | |
2606 | QUADOFFC | 0.117621775 | |
2607 | QUADOFFD | 0.352319125 | |
2608 | QUALCOM1 | ||
2609 | QUALCOM2 | ||
2610 | QUALCOM3 | ||
2611 | QUALITY | ||
2612 | RA_APER | 150.1554086126 | RA of aperture reference position |
2613 | RA_TARG | 150.1554086126 | right ascension of the target (deg) (J2000) |
2614 | READNSEA | 4.5700002 | calibrated read noise for amplifier A |
2615 | READNSEB | 3.9100001 | calibrated read noise for amplifier B |
2616 | READNSEC | 4.25 | calibrated read noise for amplifier C |
2617 | READNSED | 4.04 | calibrated read noise for amplifier D |
2618 | REFFRAME | ICRS | guide star catalog version |
2619 | REJ_RATE | 0.0 | rate at which pixels are affected by cosmic ray |
2620 | ROOTNAME | jboa28wmq | rootname of the observation set |
2621 | RPTCORR | OMIT | add individual repeat observations |
2622 | SCALENSE | 0.0 | multiplicative scale factor applied to noise |
2623 | SCLAMP | NONE | lamp status, NONE or name of lamp which is on |
2624 | SDQFLAGS | 31743 | serious data quality flags |
2625 | SHADCORR | OMIT | apply shutter shading correction |
2626 | SHADFILE | jref$kcb17349j_shd.fits | shutter shading correction file |
2627 | SHUTRPOS | A | Shutter position: A or B |
2628 | SIZAXIS1 | 4096 | subarray axis1 size in unbinned detector pixels |
2629 | SIZAXIS2 | 2048 | subarray axis2 size in unbinned detector pixels |
2630 | SKYRMS | 7.873235 | |
2631 | SKYSUB | sky value subtracted (MODE or NONE) | |
2632 | SKYSUM | 0.0 | sky level from the sum of all constituent image |
2633 | SKYVAL | 32.5013968269 | |
2634 | SNRMAX | 233.93831 | maximum signal to noise of good pixels |
2635 | SNRMEAN | 5.9348207 | mean value of signal to noise of good pixels |
2636 | SNRMIN | -3.4609985 | minimum signal to noise of good pixels |
2637 | SOFTERRS | 0 | number of soft error pixels (DQF=1) |
2638 | SPOTTAB | N/A | Coronagraphic spot offset table |
2639 | STATFLAG | False | Calculate statistics? |
2640 | STDCFFF | True | science telemetry fill data present (T=1/F=0) |
2641 | STDCFFP | 0x5569 | science telemetry fill pattern (hex) |
2642 | SUBARRAY | False | data from a subarray (T) or full frame (F) |
2643 | SUNANGLE | 107.339531 | angle between sun and V1 axis |
2644 | SUN_ALT | -32.338875 | altitude of the sun above Earth's limb |
2645 | TARGNAME | ANY | proposer's target name |
2646 | TDDALPHA | 0.2802605508521792 | |
2647 | TDDBETA | -0.0907535169507264 | |
2648 | TELESCOP | HST | telescope used to acquire data |
2649 | TIME-OBS | 13:09:12 | UT time of start of observation (hh:mm:ss) |
2650 | T_SGSTAR | N/A | OMS calculated guide star control |
2651 | VAFACTOR | 1.000104465141 | velocity aberration plate scale factor |
2652 | WCSCDATE | 13:02:32 (10/04/2012) | Time WCS keywords were copied. |
2653 | WFCMPRSD | False | was WFC data compressed? (T/F) |
2654 | WRTERR | True | write out error array extension |
2655 | data | [-6.6392368e-04 -7.4554735e-04 4.8087438e-04 4.6366435e-03\n 4.0622065e-03 1.8645284e-03 -1.6975302e-03 3.0871120e-03\n 5.0989185e-03 3.5293382e-03 -1.5537925e-04 -3.2596183e-03\n -2.8722705e-03 1.7605651e-03 6.0587161e-04 -5.3086010e-04\n -2.7106896e-03 -1.8340673e-03 -4.1120402e-03 2.1634230e-03\n 1.6148441e-04 1.0551643e-03 3.1437965e-03 -1.9191872e-04\n -2.4358691e-04 -1.0489002e-03 -3.5179958e-03 -5.6952843e-04\n 3.2864837e-03 2.7720656e-03 1.3419596e-03 4.1347533e-03\n 1.6661258e-03 6.6848885e-04 -8.8127225e-04 8.7740365e-04\n -5.6074296e-05 1.8788280e-03 2.8152610e-03 3.1932134e-03\n 4.1787865e-04 2.9332149e-03 2.9653248e-03 3.5047496e-04\n -1.1925530e-03 1.4111360e-03 -1.6919562e-03 1.1767941e-03\n -3.4023253e-03 -1.9232254e-03 -1.9277311e-03 -2.3345232e-03\n -1.6488069e-03 -1.0424999e-03 9.7719557e-04 1.3822278e-03\n 1.2308303e-03 2.2039828e-03 6.2716487e-03 1.7309724e-03\n 5.2773790e-04 1.1996093e-03 -2.2492716e-03 4.6352888e-03\n 3.8335519e-03 -2.4438635e-03 5.3681416e-04 5.8531977e-04\n -9.4325340e-04 4.7107969e-04 6.7408051e-04 2.2477907e-04\n 8.8439201e-04 4.1622756e-05 5.1165130e-03 -1.3873057e-04\n -4.1221748e-03 -3.0604929e-03 -2.2900004e-03 4.5243293e-04\n 6.8688835e-03 4.7635818e-03 -4.6979502e-04 1.8519725e-03\n 5.1626731e-03 4.0075271e-03 -1.9586207e-05 -3.0861627e-03\n -6.3474150e-03 -2.7154086e-03 7.9934584e-04 5.1424508e-03\n 6.9035976e-03 4.1878317e-03 8.5889234e-04 -3.9113197e-03\n -4.7257502e-04 5.0681373e-03 3.0521965e-03 1.8753707e-03] | [-2.08625640e-03 -1.80972705e-03 2.64548034e-05 -2.63600319e-04\n 1.42299559e-03 2.02666456e-03 -1.17879244e-04 3.37513071e-03\n 2.49592029e-03 3.04455054e-03 1.94292085e-03 4.74532740e-03\n 1.81267620e-03 5.18500165e-04 7.53829721e-04 9.66044317e-04\n 7.09087937e-04 3.14008095e-03 1.35860278e-03 4.81493538e-03\n 5.10630617e-03 4.88533219e-03 4.36257338e-03 1.68357894e-03\n 6.62868842e-04 -2.26245308e-03 -3.70197045e-03 -1.07296021e-03\n -7.64733530e-04 -4.15749848e-04 -1.84519531e-03 7.24298356e-04\n 9.74487630e-04 2.15133373e-03 3.29656817e-04 -1.46984460e-03\n -1.00637844e-03 -1.76835584e-03 1.25491107e-03 3.45191476e-03\n 6.48635541e-05 5.98746026e-03 5.72868623e-03 5.25044650e-03\n 1.48071221e-03 2.93879583e-03 -5.88457333e-05 2.88247503e-03\n -6.52714749e-04 -1.01292671e-05 -3.86311061e-04 2.91337492e-03\n 3.67482868e-03 -8.25248018e-04 6.31759118e-04 3.33856139e-03\n 3.93944234e-03 1.30851753e-03 4.22561867e-03 2.36554584e-03\n -3.61910765e-03 -3.90761206e-03 -4.05893428e-03 -1.22328533e-03\n -2.05516722e-06 -5.46598202e-03 -2.86481599e-03 1.67676108e-03\n 1.22905069e-03 1.32165919e-03 1.58867298e-03 -1.88102061e-03\n -2.73425505e-03 -4.90673818e-04 4.58174758e-03 -8.69360738e-05\n -1.78016233e-03 2.16756156e-03 -4.98418789e-03 -2.01716903e-03\n 6.11356273e-03 8.95318575e-03 2.79917405e-03 5.37021924e-03\n 4.10461752e-03 5.36447763e-03 4.74915560e-03 2.12171534e-03\n 3.79772135e-03 -1.71951356e-03 -9.02462343e-04 1.02200871e-03\n 1.94186834e-03 4.11595451e-03 2.45072530e-04 -1.47819007e-03\n -1.40658361e-04 3.04506510e-03 -9.74165683e-04 2.42629088e-04] |
2656 | primary_header | None | {'ORIGIN': ('STScI/MAST', 'institution responsible for creating this file'), 'DATE': ('2023-12-20', 'file creation date'), 'PROCVER': ('0.10.0', 'software version'), 'RA_OBJ': (150.0946, '[deg] right ascension'), 'DEC_OBJ': (2.38681, '[deg] declination')} |
2657 | wcs | None | From Transform \n-------------- -------------\n detector CompoundModel\nCelestialFrame None |