Skip to content

Commit f858f36

Browse files
committed
DOC: updating docs to remove extra to_table() calls
1 parent 897906e commit f858f36

File tree

1 file changed

+5
-5
lines changed

1 file changed

+5
-5
lines changed

docs/ipac/irsa/irsa.rst

Lines changed: 5 additions & 5 deletions
Original file line numberDiff line numberDiff line change
@@ -271,7 +271,7 @@ Simple image access queries
271271

272272
`~astroquery.ipac.irsa.IrsaClass.query_sia` provides a way to access IRSA's Simple
273273
Image Access VO service. In the following example we are looking for Spitzer
274-
Enhanced Imaging products in the centre of the COSMOS field as an `~astropy.table.Table`.
274+
Enhanced Imaging products in the centre of the COSMOS field as a `~astropy.table.QTable`.
275275

276276
.. doctest-remote-data::
277277

@@ -280,7 +280,7 @@ Enhanced Imaging products in the centre of the COSMOS field as an `~astropy.tabl
280280
>>> from astropy import units as u
281281
>>>
282282
>>> coord = SkyCoord('150.01d 2.2d', frame='icrs')
283-
>>> spitzer_images = Irsa.query_sia(pos=(coord, 1 * u.arcmin), collection='spitzer_seip').to_table()
283+
>>> spitzer_images = Irsa.query_sia(pos=(coord, 1 * u.arcmin), collection='spitzer_seip')
284284

285285
To list available collections for SIA queries, the
286286
`~astroquery.ipac.irsa.IrsaClass.list_collections` method is provided, and
@@ -342,7 +342,7 @@ Now plot the cutout.
342342
from astropy.wcs import WCS
343343
import matplotlib.pyplot as plt
344344
coord = SkyCoord('150.01d 2.2d', frame='icrs')
345-
spitzer_images = Irsa.query_sia(pos=(coord, 1 * u.arcmin), collection='spitzer_seip').to_table()
345+
spitzer_images = Irsa.query_sia(pos=(coord, 1 * u.arcmin), collection='spitzer_seip')
346346
science_image = spitzer_images[spitzer_images['dataproduct_subtype'] == 'science'][0]
347347
with fits.open(science_image['access_url'], use_fsspec=True) as hdul:
348348
cutout = Cutout2D(hdul[0].section, position=coord, size=2 *
@@ -356,7 +356,7 @@ Simple spectral access queries
356356

357357
`~astroquery.ipac.irsa.IrsaClass.query_ssa` provides a way to access IRSA's Simple
358358
Spectral Access VO service. In the following example we are looking for Spitzer
359-
Enhanced Imaging products in the centre of the COSMOS field as an `~astropy.table.Table`.
359+
Enhanced Imaging products in the centre of the COSMOS field as a `~astropy.table.QTable`.
360360

361361
.. doctest-remote-data::
362362

@@ -365,7 +365,7 @@ Enhanced Imaging products in the centre of the COSMOS field as an `~astropy.tabl
365365
>>> from astropy import units as u
366366
>>>
367367
>>> coord = pos = SkyCoord.from_name('Arp 220')
368-
>>> arp220_spectra = Irsa.query_ssa(pos=coord).to_table()
368+
>>> arp220_spectra = Irsa.query_ssa(pos=coord)
369369

370370
Without specifying the collection, the query returns results from multiple
371371
collections. For example this target has spectra from SOFIA as well as from

0 commit comments

Comments
 (0)