diff --git a/astroquery/imcce/__init__.py b/astroquery/imcce/__init__.py
index 3fe1fbee94..228e0e509a 100644
--- a/astroquery/imcce/__init__.py
+++ b/astroquery/imcce/__init__.py
@@ -18,10 +18,10 @@ class Conf(_config.ConfigNamespace):
# server settings
ephemcc_server = _config.ConfigItem(
- 'http://vo.imcce.fr/webservices/miriade/ephemcc_query.php',
+ 'https://ssp.imcce.fr/webservices/miriade/api/ephemcc.php',
'IMCCE/Miriade.ephemcc base server')
skybot_server = _config.ConfigItem(
- ['http://vo.imcce.fr/webservices/skybot/skybotconesearch_query.php'],
+ ['https://ssp.imcce.fr/webservices/skybot/api/conesearch.php'],
'SkyBoT')
timeout = _config.ConfigItem(
diff --git a/astroquery/imcce/core.py b/astroquery/imcce/core.py
index dbfd0a5384..70f6e58ca1 100644
--- a/astroquery/imcce/core.py
+++ b/astroquery/imcce/core.py
@@ -23,7 +23,7 @@
class MiriadeClass(BaseQuery):
"""
A class for querying the
- `IMCCE/Miriade `_ service.
+ `IMCCE/Miriade `_ service.
"""
_query_uri = None # uri used in query
@@ -49,8 +49,8 @@ def get_ephemerides_async(self, targetname, *, objtype='asteroid',
get_raw_response=False, cache=True):
"""
Query the
- `IMCCE Miriade `_
- `ephemcc `_
+ `IMCCE Miriade `_
+ `ephemcc `_
service.
@@ -85,14 +85,14 @@ def get_ephemerides_async(self, targetname, *, objtype='asteroid',
location : str, optional
Location of the observer on Earth as a code or a set of
coordinates. See the
- `Miriade manual `_
+ `Miriade manual `_
for details. Default: geocentric location (``'500'``)
coordtype : int, optional
Type of coordinates to be calculated: ``1``: spherical, ``2``:
rectangular, ``3``: local coordinates (azimuth and elevation),
``4``: hour angle coordinates, ``5``: dedicated to observation,
- ``6``: dedicated to AO observation. Default: ``1``
+ Default: ``1``
timescale : str, optional
The time scale used in the computation of the ephemerides:
@@ -142,42 +142,38 @@ def get_ephemerides_async(self, targetname, *, objtype='asteroid',
+------------------+-----------------------------------------------+
| Column Name | Definition |
+==================+===============================================+
- | ``target`` | Target name (str, 1, 2, 3, 4, 5, 6 ) |
- +------------------+-----------------------------------------------+
- | ``epoch`` | Ephemerides epoch (JD, float, 1, 2, 3, 4, 5, |
- | | 6) |
+ | ``epoch`` | Ephemerides epoch (JD, float, 1, 2, 3, 4, 5) |
+------------------+-----------------------------------------------+
| ``RA`` | Target RA at ``ephtype`` (deg, float, 1) |
+------------------+-----------------------------------------------+
| ``DEC`` | Target declination at ``ephtype`` (deg, |
| | float, 1, 4, 5) |
+------------------+-----------------------------------------------+
- | ``RAJ2000`` | Target RA at J2000 (deg, float, 5, 6) |
+ | ``RAJ2000`` | Target RA at J2000 (deg, float, 5) |
+------------------+-----------------------------------------------+
- | ``DECJ2000`` | Target declination at J2000 (deg, float, 5, 6)|
+ | ``DECJ2000`` | Target declination at J2000 (deg, float, 5) |
+------------------+-----------------------------------------------+
| ``AZ`` | Target azimuth (deg, float, 3, 5) |
+------------------+-----------------------------------------------+
| ``EL`` | Target elevation (deg, float, 3, 5) |
+------------------+-----------------------------------------------+
| ``delta`` | Distance from observer (au, float, 1, 2, 3, |
- | | 4, 5, 6) |
+ | | 4, 5) |
+------------------+-----------------------------------------------+
- | ``delta_rate`` | Rate in observer distance (km/s, float, |
- | | 1, 5, 6) |
+ | ``delta_rate`` | Rate in observer distance (km/s, float, 1, 5) |
+------------------+-----------------------------------------------+
| ``V`` | Apparent visual magnitude (mag, float, 1, 2, |
- | | 3, 4, 5, 6) |
+ | | 3, 4, 5) |
+------------------+-----------------------------------------------+
- | ``alpha`` | Solar phase angle (deg, 1, 2, 3, 4, 5, 6) |
+ | ``alpha`` | Solar phase angle (deg, 1, 2, 3, 4, 5) |
+------------------+-----------------------------------------------+
- | ``elong`` | Solar elongation angle (deg, 1, 2, 3, 4, 5, 6)|
+ | ``elong`` | Solar elongation angle (deg, 1, 2, 3, 4, 5) |
+------------------+-----------------------------------------------+
| ``RAcosD_rate`` | Rate of motion in RA * cos(DEC) (arcsec/min, |
- | | float, 1, 5, 6) |
+ | | float, 1, 5) |
+------------------+-----------------------------------------------+
| ``DEC_rate`` | Rate of motion in DEC (arcsec/min, float, 1, |
- | | 5, 6) |
+ | | 5) |
+------------------+-----------------------------------------------+
| ``x`` | X position state vector (au, float, 2) |
+------------------+-----------------------------------------------+
@@ -193,8 +189,7 @@ def get_ephemerides_async(self, targetname, *, objtype='asteroid',
+------------------+-----------------------------------------------+
| ``rv`` | Radial velocity (km/s, float, 2) |
+------------------+-----------------------------------------------+
- | ``heldist`` | Target heliocentric distance (au, float, 2, |
- | | 5, 6) |
+ | ``heldist`` | Target heliocentric distance (au, float, 2, 5)|
+------------------+-----------------------------------------------+
| ``x_h`` | X heliocentric position vector (au, float, 2) |
+------------------+-----------------------------------------------+
@@ -210,13 +205,13 @@ def get_ephemerides_async(self, targetname, *, objtype='asteroid',
+------------------+-----------------------------------------------+
| ``hourangle`` | Target hour angle (deg, float, 4, 5) |
+------------------+-----------------------------------------------+
- | ``siderealtime`` | Local sidereal time (hr, float, 5, 6) |
+ | ``siderealtime`` | Local sidereal time (hr, float, 5) |
+------------------+-----------------------------------------------+
- | ``refraction`` | Atmospheric refraction (arcsec, float, 5, 6) |
+ | ``refraction`` | Atmospheric refraction (arcsec, float, 5) |
+------------------+-----------------------------------------------+
- | ``airmass`` | Target airmass (float, 5, 6) |
+ | ``airmass`` | Target airmass (float, 5) |
+------------------+-----------------------------------------------+
- | ``posunc`` | Positional uncertainty (arcsec, float, 5, 6) |
+ | ``posunc`` | Positional uncertainty (arcsec, float, 5) |
+------------------+-----------------------------------------------+
@@ -299,17 +294,27 @@ def _parse_result(self, response, *, verbose=None):
votable = parse(voraw)
data = votable.get_first_table().to_table()
- # modify table columns
+ # modify table columns. This is an ugly hack as astropy's votable parser
+ # is not yet capable of parsing some of these properly.
+ # Also, not clear why some of the columns are now parsed as object as
+ # opposed to strings, workaround here is to do .astype()
+
+ data['date'] = Time(data['date'].astype('str'), format='isot')
+
+ # Adding for backwards compatibility
+ data['epoch'] = data['date'].jd
data['epoch'].unit = u.d
- if 'ra' in data.columns:
- data['ra'] = Angle(data['ra'], unit=u.hourangle).deg*u.deg
- data.rename_column('ra', 'RA')
+ if 'RA' in data.columns:
+ data['RA'] = Angle(data['RA'].astype('str'), unit=u.hourangle).deg*u.deg
+
+ if 'DEC' in data.columns:
+ data['DEC'] = Angle(data['DEC'], unit=u.deg).deg*u.deg
if 'dec' in data.columns:
- data['dec'] = Angle(data['dec'], unit=u.deg).deg*u.deg
data.rename_column('dec', 'DEC')
+ # These don't seem to be returned with the new API/url, as of 2025-04-07
if 'raJ2000' in data.columns and 'decJ2000' in data.columns:
data['raJ2000'] = Angle(
data['raJ2000'], unit=u.hourangle).deg*u.deg
@@ -342,6 +347,9 @@ def _parse_result(self, response, *, verbose=None):
data['vy_h'].unit = u.au/u.day
data['vz_h'].unit = u.au/u.day
+ if 'dobs' in data.columns:
+ data.rename_column('dobs', 'delta')
+
if 'distance' in data.columns:
data.rename_column('distance', 'delta')
@@ -358,8 +366,8 @@ def _parse_result(self, response, *, verbose=None):
data.rename_column('azimut', 'AZ')
data.rename_column('elevation', 'EL')
- if 'mv' in data.columns:
- data.rename_column('mv', 'V')
+ if 'vmag' in data.columns:
+ data.rename_column('vmag', 'V')
data['V'].unit = u.mag
if 'phase' in data.columns:
@@ -368,14 +376,14 @@ def _parse_result(self, response, *, verbose=None):
if 'elongation' in data.columns:
data.rename_column('elongation', 'elong')
- if 'dracosdec' in data.columns:
- data.rename_column('dracosdec', 'RAcosD_rate')
+ if 'dRAcosDEC' in data.columns:
+ data.rename_column('dRAcosDEC', 'RAcosD_rate')
- if 'ddec' in data.columns:
- data.rename_column('ddec', 'DEC_rate')
+ if 'dDEC' in data.columns:
+ data.rename_column('dDEC', 'DEC_rate')
- if 'dist_dot' in data.columns:
- data.rename_column('dist_dot', 'delta_rate')
+ if 'rv' in data.columns:
+ data.rename_column('rv', 'delta_rate')
if 'lst' in data.columns:
data.rename_column('lst', 'siderealtime')
@@ -418,7 +426,7 @@ def uri(self):
>>> skybot = Skybot()
>>> obj = skybot.cone_search(field, 0.1*u.deg, epoch) # doctest: +SKIP
>>> skybot.uri # doctest: +SKIP
- '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'
+ 'https://ssp.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'
"""
return self._uri
@@ -437,7 +445,7 @@ def cone_search_async(self,
cache=True):
"""
This method queries the IMCCE
- `SkyBoT `_
+ `SkyBoT `_
cone search service and produces a `~astropy.table.QTable` object
containing all Solar System bodies that might be in the cone
defined by the cone center coordinates and epoch provided.
diff --git a/astroquery/imcce/tests/data/3552_coordtype1.dat b/astroquery/imcce/tests/data/3552_coordtype1.dat
index d8e5f62ad9..300ab4c4ec 100644
--- a/astroquery/imcce/tests/data/3552_coordtype1.dat
+++ b/astroquery/imcce/tests/data/3552_coordtype1.dat
@@ -1,68 +1,136 @@
-
-
-
-
-
-
-Miriade - Positional ephemeris
-
-Positional ephemeris
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-Name or designation of the target
-
-
-Julian day (UTC)
-
-
-Right ascension of target centre
-
-
-Declination of target centre
-
-
-Distance from observer
-
-
-Apparent visual magnitude
-
-
-Phase angle
-
-
-Solar elongation
-
-
-Rate of change of target center RA (multiplied by the cosine of the declination)
-
-
-Rate of change of target center DE
-
-
-Rate of change of target distance from observer
-
-
-
-Don Quixote 2458516.4295727154201 37 2.87184+43 35 17.4235 3.008900447 18.72 18.36 87.55 0.56253E+00-0.58523E-01 34.0401852
-
-
-
-
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+ Planetary theory used to compute the ephemeris
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+ Berthier et al., 2009, EPSC, 676
+
+
+
+ Positional ephemerides of solar system objects
+
+
+
+
+
+
+
+
+ Planetary theory
+
+
+ Frame type
+
+
+ Coordinate type
+
+
+ Frame center
+
+
+ Precession/nutation model
+
+
+ Relativistic perturbations
+
+
+ PPN coordinate system
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+ Date
+
+
+ Right ascension
+
+
+ Declination
+
+
+ Range of target center to observer
+
+
+ Apparent magnitude
+
+
+ Phase angle
+
+
+ Sun elongation
+
+
+ Component of proper motion in right ascension corrected for the declination
+
+
+ Component of proper motion in declination
+
+
+ Radial velocity of target wrt observer
+
+
+
+
+ 2025-04-08T02:36:37.153
+ +10 22 30.22549
+ +18 39 43.4505
+ 4.782045321
+ 20.69
+ 7.78
+ 131.94
+ -0.2772E+00
+ -0.1617E-01
+ 13.26617
+
+
+
+
+
-
diff --git a/astroquery/imcce/tests/data/3552_coordtype2.dat b/astroquery/imcce/tests/data/3552_coordtype2.dat
index cf099200b4..70af3bd9eb 100644
--- a/astroquery/imcce/tests/data/3552_coordtype2.dat
+++ b/astroquery/imcce/tests/data/3552_coordtype2.dat
@@ -1,95 +1,150 @@
-
-
-
-
-
-
-Miriade - Positional ephemeris
-
-Positional ephemeris
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-Name or designation of the target
-
-
-Julian day (UTC)
-
-
-X position state vector
-
-
-Y position state vector
-
-
-Z position state vector
-
-
-X velocity state vector
-
-
-Y velocity state vector
-
-
-Z velocity state vector
-
-
-Target-observer distance
-
-
-Apparent visual magnitude
-
-
-Phase angle
-
-
-Solar elongation
-
-
-Radial velocity
-
-
-Sun-target distance
-
-
-X heliocentric position state vector
-
-
-Y heliocentric position state vector
-
-
-Z heliocentric position state vector
-
-
-X heliocentric velocity state vector
-
-
-Y heliocentric velocity state vector
-
-
-Z heliocentric velocity state vector
-
-
-
-Don Quixote 2458516.42987012491 1.9869001083502 0.8955362983387 2.0745505019470 0.0088993149147 0.0169725486824 0.0126644662530 3.0089062942094 18.72 18.36 87.55 34.040 3.1311694826006 1.3210362670716 1.5621709981656 2.3636294969639 -0.0040714189833 0.0062462212313 0.0080150276734
-
-
-
-
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+ Planetary theory used to compute the ephemeris
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+ Berthier et al., 2009, EPSC, 676
+
+
+
+ Positional ephemerides of solar system objects
+
+
+
+
+
+
+
+
+
+
+ Planetary theory
+
+
+ Frame type
+
+
+ Coordinate type
+
+
+ Frame center
+
+
+ Precession/nutation model
+
+
+ Relativistic perturbations
+
+
+ PPN coordinate system
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+ Date
+
+
+ X-component of position vector of the target
+
+
+ Y-component of position vector of the target
+
+
+ Z-component of position vector of the target
+
+
+ Range of target center to observer
+
+
+ Heliocentric range
+
+
+ Phase angle
+
+
+ Sun elongation
+
+
+ Apparent magnitude
+
+
+ X-component of velocity vector of the target
+
+
+ Y-component of velocity vector of the target
+
+
+ Z-component of velocity vector of the target
+
+
+ Radial velocity of target wrt observer
+
+
+
+
+ 2460773.6042106
+ -4.1267918766151
+ 1.8696972551604
+ 1.5301780377197
+ 4.7820104397597
+ 5.5019000808637
+ 7.78
+ 131.95
+ 20.694
+ -0.0029491685074
+ 0.0114965565690
+ 0.0019402583293
+ 13.265
+
+
+
+
+
-
diff --git a/astroquery/imcce/tests/data/3552_coordtype3.dat b/astroquery/imcce/tests/data/3552_coordtype3.dat
index dcc2457ccf..9be05c20d7 100644
--- a/astroquery/imcce/tests/data/3552_coordtype3.dat
+++ b/astroquery/imcce/tests/data/3552_coordtype3.dat
@@ -1,61 +1,119 @@
-
-
-
-
-
-
-Miriade - Positional ephemeris
-
-Positional ephemeris
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-Name or designation of the target
-
-
-Julian day (UTC)
-
-
-Azimuth of target centre
-
-
-Elevation of target centre
-
-
-Apparent visual magnitude
-
-
-Distance from observer
-
-
-Phase angle
-
-
-Solar elongation
-
-
-
-Don Quixote 2458516.42997361580299 13 9.022+34 16 22.96 18.72 3.008884287 18.36 87.55
-
-
-
-
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+ Planetary theory used to compute the ephemeris
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+ Berthier et al., 2009, EPSC, 676
+
+
+
+ Positional ephemerides of solar system objects
+
+
+
+
+
+
+ Planetary theory
+
+
+ Frame type
+
+
+ Coordinate type
+
+
+ Frame center
+
+
+ Precession/nutation model
+
+
+ Relativistic perturbations
+
+
+ PPN coordinate system
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+ Date
+
+
+ Range of target center to observer
+
+
+ Apparent magnitude
+
+
+ Phase angle
+
+
+ Sun elongation
+
+
+ Radial velocity of target wrt observer
+
+
+
+
+ 2025-04-08T02:37:08.176
+ 4.7820480722237
+ 20.694
+ 7.78
+ 131.94
+ 13.266
+
+
+
+
+
diff --git a/astroquery/imcce/tests/data/3552_coordtype4.dat b/astroquery/imcce/tests/data/3552_coordtype4.dat
index 3d98aee1f0..5811fa42da 100644
--- a/astroquery/imcce/tests/data/3552_coordtype4.dat
+++ b/astroquery/imcce/tests/data/3552_coordtype4.dat
@@ -1,61 +1,123 @@
-
-
-
-
-
-
-Miriade - Positional ephemeris
-
-Positional ephemeris
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-Name or designation of the target
-
-
-Julian day (UTC)
-
-
-Hour angle of target centre
-
-
-Declination of target centre
-
-
-Apparent visual magnitude
-
-
-Distance from observer
-
-
-Phase angle
-
-
-Solar elongation
-
-
-
-Don Quixote 2458516.43007193878 5 38 55.14+43 35 15.92 18.72 3.008886232 18.36 87.55
-
-
-
-
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+ Planetary theory used to compute the ephemeris
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+ Berthier et al., 2009, EPSC, 676
+
+
+
+ Positional ephemerides of solar system objects
+
+
+
+
+
+
+
+ Planetary theory
+
+
+ Frame type
+
+
+ Coordinate type
+
+
+ Frame center
+
+
+ Precession/nutation model
+
+
+ Relativistic perturbations
+
+
+ PPN coordinate system
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+ Date
+
+
+ Declination
+
+
+ Range of target center to observer
+
+
+ Apparent magnitude
+
+
+ Phase angle
+
+
+ Sun elongation
+
+
+ Radial velocity of target wrt observer
+
+
+
+
+ 2025-04-08T02:46:17.979
+ 18.6620
+ 4.7820968340710
+ 20.694
+ 7.78
+ 131.94
+ 13.269
+
+
+
+
+
-
diff --git a/astroquery/imcce/tests/data/3552_coordtype5.dat b/astroquery/imcce/tests/data/3552_coordtype5.dat
index c2485deb48..de8e669057 100644
--- a/astroquery/imcce/tests/data/3552_coordtype5.dat
+++ b/astroquery/imcce/tests/data/3552_coordtype5.dat
@@ -1,97 +1,141 @@
-
-
-
-
-
-
-Miriade - Positional ephemeris
-
-Positional ephemeris
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-Name or designation of the target
-
-
-Julian day (UTC)
-
-
-Local sideral time
-
-
-J2000 right ascension of the target
-
-
-J2000 declination of the target
-
-
-Hour angle of target centre
-
-
-Declination of target centre
-
-
-Azimuth of target centre
-
-
-Elevation of target centre
-
-
-Atmospheric refraction
-
-
-Air mass
-
-
-Apparent visual magnitude
-
-
-Observer-target distance
-
-
-Sun-target distance
-
-
-Phase angle
-
-
-Solar elongation
-
-
-Current ephemeris uncertainty
-
-
-Rate of change of target center RA (multiplied by the cosine of the declination)
-
-
-Rate of change of target center DE
-
-
-Rate of change of target distance from observer
-
-
-
-Don Quixote 2458516.43017231347 7.26849 1 37 2.74+43 35 15.92 5 39 3.83+43 35 15.92 299 15 26.75+34 13 54.7792.411.77 18.72 3.00888822 3.131171741 18.36 87.55 0.0244 0.56174E+00-0.64308E-01 34.2608039
-
-
-
-
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+ Planetary theory used to compute the ephemeris
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+ Berthier et al., 2009, EPSC, 676
+
+
+
+ Positional ephemerides of solar system objects
+
+
+
+
+
+
+
+
+
+ Planetary theory
+
+
+ Frame type
+
+
+ Coordinate type
+
+
+ Frame center
+
+
+ Precession/nutation model
+
+
+ Relativistic perturbations
+
+
+ PPN coordinate system
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+ Date
+
+
+ Right ascension
+
+
+ Declination
+
+
+ Range of target center to observer
+
+
+ Heliocentric range
+
+
+ Apparent magnitude
+
+
+ Phase angle
+
+
+ Sun elongation
+
+
+ Component of proper motion in right ascension corrected for the declination
+
+
+ Component of proper motion in declination
+
+
+ Radial velocity of target wrt observer
+
+
+
+
+ 2025-04-08T02:46:43.646
+ +10 22 30.0283
+ +18 39 43.287
+ 4.782099111
+ 5.501851832
+ 20.694
+ 7.78
+ 131.94
+ -0.2771E+00
+ -0.1620E-01
+ 13.26865
+
+
+
+
+
-
diff --git a/astroquery/imcce/tests/data/3552_coordtype6.dat b/astroquery/imcce/tests/data/3552_coordtype6.dat
deleted file mode 100644
index 2489d450db..0000000000
--- a/astroquery/imcce/tests/data/3552_coordtype6.dat
+++ /dev/null
@@ -1,83 +0,0 @@
-
-
-
-
-
-
-Miriade - Positional ephemeris
-
-Positional ephemeris
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-Name or designation of the target
-
-
-Julian day (UTC)
-
-
-Local sideral time
-
-
-J2000 right ascension of the target
-
-
-J2000 declination of the target
-
-
-Atmospheric refraction
-
-
-Air mass
-
-
-Apparent visual magnitude
-
-
-Observer-target distance
-
-
-Sun-target distance
-
-
-Phase angle
-
-
-Solar elongation
-
-
-Current ephemeris uncertainty
-
-
-Rate of change of target center RA (multiplied by the cosine of the declination)
-
-
-Rate of change of target center DE
-
-
-Rate of change of target distance from observer
-
-
-
-Don Quixote 2458516.43759827130 7.44720 1 37 3.47+43 35 16.7597.891.85 18.72 3.00905822 3.131227200 18.36 87.55 0.0244 0.56257E+00-0.58484E-01 34.0402653
-
-
-
-
-
-
diff --git a/astroquery/imcce/tests/test_miriade.py b/astroquery/imcce/tests/test_miriade.py
index ac9049502b..0df074d6aa 100644
--- a/astroquery/imcce/tests/test_miriade.py
+++ b/astroquery/imcce/tests/test_miriade.py
@@ -42,9 +42,9 @@ def patch_request(request):
def test_spherical_coordinates(patch_request):
eph = Miriade.get_ephemerides('3552', coordtype=1)
- cols = ('target', 'epoch', 'RA', 'DEC', 'delta', 'V', 'alpha', 'elong',
+ cols = ('epoch', 'RA', 'DEC', 'delta', 'V', 'alpha', 'elong',
'RAcosD_rate', 'DEC_rate', 'delta_rate')
- units = (None, u.d, u.deg, u.deg, u.au, u.mag, u.deg, u.deg,
+ units = (u.d, u.deg, u.deg, u.au, u.mag, u.deg, u.deg,
u.arcsec / u.minute, u.arcsec / u.minute, u.km / u.s)
for i in range(len(cols)):
assert cols[i] in eph.columns
@@ -53,12 +53,12 @@ def test_spherical_coordinates(patch_request):
def test_rectangular_coordinates(patch_request):
eph = Miriade.get_ephemerides('3552', coordtype=2)
- cols = ('target', 'epoch', 'x', 'y', 'z',
+ cols = ('epoch', 'x', 'y', 'z',
'vx', 'vy', 'vz', 'delta', 'V',
'alpha', 'elong', 'rv', 'heldist',
'x_h', 'y_h', 'z_h',
'vx_h', 'vy_h', 'vz_h')
- units = (None, u.d, u.au, u.au, u.au, u.au/u.day, u.au/u.day,
+ units = (u.d, u.au, u.au, u.au, u.au/u.day, u.au/u.day,
u.au/u.day, u.au, u.mag, u.deg, u.deg, u.km/u.s,
u.au, u.au, u.au, u.au, u.au/u.day, u.au/u.day, u.au/u.day)
for i in range(len(cols)):
@@ -68,8 +68,8 @@ def test_rectangular_coordinates(patch_request):
def test_local_coordinates(patch_request):
eph = Miriade.get_ephemerides('3552', coordtype=3)
- cols = ('target', 'epoch', 'AZ', 'EL', 'V', 'delta', 'alpha', 'elong')
- units = (None, u.day, u.deg, u.deg, u.mag, u.au, u.deg, u.deg)
+ cols = ('epoch', 'AZ', 'EL', 'V', 'delta', 'alpha', 'elong')
+ units = (u.day, u.deg, u.deg, u.mag, u.au, u.deg, u.deg)
for i in range(len(cols)):
assert cols[i] in eph.columns
assert eph[cols[i]].unit == units[i]
@@ -77,9 +77,9 @@ def test_local_coordinates(patch_request):
def test_hourangle_coordinates(patch_request):
eph = Miriade.get_ephemerides('3552', coordtype=4)
- cols = ('target', 'epoch', 'hourangle',
+ cols = ('epoch', 'hourangle',
'DEC', 'V', 'delta', 'alpha', 'elong')
- units = (None, u.d, u.deg, u.deg, u.mag, u.au, u.deg, u.deg)
+ units = (u.d, u.deg, u.deg, u.mag, u.au, u.deg, u.deg)
for i in range(len(cols)):
assert cols[i] in eph.columns
assert eph[cols[i]].unit == units[i]
@@ -87,11 +87,11 @@ def test_hourangle_coordinates(patch_request):
def test_observation_coordinates(patch_request):
eph = Miriade.get_ephemerides('3552', coordtype=5)
- cols = ('target', 'epoch', 'siderealtime', 'RAJ2000', 'DECJ2000',
+ cols = ('epoch', 'siderealtime', 'RAJ2000', 'DECJ2000',
'hourangle', 'DEC', 'AZ', 'EL', 'refraction',
'V', 'delta', 'heldist', 'alpha', 'elong', 'posunc',
'RAcosD_rate', 'DEC_rate', 'delta_rate')
- units = (None, u.d, u.h, u.deg, u.deg, u.deg, u.deg, u.deg, u.deg,
+ units = (u.d, u.h, u.deg, u.deg, u.deg, u.deg, u.deg, u.deg,
u.arcsec, u.mag, u.au, u.au, u.deg, u.deg, u.arcsec,
u.arcsec / u.minute, u.arcsec / u.minute, u.km / u.s)
for i in range(len(cols)):
@@ -99,20 +99,7 @@ def test_observation_coordinates(patch_request):
assert eph[cols[i]].unit == units[i]
-def test_aoobservation_coordinates(patch_request):
- eph = Miriade.get_ephemerides('3552', coordtype=6)
- cols = ('target', 'epoch', 'siderealtime', 'RAJ2000', 'DECJ2000',
- 'refraction', 'V', 'delta', 'heldist', 'alpha',
- 'elong', 'posunc', 'RAcosD_rate', 'DEC_rate', 'delta_rate')
- units = (None, u.d, u.h, u.deg, u.deg, u.arcsec, u.mag,
- u.au, u.au, u.deg, u.deg, u.arcsec, u.arcsec / u.minute,
- u.arcsec / u.minute, u.km / u.s)
- for i in range(len(cols)):
- assert cols[i] in eph.columns
- assert eph[cols[i]].unit == units[i]
-
-
def test_get_raw_response(patch_request):
raw_eph = Miriade.get_ephemerides(
'3552', coordtype=1, get_raw_response=True)
- assert "" in raw_eph
+ assert '' in raw_eph
diff --git a/astroquery/imcce/tests/test_miriade_remote.py b/astroquery/imcce/tests/test_miriade_remote.py
index 4037850cca..61a1d67acb 100644
--- a/astroquery/imcce/tests/test_miriade_remote.py
+++ b/astroquery/imcce/tests/test_miriade_remote.py
@@ -4,7 +4,7 @@
import numpy.testing as npt
import pytest
-from .. import core
+from astroquery.imcce import Miriade
@pytest.mark.remote_data
@@ -13,10 +13,8 @@ class TestMiriadeClass:
def test_ephemerides(self):
# check values of Ceres for a given epoch
# orbital uncertainty of Ceres is basically zero
- res = core.Miriade.get_ephemerides('Ceres', location='500',
- epoch=2451544.5)
-
- assert res['target'] == "Ceres"
+ res = Miriade.get_ephemerides('Ceres', location='500',
+ epoch=2451544.5)
npt.assert_allclose(
[2451544.5, 188.70280, 9.09829],
diff --git a/docs/imcce/imcce.rst b/docs/imcce/imcce.rst
index e97b21d97c..15247f51a1 100644
--- a/docs/imcce/imcce.rst
+++ b/docs/imcce/imcce.rst
@@ -205,7 +205,7 @@ Pallas over an entire year with a time step of 1 day:
The observer location is defined through the ``location`` keyword,
expecting a string containing the official IAU observatory code, a
spacecraft name, or a set of coordinates (see the `Miriade manual
-`_ for
+`_ for
details).
@@ -219,7 +219,7 @@ query, the coordinate type in
`~astroquery.imcce.MiriadeClass.get_ephemerides` is defined through
an integer value. For a full discussion of the different coordinate
types we refer to `this section
-`_ of the
+`_ of the
Miriade website. The keyword ``coordtype`` controls which set of
coordinates and properties are queried.