参考/API#

天文坐标包裹#

这个子包包含天文物体天体坐标的类和函数。它还包含坐标系之间转换的框架。

功能#

angular_separation(lon1, lat1, lon2, lat2)

球面上两点之间的角度间隔。

cartesian_to_spherical(x, y, z)

将三维直角笛卡尔坐标转换为球极坐标。

concatenate \(坐标)

将多个坐标对象合并为一个 SkyCoord .

concatenate_representations \(代表)

通过连接每个组件中的数据,将多个表示对象组合到一个实例中。

custom_stokes_symbol_mapping(mapping[, replace])

添加一组从值到斯托克斯符号的自定义映射。

get_body(body, time[, location, ephemeris])

得到一个 SkyCoord 从地球上某个位置观察到的太阳系天体 GCRS 参考系。

get_body_barycentric(body, time[, ephemeris])

计算太阳系天体的重心位置。

get_body_barycentric_posvel(body, time[, ...])

计算太阳系天体的重心位置和速度。

get_constellation(coord[, short_name, ...])

确定给定坐标对象包含的星座。

get_icrs_coordinates(name[, parse, cache])

使用检索ICRS对象 Sesame 检索指定名称的坐标。

get_moon(time[, location, ephemeris])

自 5.3 版本弃用.

get_sun \(时间)

确定太阳在给定时间(如果输入是数组,则为一个或多个时间)的位置 Time 对象),在地心坐标系中。

golden_spiral_grid \(尺寸)

使用斐波那契或黄金螺旋线方法在单位球体的曲面上生成点的栅格。

make_transform_graph_docs(transform_graph)

生成可在其他docstring中使用的字符串,以包含转换图,显示可用的变换和坐标系。

match_coordinates_3d(matchcoord, catalogcoord)

查找目录坐标集中一个或多个坐标的最接近的三维匹配。

match_coordinates_sky(matchcoord, catalogcoord)

查找目录坐标集中一个或多个坐标的最近天空匹配。

offset_by(lon, lat, posang, distance)

距给定点具有给定偏移的点。

position_angle(lon1, lat1, lon2, lat2)

球体上两点之间的定位角度(北向东)。

search_around_3d(coords1, coords2, distlimit)

搜索至少与三维空间中指定距离相等的点对。

search_around_sky(coords1, coords2, seplimit)

搜索角度间隔至少与指定角度接近的点对。

spherical_to_cartesian(r, lat, lon)

将球形极坐标转换为矩形笛卡尔坐标。

uniform_spherical_random_surface([size])

在单位球体的曲面上生成点的随机采样。

uniform_spherical_random_volume([size, ...])

生成球体内遵循均匀体积密度分布的点的随机采样。

Classes#

AffineTransform(transform_func, fromsys, tosys)

一种指定为一个函数的坐标变换,它产生一个3x3笛卡尔变换矩阵和一个位移向量元组。

AltAz(*args, **kwargs)

高度-方位角系统中相对于WGS84椭球体的坐标或框架(水平坐标)。

Angle(angle[, unit, dtype, copy])

一个或多个角度值,单位等于弧度或度。

Attribute([default, secondary_attribute])

保存帧属性的不可变数据描述符。

BarycentricMeanEcliptic(*args[, copy, ...])

重心平均黄道坐标。

BarycentricTrueEcliptic(*args[, copy, ...])

重心真黄道坐标。

BaseAffineTransform(fromsys, tosys[, ...])

之间的公共功能的基类 AffineTransform -类型子类。

BaseBodycentricRepresentation(lon[, lat, ...])

以身体为中心的3D坐标中的点的表示。

BaseCoordinateFrame(*args[, copy, ...])

坐标系的基类。

BaseDifferential(*args, **kwargs)

表示不同表示的基类。

BaseEclipticFrame(*args[, copy, ...])

一个基类,用于具有类似黄道帧的名称和约定的帧。

BaseGeodeticRepresentation(lon[, lat, ...])

大地测量表示的基类。

BaseRADecFrame(*args[, copy, ...])

一个基类,根据典型的“赤道”约定,将经度和纬度表示为赤经和赤纬的帧的默认表示信息。

BaseRepresentation(*args[, differentials])

在三维坐标系中表示点的基。

BaseRepresentationOrDifferential(*args, **kwargs)

三维坐标表示和微分。

BaseSphericalCosLatDifferential(*args, **kwargs)

球底表示上点的微分。

BaseSphericalDifferential(*args, **kwargs)

BoundsError 

当角度超出用户指定的界限时引发。

CIRS(*args[, copy, representation_type, ...])

天球中间参考系(CIRS)中的坐标或坐标系。

CartesianDifferential(d_x[, d_y, d_z, unit, ...])

三维笛卡尔坐标中点的微分。

