Lines Matching refs:deg

40     UnitSphericalRepresentation(lon=8*u.hour, lat=5*u.deg)
41 UnitSphericalRepresentation(lon=8*u.hourangle, lat=5*u.deg)
42 SphericalRepresentation(lon=8*u.hourangle, lat=5*u.deg, distance=10*u.kpc)
48 UnitSphericalRepresentation(Longitude(8, u.hour), Latitude(5, u.deg))
49 SphericalRepresentation(Longitude(8, u.hour), Latitude(5, u.deg), Distance(10, u.kpc))
52 UnitSphericalRepresentation(lon=[8, 9]*u.hourangle, lat=[5, 6]*u.deg)
55 UnitSphericalRepresentation(lon=[8, 9]*u.hourangle, lat=[5, 6]*u.deg, copy=False)
63 c1 = SphericalRepresentation(lon=8*u.hourangle, lat=5*u.deg, distance=10*u.kpc)
69 SphericalRepresentation(lon=[8, 9]*u.hourangle, lat=[5, 6]*u.deg, distance=[10, 11]*u.kpc)
72 c2 = SphericalRepresentation(lon=[8, 9]*u.hourangle, lat=[5, 6]*u.deg, distance=10*u.kpc)
76 c2 = UnitSphericalRepresentation(lon=[8, 9, 10]*u.hourangle, lat=[5, 6]*u.deg)
81 c2 = UnitSphericalRepresentation(lon=Angle([8*u.hourangle, 135*u.deg]),
82 lat=Angle([5*u.deg, (6*np.pi/180)*u.rad]))
83 assert c2.lat.unit == u.deg and c2.lon.unit == u.hourangle
88 lon = u.Quantity([120*u.deg, 135*u.deg], u.hourangle)
89 lat = u.Quantity([(5*np.pi/180)*u.rad, 0.4*u.hourangle], u.deg)
99 c1.lat = Latitude(5, u.deg)
102 c2.lat[:] = [0] * u.deg # possible, but NOT SUPPORTED
108 _ = PhysicsSphericalRepresentation(phi=120*u.deg, theta=85*u.deg, r=3*u.kpc)
130 srep = SphericalRepresentation(lon=90*u.deg, lat=0*u.deg, distance=1*u.pc)
151 icrs = ICRS(UnitSphericalRepresentation(lon=8*u.hour, lat=5*u.deg))
154 assert icrs.data.lat == 5*u.deg
160 fk5 = FK5(UnitSphericalRepresentation(lon=8*u.hour, lat=5*u.deg))
162 fk5_2000 = FK5(UnitSphericalRepresentation(lon=8*u.hour, lat=5*u.deg), equinox=J2000)
172 fk5.data = UnitSphericalRepresentation(lon=8*u.hour, lat=5*u.deg)
184 assert_allclose(icrs.represent_as(SphericalRepresentation).lat, 5*u.deg)
186 assert_allclose(icrs.spherical.lat, 5*u.deg)
194 assert_allclose(icrs.dec, 5*u.deg)
201 icrs_2 = ICRS(ra=8*u.hour, dec=5*u.deg, distance=1*u.kpc)
210 coo1 = ICRS(ra=0*u.hour, dec=0*u.deg)
211 coo2 = ICRS(ra=0*u.hour, dec=1*u.deg)
216 coo3 = ICRS(ra=0*u.hour, dec=0*u.deg, distance=1*u.kpc)
217 coo4 = ICRS(ra=0*u.hour, dec=0*u.deg, distance=2*u.kpc)
238 fk5 = FK5(ra=8*u.hour, dec=5*u.deg)
251 srep = UnitSphericalRepresentation(lon=8*u.hour, lat=5*u.deg)
266 fk5_2 = FK5(ra=8*u.hour, dec=5*u.deg, equinox=J2001)
272 assert not allclose(fk5_2.ra, fk5_trans.ra, rtol=0, atol=1e-10*u.deg)
276 assert_allclose(fk5_2.ra, fk5_trans_2.ra, rtol=0, atol=1e-10*u.deg)
322 lat=5 * u.deg, distance=1 * u.kpc), frame='icrs')
329 sc = coords.SkyCoord(ra=8 * u.hour, dec=5 * u.deg, frame='icrs')
330 sc = coords.SkyCoord(l=120 * u.deg, b=5 * u.deg, frame='galactic')
333 sc = coords.SkyCoord(coords.ICRS(ra=8 * u.hour, dec=5 * u.deg))
361 sc = coords.SkyCoord('8:00:00 +5:00:00.0', unit=(u.hour, u.deg), frame='icrs')
381 sc1 = coords.SkyCoord(ra=8 * u.hour, dec=5 * u.deg, equinox=J2001, frame='fk5')
395 sc = coords.SkyCoord(ra=8 * u.hour, dec=5 * u.deg, frame='icrs')
407 cat1 = coords.SkyCoord(ra=[1, 2]*u.hr, dec=[3, 4.01]*u.deg,
409 cat2 = coords.SkyCoord(ra=[1, 2, 2.01]*u.hr, dec=[3, 4, 5]*u.deg,
437 assert np.abs(m31icrs.ra - m31fk4.ra) > .5*u.deg