EarthLocation¶
- class astropy.coordinates.EarthLocation(*args, **kwargs)[source]¶
Bases:
Quantity
Location on the Earth.
Initialization is first attempted assuming geocentric (x, y, z) coordinates are given; if that fails, another attempt is made assuming geodetic coordinates (longitude, latitude, height above a reference ellipsoid). When using the geodetic forms, Longitudes are measured increasing to the east, so west longitudes are negative. Internally, the coordinates are stored as geocentric.
To ensure a specific type of coordinates is used, use the corresponding class methods (
from_geocentric
andfrom_geodetic
) or initialize the arguments with names (x
,y
,z
for geocentric;lon
,lat
,height
for geodetic). See the class methods for details.Notes
This class fits into the coordinates transformation framework in that it encodes a position on the
ITRS
frame. To get a properITRS
object from this object, use theitrs
property.Attributes Summary
The default ellipsoid used to convert to geodetic coordinates.
Convert to a tuple with X, Y, and Z as quantities
Convert to geodetic coordinates for the default ellipsoid.
Height of the location, for the default ellipsoid.
Container for meta information like name, description, format.
An
ITRS
object for the location of this object at the defaultobstime
.Latitude of the location, for the default ellipsoid.
Longitude of the location, for the default ellipsoid.
The X component of the geocentric coordinates.
The Y component of the geocentric coordinates.
The Z component of the geocentric coordinates.
Methods Summary
from_geocentric
(x, y, z[, unit])Location on Earth, initialized from geocentric coordinates.
from_geodetic
(lon, lat[, height, ellipsoid])Location on Earth, initialized from geodetic coordinates.
get_gcrs
(obstime)GCRS position with velocity at
obstime
as a GCRS coordinate.get_gcrs_posvel
(obstime)Calculate the GCRS position and velocity of this object at the requested
obstime
.get_itrs
([obstime])Generates an
ITRS
object with the location of this object at the requestedobstime
.Get list of names of observatories for use with
of_site
.gravitational_redshift
(obstime[, bodies, masses])Return the gravitational redshift at this EarthLocation.
of_address
(address[, get_height, google_api_key])Return an object of this class for a given address by querying either the OpenStreetMap Nominatim tool [1] (default) or the Google geocoding API [2], which requires a specified API key.
of_site
(site_name)Return an object of this class for a known observatory/site by name.
Convert to a tuple with X, Y, and Z as quantities
to_geodetic
([ellipsoid])Convert to geodetic coordinates.
Attributes Documentation
- ellipsoid¶
The default ellipsoid used to convert to geodetic coordinates.
- geocentric¶
Convert to a tuple with X, Y, and Z as quantities
- geodetic¶
Convert to geodetic coordinates for the default ellipsoid.
- height¶
Height of the location, for the default ellipsoid.
- info¶
Container for meta information like name, description, format. This is required when the object is used as a mixin column within a table, but can be used as a general way to store meta information.
- lat¶
Latitude of the location, for the default ellipsoid.
- lon¶
Longitude of the location, for the default ellipsoid.
- x¶
The X component of the geocentric coordinates.
- y¶
The Y component of the geocentric coordinates.
- z¶
The Z component of the geocentric coordinates.
Methods Documentation
- classmethod from_geocentric(x, y, z, unit=None)[source]¶
Location on Earth, initialized from geocentric coordinates.
- Parameters:
- x, y, z
Quantity
or numpy:array_like Cartesian coordinates. If not quantities,
unit
should be given.- unitastropy:unit-like or
python:None
Physical unit of the coordinate values. If
x
,y
, and/orz
are quantities, they will be converted to this unit.
- x, y, z
- Raises:
astropy.units.UnitsError
If the units on
x
,y
, andz
do not match or an invalid unit is given.ValueError
If the shapes of
x
,y
, andz
do not match.TypeError
If
x
is not aQuantity
and no unit is given.
- classmethod from_geodetic(lon, lat, height=0.0, ellipsoid=None)[source]¶
Location on Earth, initialized from geodetic coordinates.
- Parameters:
- lon
Longitude
orpython:float
Earth East longitude. Can be anything that initialises an
Angle
object (if float, in degrees).- lat
Latitude
orpython:float
Earth latitude. Can be anything that initialises an
Latitude
object (if float, in degrees).- height
Quantity
[:ref: ‘length’] orpython:float
, optional Height above reference ellipsoid (if float, in meters; default: 0).
- ellipsoid
python:str
, optional Name of the reference ellipsoid to use (default: ‘WGS84’). Available ellipsoids are: ‘WGS84’, ‘GRS80’, ‘WGS72’.
- lon
- Raises:
astropy.units.UnitsError
If the units on
lon
andlat
are inconsistent with angular ones, or that onheight
with a length.ValueError
If
lon
,lat
, andheight
do not have the same shape, or ifellipsoid
is not recognized as among the ones implemented.
Notes
For the conversion to geocentric coordinates, the ERFA routine
gd2gc
is used. See https://github.com/liberfa/erfa
- get_gcrs_posvel(obstime)[source]¶
Calculate the GCRS position and velocity of this object at the requested
obstime
.- Parameters:
- obstime
Time
The
obstime
to calculate the GCRS position/velocity at.
- obstime
- Returns:
- obsgeoloc
CartesianRepresentation
The GCRS position of the object
- obsgeovel
CartesianRepresentation
The GCRS velocity of the object
- obsgeoloc
- get_itrs(obstime=None)[source]¶
Generates an
ITRS
object with the location of this object at the requestedobstime
.
- classmethod get_site_names()[source]¶
Get list of names of observatories for use with
of_site
.Note
When this function is called, it will first attempt to download site information from the astropy data server. If it cannot (i.e., an internet connection is not available), it will fall back on the list included with astropy (which is a limited and dated set of sites). If you think a site should be added, issue a pull request to the astropy-data repository .
- Returns:
- names
python:list
ofpython:str
List of valid observatory names
- names
See also
of_site
Gets the actual location object for one of the sites names this returns.
- gravitational_redshift(obstime, bodies=['sun', 'jupiter', 'moon'], masses={})[source]¶
Return the gravitational redshift at this EarthLocation.
Calculates the gravitational redshift, of order 3 m/s, due to the requested solar system bodies.
- Parameters:
- obstime
Time
The
obstime
to calculate the redshift at.- bodiespython:iterable, optional
The bodies (other than the Earth) to include in the redshift calculation. List elements should be any body name
get_body_barycentric
accepts. Defaults to Jupiter, the Sun, and the Moon. Earth is always included (because the class represents an Earth location).- masses
python:dict
[python:str
,Quantity
], optional The mass or gravitational parameters (G * mass) to assume for the bodies requested in
bodies
. Can be used to override the defaults for the Sun, Jupiter, the Moon, and the Earth, or to pass in masses for other bodies.
- obstime
- Returns:
- redshift
Quantity
Gravitational redshift in velocity units at given obstime.
- redshift
- classmethod of_address(address, get_height=False, google_api_key=None)[source]¶
Return an object of this class for a given address by querying either the OpenStreetMap Nominatim tool [1] (default) or the Google geocoding API [2], which requires a specified API key.
This is intended as a quick convenience function to get easy access to locations. If you need to specify a precise location, you should use the initializer directly and pass in a longitude, latitude, and elevation.
In the background, this just issues a web query to either of the APIs noted above. This is not meant to be abused! Both OpenStreetMap and Google use IP-based query limiting and will ban your IP if you send more than a few thousand queries per hour [2].
Warning
If the query returns more than one location (e.g., searching on
address='springfield'
), this function will use the first returned location.- Parameters:
- address
python:str
The address to get the location for. As per the Google maps API, this can be a fully specified street address (e.g., 123 Main St., New York, NY) or a city name (e.g., Danbury, CT), or etc.
- get_heightbool, optional
This only works when using the Google API! See the
google_api_key
block below. Use the retrieved location to perform a second query to the Google maps elevation API to retrieve the height of the input address [3].- google_api_key
python:str
, optional A Google API key with the Geocoding API and (optionally) the elevation API enabled. See [4] for more information.
- address
- Returns:
- location
EarthLocation
(or subclass) instance The location of the input address. Will be type(this class)
- location
References
- classmethod of_site(site_name)[source]¶
Return an object of this class for a known observatory/site by name.
This is intended as a quick convenience function to get basic site information, not a fully-featured exhaustive registry of observatories and all their properties.
Additional information about the site is stored in the
.info.meta
dictionary of sites obtained using this method (see the examples below).Note
When this function is called, it will attempt to download site information from the astropy data server. If you would like a site to be added, issue a pull request to the astropy-data repository . If a site cannot be found in the registry (i.e., an internet connection is not available), it will fall back on a built-in list, In the future, this bundled list might include a version-controlled list of canonical observatories extracted from the online version, but it currently only contains the Greenwich Royal Observatory as an example case.
- Parameters:
- site_name
python:str
Name of the observatory (case-insensitive).
- site_name
- Returns:
- site
EarthLocation
(or subclass) instance The location of the observatory. The returned class will be the same as this class.
- site
See also
get_site_names
the list of sites that this function can access
Examples
>>> from astropy.coordinates import EarthLocation >>> keck = EarthLocation.of_site('Keck Observatory') >>> keck.geodetic GeodeticLocation(lon=<Longitude -155.47833333 deg>, lat=<Latitude 19.82833333 deg>, height=<Quantity 4160. m>) >>> keck.info name = W. M. Keck Observatory dtype = (float64, float64, float64) unit = m class = EarthLocation n_bad = 0 >>> keck.info.meta {'source': 'IRAF Observatory Database', 'timezone': 'US/Hawaii'}
- to_geodetic(ellipsoid=None)[source]¶
Convert to geodetic coordinates.
- Parameters:
- ellipsoid
python:str
, optional Reference ellipsoid to use. Default is the one the coordinates were initialized with. Available are: ‘WGS84’, ‘GRS80’, ‘WGS72’
- ellipsoid
- Returns:
- Raises:
ValueError
if
ellipsoid
is not recognized as among the ones implemented.
Notes
For the conversion to geodetic coordinates, the ERFA routine
gc2gd
is used. See https://github.com/liberfa/erfa