CartesianRepresentation(x[, y, z, unit, ...])

三维笛卡尔坐标中点的表示。

CartesianRepresentationAttribute([default, ...])

一种帧属性,它是具有指定单位的CartesianRepresentation。

CompositeTransform(transforms, fromsys, tosys)

一种由一系列单步变换组合而成的变换。

ConvertError 

如果一个坐标系无法转换为另一个坐标系,则引发。

CoordinateAttribute(frame[, default, ...])

作为坐标对象的帧属性。

CoordinateTransform(fromsys, tosys[, ...])

将坐标从一个坐标系转换到另一个坐标系的对象。

CustomBarycentricEcliptic(*args[, copy, ...])

具有自定义倾角的重心黄道坐标。

CylindricalDifferential(d_rho[, d_phi, d_z, ...])

柱坐标中点的微分。

CylindricalRepresentation(rho[, phi, z, ...])

三维柱坐标中点的表示。

DifferentialAttribute([default, ...])

作为差分实例的帧属性。

Distance([value, unit, z, cosmology, ...])

一维距离。

DynamicMatrixTransform(matrix_func, fromsys, ...)

一种坐标变换,被指定为一个能产生3×3笛卡尔变换矩阵的函数。

EarthLocation(*args, **kwargs)

地球上的位置。

EarthLocationAttribute([default, ...])

可以作为 EarthLocation .

FK4(*args[, copy, representation_type, ...])

FK4系统中的坐标或框架。

FK4NoETerms(*args[, copy, ...])

FK4系统中的一个坐标或帧,但去掉了像差的E项。

FK5(*args[, copy, representation_type, ...])

FK5系统中的坐标或框架。

FunctionTransform(func, fromsys, tosys[, ...])

由接受坐标对象并返回转换后的坐标对象的函数定义的坐标变换。

FunctionTransformWithFiniteDifference(func, ...)

基于函数的速度有限差分变换。

GCRS(*args[, copy, representation_type, ...])

地心天体参考系(GCRS)中的坐标或坐标系。

GRS80GeodeticRepresentation(lon[, lat, ...])

GRS80三维大地坐标中点的表示。

Galactic(*args[, copy, representation_type, ...])

银河系中的坐标系或坐标系。

GalacticLSR(*args[, copy, ...])

地方性静止标准(LSR)中的坐标或框架,与银河系框架轴对齐。

Galactocentric(*args, **kwargs)

坐标系银河系中的坐标或坐标系。

GenericFrame(frame_attrs)

不能存储数据但可以保存任意帧属性的帧对象。

GeocentricMeanEcliptic(*args[, copy, ...])

地心平均黄道坐标。

GeocentricTrueEcliptic(*args[, copy, ...])

地心真黄道坐标。

HADec(*args, **kwargs)

时角赤纬系统中相对于WGS84椭球体的坐标或框架(赤道坐标)。

HCRS(*args[, copy, representation_type, ...])

日心坐标系日心坐标系中的坐标或坐标系,轴线与ICRS对准。

HeliocentricEclipticIAU76(*args[, copy, ...])

日心平均值(IAU 1976)黄道坐标。

HeliocentricMeanEcliptic(*args[, copy, ...])

日心平均黄道坐标。

HeliocentricTrueEcliptic(*args[, copy, ...])

日心真黄道坐标。

ICRS(*args[, copy, representation_type, ...])

ICRS系统中的坐标或框架。

ITRS(*args[, copy, representation_type, ...])

国际地球参考系(ITRS)中的坐标或坐标系。

IllegalHourError \(小时)

当小时值不在[0,24]范围内时引发。

IllegalHourWarning(hour[, alternativeactionstr])

当小时值为24时引发。

IllegalMinuteError \(分钟)

当分钟值不在范围内时引发 [0,60] .

IllegalMinuteWarning(minute[, ...])

当分钟值为60时引发。

IllegalSecondError \(第二个)

当第二个值(时间)不在范围内时引发 [0,60] .

IllegalSecondWarning(second[, ...])

当第二个值为60时引发。

LSR(*args[, copy, representation_type, ...])

局部静止标准(LSR)中的坐标或坐标系。

LSRD(*args[, copy, representation_type, ...])

REST的动态局部标准(LSRD)中的坐标或框架。

LSRK(*args[, copy, representation_type, ...])

运动学局部静止标准(LSR)中的坐标或坐标系。

Latitude(angle[, unit])

类似纬度的角度,必须在-90到+90度的范围内。

Longitude(angle[, unit, wrap_angle])

在一个连续的360度范围内环绕的类似经度的角度。

PhysicsSphericalDifferential(d_phi[, ...])

使用物理约定的三维球坐标微分。

PhysicsSphericalRepresentation(phi[, theta, ...])

