@@ -53,13 +53,13 @@ not explicitly called for TICA.
5353 >>> from astropy.coordinates import SkyCoord
5454 ...
5555 >>> cutout_coord = SkyCoord(107.18696 , - 70.50919 , unit = " deg" )
56- >>> hdulist = Tesscut.get_cutouts(coordinates = cutout_coord)
56+ >>> hdulist = Tesscut.get_cutouts(coordinates = cutout_coord, sector = 33 )
5757 >>> hdulist[0 ].info() # doctest: +IGNORE_OUTPUT
5858 Filename: <class '_io.BytesIO'>
5959 No. Name Ver Type Cards Dimensions Format
60- 0 PRIMARY 1 PrimaryHDU 56 ()
61- 1 PIXELS 1 BinTableHDU 280 1196R x 12C [D, E, J, 25J, 25E, 25E, 25E, 25E, J, E, E, 38A]
62- 2 APERTURE 1 ImageHDU 81 (5, 5) int32
60+ 0 PRIMARY 1 PrimaryHDU 57 ()
61+ 1 PIXELS 1 BinTableHDU 281 3495R x 12C [D, E, J, 25J, 25E, 25E, 25E, 25E, J, E, E, 38A]
62+ 2 APERTURE 1 ImageHDU 82 (5, 5) int32
6363
6464
6565For users with time-sensitive targets who would like cutouts from the latest observations,
@@ -72,7 +72,9 @@ this example shows a request for TICA cutouts:
7272 >>> from astropy.coordinates import SkyCoord
7373 ...
7474 >>> cutout_coord = SkyCoord(107.18696 , - 70.50919 , unit = " deg" )
75- >>> hdulist = Tesscut.get_cutouts(coordinates = cutout_coord, product = ' tica' )
75+ >>> hdulist = Tesscut.get_cutouts(coordinates = cutout_coord,
76+ ... product= ' tica' ,
77+ ... sector= 28 )
7678 >>> hdulist[0 ][0 ].header[' FFI_TYPE' ] # doctest: +IGNORE_OUTPUT
7779 'TICA'
7880
@@ -83,7 +85,7 @@ than a set of coordinates.
8385
8486 >>> from astroquery.mast import Tesscut
8587 ...
86- >>> hdulist = Tesscut.get_cutouts(objectname = " TIC 32449963" )
88+ >>> hdulist = Tesscut.get_cutouts(objectname = " TIC 32449963" , sector = 37 )
8789 >>> hdulist[0 ].info() # doctest: +IGNORE_OUTPUT
8890 Filename: <class '_io.BytesIO'>
8991 No. Name Ver Type Cards Dimensions Format
@@ -106,7 +108,9 @@ simply with either the objectname or coordinates.
106108
107109 >>> from astroquery.mast import Tesscut
108110 ...
109- >>> hdulist = Tesscut.get_cutouts(objectname = " Eleonora" , moving_target = True , size = 5 , sector = 6 )
111+ >>> hdulist = Tesscut.get_cutouts(objectname = " Eleonora" ,
112+ ... moving_target= True ,
113+ ... sector= 6 )
110114 >>> hdulist[0 ].info() # doctest: +IGNORE_OUTPUT
111115 Filename: <class '_io.BytesIO'>
112116 No. Name Ver Type Cards Dimensions Format
@@ -141,12 +145,12 @@ pixel file will be produced for each one.
141145 >>> import astropy.units as u
142146 ...
143147 >>> cutout_coord = SkyCoord(107.18696 , - 70.50919 , unit = " deg" )
144- >>> manifest = Tesscut.download_cutouts(coordinates = cutout_coord, size = [5 , 7 ]* u.arcmin, sector = 9 ) # doctest: +IGNORE_OUTPUT
148+ >>> manifest = Tesscut.download_cutouts(coordinates = cutout_coord, size = [5 , 5 ]* u.arcmin, sector = 9 ) # doctest: +IGNORE_OUTPUT
145149 Downloading URL https://mast.stsci.edu/tesscut/api/v0.1/astrocut?ra=107.18696&dec=-70.50919&y=0.08333333333333333&x=0.11666666666666667&units=d§or=9 to ./tesscut_20210716150026.zip ... [Done]
146150 >>> print (manifest) # doctest: +IGNORE_OUTPUT
147151 Local Path
148152 ----------------------------------------------------------
149- ./tess-s0009-4-1_107.186960_-70.509190_21x15_astrocut .fits
153+ ./tess-s0009-4-1_107.186960_-70.509190_15x15_astrocut .fits
150154
151155The query from the example above defaults to downloading cutouts from SPOC. The following example is a query for
152156the same target from above, but with the product argument passed as TICA to explicitly request for TICA cutouts,
@@ -234,17 +238,6 @@ The following example requests SPOC cutouts for a moving target.
234238Note that the moving targets functionality is not currently available for TICA,
235239so the query will always default to SPOC.
236240
237- .. doctest-remote-data ::
238-
239- >>> from astroquery.mast import Tesscut
240- ...
241- >>> sector_table = Tesscut.get_sectors(objectname = " Ceres" , moving_target = True )
242- >>> print (sector_table)
243- sectorName sector camera ccd
244- -------------- ------ ------ ---
245- tess-s0029-1-4 29 1 4
246- tess-s0043-3-3 43 3 3
247- tess-s0044-2-4 44 2 4
248241
249242Zcut
250243====
@@ -270,7 +263,7 @@ If the given coordinate appears in more than one Zcut survey, a FITS file will b
270263 >>> from astropy.coordinates import SkyCoord
271264 ...
272265 >>> cutout_coord = SkyCoord(189.49206 , 62.20615 , unit = " deg" )
273- >>> hdulist = Zcut.get_cutouts(coordinates = cutout_coord, size = 5 )
266+ >>> hdulist = Zcut.get_cutouts(coordinates = cutout_coord, survey = ' 3dhst_goods-n ' )
274267 >>> hdulist[0 ].info() # doctest: +IGNORE_OUTPUT
275268 Filename: <class '_io.BytesIO'>
276269 No. Name Ver Type Cards Dimensions Format
@@ -292,31 +285,37 @@ If a given coordinate appears in more than one Zcut survey, a cutout will be pro
292285 >>> from astropy.coordinates import SkyCoord
293286 ...
294287 >>> cutout_coord = SkyCoord(189.49206 , 62.20615 , unit = " deg" )
295- >>> manifest = Zcut.download_cutouts(coordinates = cutout_coord, size = [200 , 300 ], units = " px" ) # doctest: +IGNORE_OUTPUT
288+ >>> manifest = Zcut.download_cutouts(coordinates = cutout_coord,
289+ ... size= [5 , 10 ],
290+ ... units= " px" ,
291+ ... survey= " 3dhst_goods-n" ) # doctest: +IGNORE_OUTPUT
296292 Downloading URL https://mast.stsci.edu/zcut/api/v0.1/astrocut?ra=189.49206&dec=62.20615&y=200&x=300&units=px&format=fits to ./zcut_20210125155545.zip ... [Done]
297293 Inflating...
298294 ...
299295 >>> print (manifest) # doctest: +IGNORE_OUTPUT
300296 Local Path
301297 -------------------------------------------------------------------------
302298 ./candels_gn_30mas_189.492060_62.206150_300.0pix-x-200.0pix_astrocut.fits
303-
304-
305- .. doctest-remote-data ::
306-
307- >>> from astroquery.mast import Zcut
308- >>> from astropy.coordinates import SkyCoord
309- ...
310- >>> cutout_coord = SkyCoord(189.49206 , 62.20615 , unit = " deg" )
311- >>> manifest = Zcut.download_cutouts(coordinates = cutout_coord, size = [200 , 300 ], units = " px" , form = " jpg" ) # doctest: +IGNORE_OUTPUT
299+ >>> manifest = Zcut.download_cutouts(coordinates = cutout_coord,
300+ ... size= [5 , 10 ],
301+ ... units= " px" ,
302+ ... survey= " 3dhst_goods-n" ,
303+ ... cutout_format= " jpg" ) # doctest: +IGNORE_OUTPUT
312304 Downloading URL https://mast.stsci.edu/zcut/api/v0.1/astrocut?ra=189.49206&dec=62.20615&y=200&x=300&units=px&format=jpg to ./zcut_20201202132453.zip ... [Done]
313305 ...
314- >>> print (manifest) # doctest: +IGNORE_OUTPUT
315- Local Path
316- ---------------------------------------------------------------------------------------------------------
317- ./hlsp_candels_hst_acs_gn-tot-30mas_f606w_v1.0_drz_189.492060_62.206150_300.0pix-x-200.0pix_astrocut.jpg
318- ./hlsp_candels_hst_acs_gn-tot-30mas_f814w_v1.0_drz_189.492060_62.206150_300.0pix-x-200.0pix_astrocut.jpg
319- ./hlsp_candels_hst_acs_gn-tot-30mas_f850lp_v1.0_drz_189.492060_62.206150_300.0pix-x-200.0pix_astrocut.jpg
306+ >>> print (manifest)
307+ Local Path
308+ -----------------------------------------------------------------------------------------------------
309+ ./hlsp_3dhst_spitzer_irac_goods-n_irac1_v4.0_sc_189.492060_62.206150_10.0pix-x-5.0pix_astrocut.jpg
310+ ./hlsp_3dhst_spitzer_irac_goods-n-s2_irac3_v4.0_sc_189.492060_62.206150_10.0pix-x-5.0pix_astrocut.jpg
311+ ./hlsp_3dhst_spitzer_irac_goods-n-s1_irac4_v4.0_sc_189.492060_62.206150_10.0pix-x-5.0pix_astrocut.jpg
312+ ./hlsp_3dhst_spitzer_irac_goods-n_irac2_v4.0_sc_189.492060_62.206150_10.0pix-x-5.0pix_astrocut.jpg
313+ ./hlsp_3dhst_mayall_mosaic_goods-n_u_v4.0_sc_189.492060_62.206150_10.0pix-x-5.0pix_astrocut.jpg
314+ ./hlsp_3dhst_subaru_suprimecam_goods-n_rc_v4.0_sc_189.492060_62.206150_10.0pix-x-5.0pix_astrocut.jpg
315+ ./hlsp_3dhst_subaru_suprimecam_goods-n_v_v4.0_sc_189.492060_62.206150_10.0pix-x-5.0pix_astrocut.jpg
316+ ./hlsp_3dhst_subaru_suprimecam_goods-n_ic_v4.0_sc_189.492060_62.206150_10.0pix-x-5.0pix_astrocut.jpg
317+ ./hlsp_3dhst_subaru_suprimecam_goods-n_zp_v4.0_sc_189.492060_62.206150_10.0pix-x-5.0pix_astrocut.jpg
318+ ./hlsp_3dhst_subaru_suprimecam_goods-n_b_v4.0_sc_189.492060_62.206150_10.0pix-x-5.0pix_astrocut.jpg
320319
321320
322321Survey information
@@ -387,5 +386,6 @@ If the given coordinate appears in more than one product, a cutout will be produ
387386 Local Path
388387 ---------------------------------------------------------------------------------
389388 ./hst_cutout_skycell-p2007x09y05-ra351d3478-decn28d4978_wfc3_ir_f160w_coarse.fits
389+ ./hst_cutout_skycell-p2007x09y05-ra351d3478-decn28d4978_wfc3_ir_f160w.fits
390390 ./hst_cutout_skycell-p2007x09y05-ra351d3478-decn28d4978_wfc3_uvis_f606w.fits
391391 ./hst_cutout_skycell-p2007x09y05-ra351d3478-decn28d4978_wfc3_uvis_f814w.fits
0 commit comments