from __future__ import absolute_import as _absolute_import from __future__ import division as _division from __future__ import print_function as _print_function import numpy as _np from astropy.constants import Constant as _Constant from astropy.constants import G as _G gm_mercury = _Constant( abbrev='gm_mercury', name='Gravitational constant times the mass of Mercury', value=2.2031815411154894e+13, unit='m3 / s2', uncertainty=1.9361909444154922e+5, reference='ggmes_100v07: Mazarico, E., A. Genova, S. Goossens, F. G. ' 'Lemoine, G. A. Neumann, M. T. Zuber, D. E. Smith, and S. C. Solomon ' '(2014), The gravity field, orientation, and ephemeris of Mercury ' 'from MESSENGER observations after three years in orbit, J. Geophys. ' 'Res. Planets, 119, 2417-2436, doi:10.1002/2014JE004675.') mass_mercury = _Constant( abbrev='mass_mercury', name='Mass of Mercury', value=gm_mercury.value / _G.value, unit='kg', uncertainty=_np.sqrt((gm_mercury.uncertainty / _G.value)**2 + (gm_mercury.value * _G.uncertainty / _G.value**2)**2 ), reference='Derived from gm_mercury and G.')
""" pyshtools constants for the planet Mars. Each object is an astropy Constant that possesses the attributes name, value, unit, uncertainty, and reference. """ import numpy as _np from astropy.constants import Constant as _Constant from astropy.constants import G as _G gm = _Constant( abbrev='gm_mars', name='Gravitational constant times the mass of Mars', value=0.4282837581575610e+14, unit='m3 / s2', uncertainty=0.18167460e+6, reference='Konopliv A. S., R. S. Park, W. M. Folkner (2016). ' 'An improved JPL Mars gravity field and orientation from Mars orbiter ' 'and lander tracking data, Icarus, 274, 253-260, ' 'doi:10.1016/j.icarus.2016.02.052') mass = _Constant( abbrev='mass_mars', name='Mass of Mars', value=gm.value / _G.value, unit='kg', uncertainty=_np.sqrt((gm.uncertainty / _G.value)**2 + (gm.value * _G.uncertainty / _G.value**2)**2), reference='Derived from gm_mars and G.') r = _Constant(
""" pyshtools constants for the planet Venus. Each object is an astropy Constant that possesses the attributes name, value, unit, uncertainty, and reference. """ import numpy as _np from astropy.constants import Constant as _Constant from astropy.constants import G as _G gm = _Constant( abbrev='gm_venus', name='Gravitational constant times the mass of Venus', value=324858592079000., unit='m3 / s2', uncertainty=6376000.0, reference='MGNP180U: Konopliv A. S., W. B. Banerdt, and W. L. Sjogren ' '(1999) Venus gravity: 180th degree and order model. Icarus 139: 3-18.' 'doi:10.1006/icar.1999.6086.') mass = _Constant( abbrev='mass_venus', name='Mass of Venus', value=gm.value / _G.value, unit='kg', uncertainty=_np.sqrt((gm.uncertainty / _G.value)**2 + (gm.value * _G.uncertainty / _G.value**2)**2 ), reference='Derived from gm_venus and G.')
pyshtools constants for the planet Mercury. Each object is an astropy Constant that possesses the attributes name, value, unit, uncertainty, and reference. """ import numpy as _np from astropy.constants import Constant as _Constant from astropy.constants import G as _G gm_mercury = _Constant( abbrev='gm_mercury', name='Gravitational constant times the mass of Mercury', value=2.2031815411154894e+13, unit='m3 / s2', uncertainty=1.9361909444154922e+5, reference='ggmes_100v07: Mazarico, E., A. Genova, S. Goossens, F. G. ' 'Lemoine, G. A. Neumann, M. T. Zuber, D. E. Smith, and S. C. Solomon ' '(2014), The gravity field, orientation, and ephemeris of Mercury ' 'from MESSENGER observations after three years in orbit, J. Geophys. ' 'Res. Planets, 119, 2417-2436, doi:10.1002/2014JE004675.') mass_mercury = _Constant( abbrev='mass_mercury', name='Mass of Mercury', value=gm_mercury.value / _G.value, unit='kg', uncertainty=_np.sqrt((gm_mercury.uncertainty / _G.value)**2 + (gm_mercury.value * _G.uncertainty / _G.value**2)**2), reference='Derived from gm_mercury and G.')
from __future__ import absolute_import as _absolute_import from __future__ import division as _division from __future__ import print_function as _print_function import numpy as _np from astropy.constants import Constant as _Constant from astropy.constants import G as _G gm_moon = _Constant( abbrev='gm_moon', name='Gravitational constant times the mass of the Moon', value=4902.80007e9, unit='m3 / s2', uncertainty=0.00014e9, reference='Williams, J. G., A. S. Konopliv, D. H. Boggs, ' 'R. S. Park, D.-N. Yuan, F. G. Lemoine, S. Goossens, E. Mazarico, ' 'F. Nimmo, R. C. Weber, S. W. Asmar, H. J. Melosh, G. A. Neumann, ' 'R. J. Phillips, D. E. Smith, S. C. Solomon, M. M. Watkins, M. A. ' 'Wieczorek, J. C. Andrews-Hanna, J. W. Head, W. S. Kiefer, I. ' 'Matsuyama, P. J. McGovern, G. J. Taylor, and M. T. Zuber (2014). ' 'Lunar interior properties from the GRAIL mission, J. Geophys. Res. ' 'Planets, 119, 1546-1578, doi:10.1002/2013JE004559.') mass_moon = _Constant( abbrev='mass_moon', name='Mass of the Moon', value=gm_moon.value / _G.value, unit='kg', uncertainty=_np.sqrt((gm_moon.uncertainty / _G.value)**2 + (gm_moon.value * _G.uncertainty / _G.value**2)**2 ),
pyshtools constants for the planet Earth. Each object is an astropy Constant that possesses the attributes name, value, unit, uncertainty, and reference. """ import numpy as _np from astropy.constants import Constant as _Constant from astropy.constants import G as _G gm_egm2008 = _Constant( abbrev='gm_egm2008', name='Gravitational constant times the mass of Earth for the model ' 'EGM2008, including the atmosphere', value=3986004.415e+8, unit='m3 / s2', uncertainty=0.0, reference='Pavlis N. K., S. A. Holmes, S. C. Kenyon, and J. K. Factor ' '(2012). The development and evaluation of the Earth Gravitational ' 'Model 2008 (EGM2008). J. Geophys. Res., 117, B04406, ' 'doi:10.1029/2011JB008916.') mass_egm2008 = _Constant( abbrev='mass_egm2008', name='Mass of Earth for the model EGM2008, including the atmosphere', value=gm_egm2008.value / _G.value, unit='kg', uncertainty=_np.sqrt((gm_egm2008.uncertainty / _G.value)**2 + (gm_egm2008.value * _G.uncertainty / _G.value**2)**2), reference='Derived from gm_egm2008 and G.')
import astropy.units as _u from astropy.constants import Constant as _Constant #################################################### # IERS2010 Conventions #################################################### #################################################### # Natural measurable constants #################################################### G = _Constant(abbrev='G', name='Constant of gravitation', value=6.67428e-11, unit='m**3 / (kg * s**2)', uncertainty=6.7e-15, reference='IERS Conventions(2010), ' 'IERS Technical Note 36, ' 'Verlagdes Bundesamts für Kartographie und Geodäsie, ' 'Frankfurt am Main, Germany.') #################################################### # Auxiliary defining constants #################################################### L_G = _Constant(abbrev='L_G', name='1 - d(TT)/d(TCG)', value=6.969290134e-10, unit='', uncertainty=0, reference='IERS Conventions(2010), '
from __future__ import absolute_import as _absolute_import from __future__ import division as _division from __future__ import print_function as _print_function import numpy as _np from astropy.constants import Constant as _Constant from astropy.constants import G as _G gm_moon = _Constant( abbrev='gm_moon', name='Gravitational constant times the mass of the Moon', value=4902.80007e9, unit='m3 / s2', uncertainty=0.00014e9, reference='Williams, J. G., A. S. Konopliv, D. H. Boggs, ' 'R. S. Park, D.-N. Yuan, F. G. Lemoine, S. Goossens, E. Mazarico, ' 'F. Nimmo, R. C. Weber, S. W. Asmar, H. J. Melosh, G. A. Neumann, ' 'R. J. Phillips, D. E. Smith, S. C. Solomon, M. M. Watkins, M. A. ' 'Wieczorek, J. C. Andrews-Hanna, J. W. Head, W. S. Kiefer, I. ' 'Matsuyama, P. J. McGovern, G. J. Taylor, and M. T. Zuber (2014). ' 'Lunar interior properties from the GRAIL mission, J. Geophys. Res. ' 'Planets, 119, 1546-1578, doi:10.1002/2013JE004559.') mass_moon = _Constant( abbrev='mass_moon', name='Mass of the Moon', value=gm_moon.value / _G.value, unit='kg', uncertainty=_np.sqrt((gm_moon.uncertainty / _G.value)**2 + (gm_moon.value * _G.uncertainty / _G.value**2)**2), reference='Derived from gm_moon and G.')
""" from __future__ import absolute_import as _absolute_import from __future__ import division as _division from __future__ import print_function as _print_function import numpy as _np from astropy.constants import Constant as _Constant from astropy.constants import G as _G gm_venus = _Constant( abbrev='gm_venus', name='Gravitational constant times the mass of Venus', value=324858592079000., unit='m3 / s2', uncertainty=6376000.0, reference='MGNP180U: Konopliv A. S., W. B. Banerdt, and W. L. Sjogren ' '(1999) Venus gravity: 180th degree and order model. Icarus 139: 3-18.' 'doi:10.1006/icar.1999.6086.') mass_venus = _Constant( abbrev='mass_venus', name='Mass of Venus', value=gm_venus.value / _G.value, unit='kg', uncertainty=_np.sqrt((gm_venus.uncertainty / _G.value)**2 + (gm_venus.value * _G.uncertainty / _G.value**2)**2 ), reference='Derived from gm_venus and G.')
from astropy.constants import G from astropy.constants import g0 from astropy.constants import R_earth from .iers2010 import GM_earth_tt as gm_earth from .iers2010 import DEGREE2_LOVE_NUMBERS #################################################### # Define constants #################################################### W0_IHRF = _Constant( abbrev='W0', name= 'Potential of the geoid for the International Height Reference Frame(IHRF)', value=62636853.4, unit='m**2 / s**2', uncertainty=0.02, reference='IAG 2015 Resolution No.1') #################################################### # Frequently used expressions #################################################### # n*pi _2pi = 2 * pi _4pi = 4 * pi # 2*pi*G _2piG = _2pi * G
""" from __future__ import absolute_import as _absolute_import from __future__ import division as _division from __future__ import print_function as _print_function import numpy as _np from astropy.constants import Constant as _Constant from astropy.constants import G as _G gm_mars = _Constant( abbrev='gm_mars', name='Gravitational constant times the mass of Mars', value=0.4282837581575610e+14, unit='m3 / s2', uncertainty=0.18167460e+6, reference='Konopliv A. S., R. S. Park, W. M. Folkner (2016). ' 'An improved JPL Mars gravity field and orientation from Mars orbiter ' 'and lander tracking data, Icarus, 274, 253-260, ' 'doi:10.1016/j.icarus.2016.02.052') mass_mars = _Constant( abbrev='mass_mars', name='Mass of Mars', value=gm_mars.value / _G.value, unit='kg', uncertainty=_np.sqrt((gm_mars.uncertainty / _G.value)**2 + (gm_mars.value * _G.uncertainty / _G.value**2)**2 ), reference='Derived from gm_mars and G.')
from __future__ import absolute_import as _absolute_import from __future__ import division as _division from __future__ import print_function as _print_function import numpy as _np from astropy.constants import Constant as _Constant from astropy.constants import G as _G gm_egm2008 = _Constant( abbrev='gm_egm2008', name='Gravitational constant times the mass of Earth for the model ' 'EGM2008, including the atmosphere', value=3986004.415e+8, unit='m3 / s2', uncertainty=0.0, reference='Pavlis N. K., S. A. Holmes, S. C. Kenyon, and J. K. Factor ' '(2012). The development and evaluation of the Earth Gravitational ' 'Model 2008 (EGM2008). J. Geophys. Res., 117, B04406, ' 'doi:10.1029/2011JB008916.') mass_egm2008 = _Constant( abbrev='mass_egm2008', name='Mass of Earth for the model EGM2008, including the atmosphere', value=gm_egm2008.value / _G.value, unit='kg', uncertainty=_np.sqrt((gm_egm2008.uncertainty / _G.value)**2 + (gm_egm2008.value * _G.uncertainty / _G.value**2)**2 ), reference='Derived from gm_egm2008 and G.')
] # Import Moon and Sun from pyshtools.constants.Moon import gm as gm_moon from .iers2010 import GM_sun as gm_sun # Import planets from pyshtools.constants.Mars import gm as gm_mars from pyshtools.constants.Venus import gm as gm_venus from pyshtools.constants.Mercury import gm as gm_mercury # Define planets gm_jupiter = _Constant( abbrev='gm_jupiter', name='Gravitational constant times the mass of Jupiter', value=126686536.1e9, unit='m3 / s2', uncertainty=2.7e9, reference='Jacobson, R.A., (2013), JUP310 orbit solution.') gm_saturn = _Constant( abbrev='gm_saturn', name='Gravitational constant times the mass of Saturn', value=37931208e9, unit='m3 / s2', uncertainty=1e9, reference='Jacobson, R. A., Antreasian, P. G., Bordi, J. J., ' 'Criddle, K. E., Ionasescu,R., Jones, J. B., Mackenzie, R. A., ' 'Pelletier, F. J., Owen Jr., W. M., Roth, D. C., and Stauch, J. R., ' '(2006), The gravity field of the Saturnian system from satellite ' 'observations and spacecraft tracking data, '