在三维球坐标系中表示点(使用 phitheta (对于磁极和方位角)。

PrecessedGeocentric(*args[, copy, ...])

一种坐标系,其定义与GCRS相似,但进动到要求的(平均)春分点。

QuantityAttribute([default, ...])

一种帧属性,它是具有指定单位和形状的数量(可选)。

RadialDifferential(*args, **kwargs)

径向距离差分。

RadialRepresentation(distance[, ...])

表示点到原点的距离。

RangeError 

当某个角度的某个部分超出其有效范围时引发。

RepresentationMapping(reprname, framename[, ...])

NamedTupleframe_specific_representation_info 属性告诉帧用于特定表示的属性名称(和默认单位)。

SkyCoord(*args[, copy])

高级对象为天体坐标表示、操作和系统之间的转换提供了一个灵活的接口。

SkyCoordInfo([bound])

用于存储诸如名称、描述、格式等元信息的容器。

SkyOffsetFrame(*args, **kwargs)

一种相对于某一特定位置的框架,其方向与框架相匹配。

SpectralCoord(value[, unit, observer, ...])

与其对应单位的光谱坐标。

SpectralQuantity(value[, unit, ...])

一个或多个光谱单位。

SphericalCosLatDifferential(d_lon_coslat[, ...])

三维球坐标中点的微分。

SphericalDifferential(d_lon[, d_lat, ...])

三维球坐标中点的微分。

SphericalRepresentation(lon[, lat, ...])

三维球坐标中点的表示。

StaticMatrixTransform(matrix, fromsys, tosys)

定义为3×3笛卡尔变换矩阵的坐标变换。

StokesCoord(stokes[, copy])

带有辅助对象的Stokes坐标的表示形式,用于转换为配置文件名称。

StokesSymbol([symbol, description])

斯托克斯坐标的符号。

Supergalactic(*args[, copy, ...])

超星系坐标(见Lahav等人,2000年,<https://ui.adsabs.harvard.edu/abs/2000MNRAS.312..166L>,及其参考文献)。

TEME(*args[, copy, representation_type, ...])

真赤道平均分界线(TEME)中的坐标或坐标系。

TETE(*args[, copy, representation_type, ...])

赤道坐标使用真赤道和真春分点(TETE)的赤道坐标或坐标系。

TimeAttribute([default, secondary_attribute])

作为时间对象的数量的帧属性描述符。

TransformGraph \()

表示坐标系之间路径的图。

UnitSphericalCosLatDifferential(d_lon_coslat)

单位球面上点的微分。

UnitSphericalDifferential(d_lon[, d_lat, copy])

单位球面上点的微分。

UnitSphericalRepresentation(lon[, lat, ...])

单位球面上点的表示。

UnknownSiteException(site, attribute[, ...])

WGS72GeodeticRepresentation(lon[, lat, ...])

WGS72三维大地坐标中点的表示。

WGS84GeodeticRepresentation(lon[, lat, ...])

WGS84三维大地坐标中点的表示。

galactocentric_frame_defaults \()

中的帧属性的默认值的全局设置 Galactocentric 框架。

solar_system_ephemeris \()

用于计算太阳系天体位置的默认星历表。

类继承图#

Inheritance diagram of astropy.coordinates.transformations.AffineTransform, astropy.coordinates.builtin_frames.altaz.AltAz, astropy.coordinates.angles.core.Angle, astropy.coordinates.attributes.Attribute, astropy.coordinates.builtin_frames.ecliptic.BarycentricMeanEcliptic, astropy.coordinates.builtin_frames.ecliptic.BarycentricTrueEcliptic, astropy.coordinates.transformations.BaseAffineTransform, astropy.coordinates.representation.geodetic.BaseBodycentricRepresentation, astropy.coordinates.baseframe.BaseCoordinateFrame, astropy.coordinates.representation.base.BaseDifferential, astropy.coordinates.builtin_frames.ecliptic.BaseEclipticFrame, astropy.coordinates.representation.geodetic.BaseGeodeticRepresentation, astropy.coordinates.builtin_frames.baseradec.BaseRADecFrame, astropy.coordinates.representation.base.BaseRepresentation, astropy.coordinates.representation.base.BaseRepresentationOrDifferential, astropy.coordinates.representation.spherical.BaseSphericalCosLatDifferential, astropy.coordinates.representation.spherical.BaseSphericalDifferential, astropy.coordinates.angles.errors.BoundsError, astropy.coordinates.builtin_frames.cirs.CIRS, astropy.coordinates.representation.cartesian.CartesianDifferential, astropy.coordinates.representation.cartesian.CartesianRepresentation, astropy.coordinates.attributes.CartesianRepresentationAttribute, astropy.coordinates.transformations.CompositeTransform, astropy.coordinates.errors.ConvertError, astropy.coordinates.attributes.CoordinateAttribute, astropy.coordinates.transformations.CoordinateTransform, astropy.coordinates.builtin_frames.ecliptic.CustomBarycentricEcliptic, astropy.coordinates.representation.cylindrical.CylindricalDifferential, astropy.coordinates.representation.cylindrical.CylindricalRepresentation, astropy.coordinates.attributes.DifferentialAttribute, astropy.coordinates.distances.Distance, astropy.coordinates.transformations.DynamicMatrixTransform, astropy.coordinates.earth.EarthLocation, astropy.coordinates.attributes.EarthLocationAttribute, astropy.coordinates.builtin_frames.fk4.FK4, astropy.coordinates.builtin_frames.fk4.FK4NoETerms, astropy.coordinates.builtin_frames.fk5.FK5, astropy.coordinates.transformations.FunctionTransform, astropy.coordinates.transformations.FunctionTransformWithFiniteDifference, astropy.coordinates.builtin_frames.gcrs.GCRS, astropy.coordinates.representation.geodetic.GRS80GeodeticRepresentation, astropy.coordinates.builtin_frames.galactic.Galactic, astropy.coordinates.builtin_frames.lsr.GalacticLSR, astropy.coordinates.builtin_frames.galactocentric.Galactocentric, astropy.coordinates.baseframe.GenericFrame, astropy.coordinates.builtin_frames.ecliptic.GeocentricMeanEcliptic, astropy.coordinates.builtin_frames.ecliptic.GeocentricTrueEcliptic, astropy.coordinates.builtin_frames.hadec.HADec, astropy.coordinates.builtin_frames.hcrs.HCRS, astropy.coordinates.builtin_frames.ecliptic.HeliocentricEclipticIAU76, astropy.coordinates.builtin_frames.ecliptic.HeliocentricMeanEcliptic, astropy.coordinates.builtin_frames.ecliptic.HeliocentricTrueEcliptic, astropy.coordinates.builtin_frames.icrs.ICRS, astropy.coordinates.builtin_frames.itrs.ITRS, astropy.coordinates.angles.errors.IllegalHourError, astropy.coordinates.angles.errors.IllegalHourWarning, astropy.coordinates.angles.errors.IllegalMinuteError, astropy.coordinates.angles.errors.IllegalMinuteWarning, astropy.coordinates.angles.errors.IllegalSecondError, astropy.coordinates.angles.errors.IllegalSecondWarning, astropy.coordinates.builtin_frames.lsr.LSR, astropy.coordinates.builtin_frames.lsr.LSRD, astropy.coordinates.builtin_frames.lsr.LSRK, astropy.coordinates.angles.core.Latitude, astropy.coordinates.angles.core.Longitude, astropy.coordinates.representation.spherical.PhysicsSphericalDifferential, astropy.coordinates.representation.spherical.PhysicsSphericalRepresentation, astropy.coordinates.builtin_frames.gcrs.PrecessedGeocentric, astropy.coordinates.attributes.QuantityAttribute, astropy.coordinates.representation.spherical.RadialDifferential, astropy.coordinates.representation.spherical.RadialRepresentation, astropy.coordinates.angles.errors.RangeError, astropy.coordinates.baseframe.RepresentationMapping, astropy.coordinates.sky_coordinate.SkyCoord, astropy.coordinates.sky_coordinate.SkyCoordInfo, astropy.coordinates.builtin_frames.skyoffset.SkyOffsetFrame, astropy.coordinates.spectral_coordinate.SpectralCoord, astropy.coordinates.spectral_quantity.SpectralQuantity, astropy.coordinates.representation.spherical.SphericalCosLatDifferential, astropy.coordinates.representation.spherical.SphericalDifferential, astropy.coordinates.representation.spherical.SphericalRepresentation, astropy.coordinates.transformations.StaticMatrixTransform, astropy.coordinates.polarization.StokesCoord, astropy.coordinates.polarization.StokesSymbol, astropy.coordinates.builtin_frames.supergalactic.Supergalactic, astropy.coordinates.builtin_frames.equatorial.TEME, astropy.coordinates.builtin_frames.equatorial.TETE, astropy.coordinates.attributes.TimeAttribute, astropy.coordinates.transformations.TransformGraph, astropy.coordinates.representation.spherical.UnitSphericalCosLatDifferential, astropy.coordinates.representation.spherical.UnitSphericalDifferential, astropy.coordinates.representation.spherical.UnitSphericalRepresentation, astropy.coordinates.errors.UnknownSiteException, astropy.coordinates.representation.geodetic.WGS72GeodeticRepresentation, astropy.coordinates.representation.geodetic.WGS84GeodeticRepresentation, astropy.coordinates.builtin_frames.galactocentric.galactocentric_frame_defaults, astropy.coordinates.solar_system.solar_system_ephemeris