SkybotClass¶
- class astroquery.imcce.SkybotClass[source]¶
Bases:
BaseQuery
A class for querying the IMCCE SkyBoT service.
Attributes Summary
URI used in query to service.
Methods Summary
cone_search
(*args, **kwargs)Queries the service and returns a table object.
cone_search_async
(coo, rad, epoch[, ...])This method queries the IMCCE SkyBoT cone search service and produces a
QTable
object containing all Solar System bodies that might be in the cone defined by the cone center coordinates and epoch provided.Attributes Documentation
- uri¶
URI used in query to service.
Examples
>>> from astroquery.imcce import Skybot >>> from astropy.coordinates import SkyCoord >>> import astropy.units as u >>> from astropy.time import Time >>> field = SkyCoord(1*u.deg, 1*u.deg) >>> epoch = Time('2019-05-29 21:42', format='iso') >>> skybot = Skybot() >>> obj = skybot.cone_search(field, 0.1*u.deg, epoch) >>> skybot.uri 'http://vo.imcce.fr/webservices/skybot/skybotconesearch_query.php?-ra=1.0&-dec=1.0&-rd=0.1&-ep=2458633.404166667&-loc=500&-filter=120.0&-objFilter=111&-refsys=EQJ2000&-output=all&-mime=text'
Methods Documentation
- cone_search(*args, **kwargs)¶
Queries the service and returns a table object.
This method queries the IMCCE SkyBoT cone search service and produces a
QTable
object containing all Solar System bodies that might be in the cone defined by the cone center coordinates and epoch provided.- Parameters:
- coo
SkyCoord
object or tuple Center coordinates of the search cone in ICRS coordinates. If provided as tuple, the input is excepted as (right ascension in degrees, declination in degrees).
- rad
Quantity
object or float Radius of the search cone. If no units are provided (input as float), degrees are assumed. The maximum search radius is 10 degrees; if this maximum radius is exceeded, it will be clipped and a warning will be provided to the user.
- epoch
Time
object, float, or string Epoch of search process in UT. If provided as float, it is interpreted as Julian Date, if provided as string, it is interpreted as date in the form
'YYYY-MM-DD HH-MM-SS'
.- locationint or str, optional
Location of the observer on Earth as defined in the official list of IAU codes. Default: geocentric location (
'500'
)- position_error
Quantity
or float, optional Maximum positional error for targets to be queried. If no unit is provided, arcseconds are assumed. Maximum positional error is 120 arcseconds, larger values are clipped and warning will be provided to the user. Default: 120 arcseconds
- find_planetsboolean, optional
If
True
, planets will be included in the search. Default:True
- find_asteroidsboolean, optional
If
True
, asteroids will be included in the search. Default:True
- find_cometsboolean, optional
If
True
, comets will be included in the search. Default:True
- get_query_payloadboolean, optional
Returns the query payload only and performs no query. Default:
False
- get_raw_responseboolean, optional
Returns the raw response as provided by the IMCCE server instead of the parsed output. Default:
False
- cacheboolean, optional
Cache this specfific query so it might be retrieved faster in the future. Default:
True
- coo
- Returns:
- tableA
Table
object.
- tableA
Notes
The following parameters are queried from the SkyBoT service:
Column Name
Definition
'Number'
Target Number (
-1
if none provided, int)'Name'
Target Name (str)
'RA'
Target RA (J2000, deg, float)
'DEC'
Target declination (J2000, deg, float)
'Type'
Target dynamical/physical type (str)
'V'
Target apparent brightness (V-band, mag, float)
'posunc'
Positional uncertainty (arcsec, float)
'centerdist'
Angular distance of target from cone center (arcsec, float)
'RA_rate'
RA rate of motion (arcsec/hr, float)
'DEC_rate'
Declination rate of motion (arcsec/hr, float)
'geodist'
Geocentric distance of target (au, float)
'heliodist'
Heliocentric distance of target (au, float)
'alpha'
Solar phase angle (deg, float)
'elong'
Solar elongation angle (deg, float)
'x'
Target equatorial vector x (au, float)
'y'
Target equatorial vector y (au, float)
'z'
Target equatorial vector z (au, float)
'vx'
Target velocity vector x (au/d, float)
'vy'
Target velocity vector y (au/d, float)
'vz'
Target velocity vector z (au/d, float)
'epoch'
Ephemerides epoch (JD, float)
Examples
>>> from astroquery.imcce import Skybot >>> from astropy.coordinates import SkyCoord >>> from astropy.time import Time >>> import astropy.units as u >>> field = SkyCoord(1*u.deg, 1*u.deg) >>> epoch = Time('2019-05-29 21:42', format='iso') >>> Skybot.cone_search(field, 0.1*u.deg, epoch) <QTable length=2> Number Name RA ... vy vz epoch deg ... AU / d AU / d d int64 str9 float64 ... float64 float64 float64 ------ --------- ------------------ ... ----------- ----------- --------- 180969 2005 MM39 1.0019566666666666 ... 0.00977568 0.003022634 2458630.0 107804 2001 FV58 1.0765258333333332 ... 0.006551369 0.003846177 2458630.0
- cone_search_async(coo, rad, epoch, location='500', position_error=120, find_planets=True, find_asteroids=True, find_comets=True, get_query_payload=False, get_raw_response=False, cache=True)[source]¶
This method queries the IMCCE SkyBoT cone search service and produces a
QTable
object containing all Solar System bodies that might be in the cone defined by the cone center coordinates and epoch provided.- Parameters:
- coo
SkyCoord
object or tuple Center coordinates of the search cone in ICRS coordinates. If provided as tuple, the input is excepted as (right ascension in degrees, declination in degrees).
- rad
Quantity
object or float Radius of the search cone. If no units are provided (input as float), degrees are assumed. The maximum search radius is 10 degrees; if this maximum radius is exceeded, it will be clipped and a warning will be provided to the user.
- epoch
Time
object, float, or string Epoch of search process in UT. If provided as float, it is interpreted as Julian Date, if provided as string, it is interpreted as date in the form
'YYYY-MM-DD HH-MM-SS'
.- locationint or str, optional
Location of the observer on Earth as defined in the official list of IAU codes. Default: geocentric location (
'500'
)- position_error
Quantity
or float, optional Maximum positional error for targets to be queried. If no unit is provided, arcseconds are assumed. Maximum positional error is 120 arcseconds, larger values are clipped and warning will be provided to the user. Default: 120 arcseconds
- find_planetsboolean, optional
If
True
, planets will be included in the search. Default:True
- find_asteroidsboolean, optional
If
True
, asteroids will be included in the search. Default:True
- find_cometsboolean, optional
If
True
, comets will be included in the search. Default:True
- get_query_payloadboolean, optional
Returns the query payload only and performs no query. Default:
False
- get_raw_responseboolean, optional
Returns the raw response as provided by the IMCCE server instead of the parsed output. Default:
False
- cacheboolean, optional
Cache this specfific query so it might be retrieved faster in the future. Default:
True
- coo
Notes
The following parameters are queried from the SkyBoT service:
Column Name
Definition
'Number'
Target Number (
-1
if none provided, int)'Name'
Target Name (str)
'RA'
Target RA (J2000, deg, float)
'DEC'
Target declination (J2000, deg, float)
'Type'
Target dynamical/physical type (str)
'V'
Target apparent brightness (V-band, mag, float)
'posunc'
Positional uncertainty (arcsec, float)
'centerdist'
Angular distance of target from cone center (arcsec, float)
'RA_rate'
RA rate of motion (arcsec/hr, float)
'DEC_rate'
Declination rate of motion (arcsec/hr, float)
'geodist'
Geocentric distance of target (au, float)
'heliodist'
Heliocentric distance of target (au, float)
'alpha'
Solar phase angle (deg, float)
'elong'
Solar elongation angle (deg, float)
'x'
Target equatorial vector x (au, float)
'y'
Target equatorial vector y (au, float)
'z'
Target equatorial vector z (au, float)
'vx'
Target velocity vector x (au/d, float)
'vy'
Target velocity vector y (au/d, float)
'vz'
Target velocity vector z (au/d, float)
'epoch'
Ephemerides epoch (JD, float)
Examples
>>> from astroquery.imcce import Skybot >>> from astropy.coordinates import SkyCoord >>> from astropy.time import Time >>> import astropy.units as u >>> field = SkyCoord(1*u.deg, 1*u.deg) >>> epoch = Time('2019-05-29 21:42', format='iso') >>> Skybot.cone_search(field, 0.1*u.deg, epoch) <QTable length=2> Number Name RA ... vy vz epoch deg ... AU / d AU / d d int64 str9 float64 ... float64 float64 float64 ------ --------- ------------------ ... ----------- ----------- --------- 180969 2005 MM39 1.0019566666666666 ... 0.00977568 0.003022634 2458630.0 107804 2001 FV58 1.0765258333333332 ... 0.006551369 0.003846177 2458630.0