Welcome to Orbit Determinator’s documentation!¶
About Orbit Determinator¶
The orbitdeterminator package provides tools to compute the orbit of a satellite from positional measurements. It supports both cartesian and spherical coordinates for the initial positional data, two filters for smoothing and removing errors from the initial data set and finally two methods for preliminary orbit determination. The package is labeled as an open source scientific package and can be helpful for projects concerning space orbit tracking.
Lots of university students build their own cubesat’s and set them into space orbit, lots of researchers start building their own ground station to track active satellite missions. For those particular space enthusiasts we suggest using and trying our package. Any feedback is more than welcome and we wish our work to inspire other’s to join us and add more helpful features.
Our future goals for the package is to add a 3d visual graph of the final computed satellite orbit, add more filters, methods and with the help of a tracking ground station to build a server system that computes orbital elements for many active satellite missions.
Copyright and License¶
The project’s idea belongs to AerospaceResearch.net and Andreas Hornig and it has been developed under Google summer of code 2017 by Nilesh Chaturvedi and Alexandros Kazantzidis.
It is distributed under an open-source MIT license. Please find LICENSE in top level directory for details.
Installation¶
Open up your control panel, pip install git if you do not already have it and then clone the github repository of the program https://github.com/aerospaceresearch/orbitdeterminator. Create a new virtual environment for python version 3.4. Then, all you need to do is go to the directory where the package has been cloned with cd orbitdeterminator and run python setup.py install. That should install the package into your Lib/site-packages and you will be able to import and use it. Other than import you can just use it immediately from the clone directory (preferred).
Modules documentation¶
Filters:¶
Triple Moving Average¶
Here we take the average of 3 terms x0, A, B where, x0 = The point to be estimated A = weighted average of n terms previous to x0 B = weighted avreage of n terms ahead of x0 n = window size
-
orbitdeterminator.filters.triple_moving_average.
generate_filtered_data
(in_data, window)[source]¶ Apply the filter and generate the filtered data
Parameters: - in_data (string) – numpy array containing the positional data
- window (int) – window size applied into the filter
Returns: the final filtered array
Return type: numpy array
-
orbitdeterminator.filters.triple_moving_average.
triple_moving_average
(signal_array, window_size)[source]¶ Apply triple moving average to a signal
Parameters: - signal_array (numpy array) – the array of values on which the filter is to be applied
- window_size (int) – the no. of points before and after x0 which should be considered for calculating A and B
Returns: a filtered array of size same as that of signal_array
Return type: numpy array
Savintzky - Golay¶
Takes a positional data set (time, x, y, z) and applies the Savintzky Golay filter on it based on the polynomial and window parameters we input
Interpolation:¶
Lamberts-Kalman Method¶
Takes a positional data set and produces sets of six keplerian elements using Lambert’s solution for preliminary orbit determination and Kalman filters
-
orbitdeterminator.kep_determination.lamberts_kalman.
check_keplerian
(kep)[source]¶ Checks all the sets of keplerian elements to see if they have wrong values like eccentricity greater that 1 or a negative number for semi major axis
Parameters: kep (numpy array) – all the sets of keplerian elements in [semi major axis (a), eccentricity (e), inclination (i), argument of perigee (ω), right ascension of the ascending node (Ω), true anomaly (v)] format Returns: the final corrected set of keplerian elements that will be inputed in the kalman filter Return type: numpy array
-
orbitdeterminator.kep_determination.lamberts_kalman.
create_kep
(my_data)[source]¶ Computes all the keplerian elements for every point of the orbit you provide using Lambert’s solution It implements a tool for deleting all the points that give extremely jittery state vectors
Parameters: data (numpy array) – contains the positional data set in (Time, x, y, z) Format Returns: array containing all the keplerian elements computed for the orbit given in [semi major axis (a), eccentricity (e), inclination (i), argument of perigee (ω), right ascension of the ascending node (Ω), true anomaly (v)] format Return type: numpy array
-
orbitdeterminator.kep_determination.lamberts_kalman.
kalman
(kep, R)[source]¶ Takes as an input lots of sets of keplerian elements and produces the fitted value of them by applying kalman filters
Parameters: - kep (numpy array) – containing keplerian elements in this format (a, e, i, ω, Ω, v)
- R – estimate of measurement variance
Returns: final set of keplerian elements describing the orbit based on kalman filtering
Return type: numpy array
-
orbitdeterminator.kep_determination.lamberts_kalman.
orbit_trajectory
(x1_new, x2_new, time)[source]¶ Tool for checking if the motion of the sallite is retrogade or counter - clock wise
Parameters: - x1 (numpy array) – time and position for point 1 [time1,x1,y1,z1]
- x2 (numpy array) – time and position for point 2 [time2,x2,y2,z2]
- time (float) – time difference between the 2 points
Returns: true if we want to keep retrograde, False if we want counter-clock wise
Return type:
Gibb’s Method¶
Spline Interpolation¶
Interpolation using splines for calculating velocity at a point and hence the orbital elements
-
orbitdeterminator.kep_determination.interpolation.
compute_velocity
(spline, point)[source]¶ Calculate the derivative of spline at the point(on the points the given spline corresponds to). This gives the velocity at that point.
Parameters: - spline (list) – component wise cubic splines of orbit data points of the format [spline_x, spline_y, spline_z].
- point (numpy array) – point at which velocity is to be calculated.
Returns: velocity vector at the given point
Return type: numpy array
-
orbitdeterminator.kep_determination.interpolation.
cubic_spline
(orbit_data)[source]¶ Compute component wise cubic spline of points of input data
Parameters: - orbit_data (numpy array) – array of orbit data points of the
- [time, x, y, z] (format) –
Returns: component wise cubic splines of orbit data points of the format [spline_x, spline_y, spline_z]
Return type:
-
orbitdeterminator.kep_determination.interpolation.
main
(data_points)[source]¶ Apply the whole process of interpolation for keplerian element computation
Parameters: data_points (numpy array) – positional data set in format of (time, x, y, z) Returns: computed keplerian elements for every point of the orbit Return type: numpy array
Ellipse Fit¶
Finds out the ellipse that best fits to a set of data points and calculates its keplerian elements.
-
orbitdeterminator.kep_determination.ellipse_fit.
determine_kep
(data)[source]¶ Determines keplerian elements that fit a set of points.
Parameters: data (nx3 numpy array) – A numpy array of points in the format [x y z]. Returns: (kep,res) - The keplerian elements and the residuals as a tuple. kep: 1x6 numpy array res: nx3 numpy array For the keplerian elements: kep[0] - semi-major axis (in whatever units the data was provided in) kep[1] - eccentricity kep[2] - inclination (in degrees) kep[3] - argument of periapsis (in degrees) kep[4] - right ascension of ascending node (in degrees) kep[5] - true anomaly of the first row in the data (in degrees)
For the residuals: (in whatever units the data was provided in) res[0] - residuals in x axis res[1] - residuals in y axis res[2] - residuals in z axis
Gauss method¶
Implements Gauss’ method for three topocentric right ascension and declination measurements of celestial bodies. Supports both Earth-centered and Sun-centered orbits.
-
orbitdeterminator.kep_determination.gauss_method.
alpha
(x, y, z, u, v, w, mu)[source]¶ Compute the inverse of the semimajor axis.
Parameters: Returns: alpha = 1/a
Return type:
-
orbitdeterminator.kep_determination.gauss_method.
angle_diff_rad
(a1, a2)[source]¶ Computes signed difference between two angles. Input angles are assumed to be in radians. Result is returned in radians. Code adapted from https://rosettacode.org/wiki/Angle_difference_between_two_bearings#Python.
- Args:
- a1 (float): angle 1 in radians a2 (float): angle 2 in radians
- Returns:
- r (float): shortest signed difference in radians
-
orbitdeterminator.kep_determination.gauss_method.
argperi
(x, y, z, u, v, w, mu)[source]¶ Compute the argument of pericenter.
Parameters: Returns: argument of pericenter
Return type:
-
orbitdeterminator.kep_determination.gauss_method.
earth_ephemeris
(t_tdb)[source]¶ Compute heliocentric position of Earth at Julian date t_tdb (TDB, days), according to SPK kernel defined by astropy.coordinates.solar_system_ephemeris.
- Args:
- t_tdb (float): TDB instant of requested position
- Returns:
- (1x3 array): cartesian position in km
-
orbitdeterminator.kep_determination.gauss_method.
eccentricity
(x, y, z, u, v, w, mu)[source]¶ Compute value of eccentricity, e.
Parameters: Returns: eccentricity, e
Return type:
-
orbitdeterminator.kep_determination.gauss_method.
gauss_estimate_mpc
(mpc_object_data, mpc_observatories_data, inds, r2_root_ind=0)[source]¶ Gauss method implementation for MPC Near-Earth asteroids ra/dec tracking data.
Parameters: - mpc_object_data (string) – path to MPC-formatted observation data file
- mpc_observatories_data (string) – path to MPC observation sites data file
- inds (1x3 int array) – indices of requested data
- r2_root_ind (int) – index of selected Gauss polynomial root
Returns: updated position at first observation r2 (1x3 array): updated position at second observation r3 (1x3 array): updated position at third observation v2 (1x3 array): updated velocity at second observation D (3x3 array): auxiliary matrix R (1x3 array): three observer position vectors rho1 (1x3 array): LOS vector at first observation rho2 (1x3 array): LOS vector at second observation rho3 (1x3 array): LOS vector at third observation tau1 (float): time interval from second to first observation tau3 (float): time interval from second to third observation f1 (float): Lagrange’s f function value at first observation g1 (float): Lagrange’s g function value at first observation f3 (float): Lagrange’s f function value at third observation g3 (float): Lagrange’s g function value at third observation Ea_hc_pos (1x3 array): cartesian position vectors (Earth wrt Sun) rho_1_sr (float): slant range at first observation rho_2_sr (float): slant range at second observation rho_3_sr (float): slant range at third observation obs_t (1x3 array): three times of observations
Return type: r1 (1x3 array)
-
orbitdeterminator.kep_determination.gauss_method.
gauss_estimate_sat
(iod_object_data, sat_observatories_data, inds, r2_root_ind=0)[source]¶ Gauss method implementation for Earth-orbiting satellites ra/dec tracking data. Assumes observation data uses IOD format, with angle subformat 2.
- Args:
- iod_object_data (string): file path to sat tracking observation data of object sat_observatories_data (string): path to file containing COSPAR satellite tracking stations data. inds (1x3 int array): line numbers in data file to be processed r2_root_ind (int): index of selected Gauss polynomial root
- Returns:
- r1 (1x3 array): updated position at first observation r2 (1x3 array): updated position at second observation r3 (1x3 array): updated position at third observation v2 (1x3 array): updated velocity at second observation D (3x3 array): auxiliary matrix R (1x3 array): three observer position vectors rho1 (1x3 array): LOS vector at first observation rho2 (1x3 array): LOS vector at second observation rho3 (1x3 array): LOS vector at third observation tau1 (float): time interval from second to first observation tau3 (float): time interval from second to third observation f1 (float): Lagrange’s f function value at first observation g1 (float): Lagrange’s g function value at first observation f3 (float): Lagrange’s f function value at third observation g3 (float): Lagrange’s g function value at third observation rho_1_sr (float): slant range at first observation rho_2_sr (float): slant range at second observation rho_3_sr (float): slant range at third observation obs_t_jd (1x3 array): three Julian dates of observations
-
orbitdeterminator.kep_determination.gauss_method.
gauss_iterator_mpc
(mpc_object_data, mpc_observatories_data, inds, refiters=0, r2_root_ind=0)[source]¶ Gauss method iterator for minor planets ra/dec tracking data. Computes a first estimate of the orbit using gauss_estimate_sat function, and then refines this estimate using gauss_refinement. Assumes observation data file follows MPC format.
- Args:
- mpc_object_data (string): path to MPC-formatted observation data file mpc_observatories_data (string): path to MPC observation sites data file inds (1x3 int array): line numbers in data file to be processed refiters (int): number of refinement iterations to be performed r2_root_ind (int): index of selected Gauss polynomial root
- Returns:
- r1 (1x3 array): updated position at first observation r2 (1x3 array): updated position at second observation r3 (1x3 array): updated position at third observation v2 (1x3 array): updated velocity at second observation R (1x3 array): three observer position vectors rho1 (1x3 array): LOS vector at first observation rho2 (1x3 array): LOS vector at second observation rho3 (1x3 array): LOS vector at third observation rho_1_sr (float): slant range at first observation rho_2_sr (float): slant range at second observation rho_3_sr (float): slant range at third observation Ea_hc_pos (1x3 array): cartesian position vectors (Earth wrt Sun) obs_t (1x3 array): times of observations
-
orbitdeterminator.kep_determination.gauss_method.
gauss_iterator_sat
(iod_object_data, sat_observatories_data, inds, refiters=0, r2_root_ind=0)[source]¶ Gauss method iterator for Earth-orbiting satellites ra/dec tracking data. Computes a first estimate of the orbit using gauss_estimate_sat function, and then refines this estimate using gauss_refinement. Assumes observation data file is IOD-formatted, with angle subformat 2.
- Args:
- iod_object_data (string): file path to sat tracking observation data of object sat_observatories_data (string): path to file containing COSPAR satellite tracking stations data. inds (1x3 int array): line numbers in data file to be processed refiters (int): number of refinement iterations to be performed r2_root_ind (int): index of selected Gauss polynomial root
- Returns:
- r1 (1x3 array): updated position at first observation r2 (1x3 array): updated position at second observation r3 (1x3 array): updated position at third observation v2 (1x3 array): updated velocity at second observation R (1x3 array): three observer position vectors rho1 (1x3 array): LOS vector at first observation rho2 (1x3 array): LOS vector at second observation rho3 (1x3 array): LOS vector at third observation rho_1_sr (float): slant range at first observation rho_2_sr (float): slant range at second observation rho_3_sr (float): slant range at third observation obs_t (1x3 array): times of observations
-
orbitdeterminator.kep_determination.gauss_method.
gauss_method_core
(obs_radec, obs_t, R, mu, r2_root_ind=0)[source]¶ Perform core Gauss method.
Parameters: Returns: estimated position at first observation r2 (1x3 array): estimated position at second observation r3 (1x3 array): estimated position at third observation v2 (1x3 array): estimated velocity at second observation D (3x3 array): auxiliary matrix rho1 (1x3 array): LOS vector at first observation rho2 (1x3 array): LOS vector at second observation rho3 (1x3 array): LOS vector at third observation tau1 (float): time interval from second to first observation tau3 (float): time interval from second to third observation f1 (float): estimated Lagrange’s f function value at first observation g1 (float): estimated Lagrange’s g function value at first observation f3 (float): estimated Lagrange’s f function value at third observation g3 (float): estimated Lagrange’s g function value at third observation rho_1_sr (float): estimated slant range at first observation rho_2_sr (float): estimated slant range at second observation rho_3_sr (float): estimated slant range at third observation
Return type: r1 (1x3 array)
-
orbitdeterminator.kep_determination.gauss_method.
gauss_method_mpc
(filename, bodyname, obs_arr=None, r2_root_ind_vec=None, refiters=0, plot=True)[source]¶ Gauss method high-level function for minor planets (asteroids, comets, etc.) orbit determination from MPC-formatted ra/dec tracking data. Roots of 8-th order Gauss polynomial are computed using np.roots function. Note that if r2_root_ind_vec is not specified by the user, then the first positive root returned by np.roots is used by default.
- Args:
- filename (string): path to MPC-formatted observation data file bodyname (string): user-defined name of minor planet obs_arr (int vector): line numbers in data file to be processed refiters (int): number of refinement iterations to be performed r2_root_ind_vec (1xlen(obs_arr) int array): indices of Gauss polynomial roots. plot (bool): if True, plots data.
- Returns:
- x (tuple): set of Keplerian orbital elements {(a, e, taup, omega, I, omega, T),t_vec[-1]}
-
orbitdeterminator.kep_determination.gauss_method.
gauss_method_sat
(filename, obs_arr=None, bodyname=None, r2_root_ind_vec=None, refiters=0, plot=True)[source]¶ Gauss method high-level function for orbit determination of Earth satellites from IOD-formatted ra/dec tracking data. IOD angle subformat 2 is assumed. Roots of 8-th order Gauss polynomial are computed using np.roots function. Note that if r2_root_ind_vec is not specified by the user, then the first positive root returned by np.roots is used by default.
- Args:
- filename (string): path to IOD-formatted observation data file obs_arr (int vector): line numbers in data file to be processed bodyname (string): user-defined name of satellite refiters (int): number of refinement iterations to be performed r2_root_ind_vec (1xlen(obs_arr) int array): indices of Gauss polynomial roots. plot (bool): if True, plots data.
- Returns:
- x (tuple): set of Keplerian orbital elements (a, e, taup, omega, I, omega, T)
-
orbitdeterminator.kep_determination.gauss_method.
gauss_method_sat_passes
(filename, obs_arr=None, bodyname=None, r2_root_ind_vec=None, refiters=10, plot=False)[source]¶ Gauss method high-level function for orbit determination of Earth satellites from IOD-formatted ra/dec tracking data. Roots of 8-th order Gauss polynomial are computed using np.roots function. Note that if r2_root_ind_vec is not specified by the user, then the first positive root returned by np.roots is used by default.
- Args:
- filename (string): path to IOD-formatted observation data file obs_arr (int vector): line numbers in data file to be processed bodyname (string): user-defined name of satellite refiters (int): number of refinement iterations to be performed r2_root_ind_vec (1xlen(obs_arr) int array): indices of Gauss polynomial roots. plot (bool): if True, plots data.
- Returns:
- x (tuple): set of Keplerian orbital elements {(a, e, taup, omega, I, omega, T),t_vec[-1]}
-
orbitdeterminator.kep_determination.gauss_method.
gauss_refinement
(mu, tau1, tau3, r2, v2, atol, D, R, rho1, rho2, rho3, f_1, g_1, f_3, g_3)[source]¶ Perform refinement of Gauss method.
Parameters: - mu (float) – gravitational parameter of center of attraction
- tau1 (float) – time interval from second to first observation
- tau3 (float) – time interval from second to third observation
- r2 (1x3 array) – estimated position at second observation
- v2 (1x3 array) – estimated velocity at second observation
- atol (float) – absolute tolerance of universal Kepler anomaly computation
- D (3x3 array) – auxiliary matrix
- R (1x3 array) – three observer position vectors
- rho1 (1x3 array) – LOS vector at first observation
- rho2 (1x3 array) – LOS vector at second observation
- rho3 (1x3 array) – LOS vector at third observation
- f_1 (float) – estimated Lagrange’s f function value at first observation
- g_1 (float) – estimated Lagrange’s g function value at first observation
- f_3 (float) – estimated Lagrange’s f function value at third observation
- g_3 (float) – estimated Lagrange’s g function value at third observation
Returns: updated position at first observation r2 (1x3 array): updated position at second observation r3 (1x3 array): updated position at third observation v2 (1x3 array): updated velocity at second observation rho_1_sr (float): updated slant range at first observation rho_2_sr (float): updated slant range at second observation rho_3_sr (float): updated slant range at third observation f_1_new (float): updated Lagrange’s f function value at first observation g_1_new (float): updated Lagrange’s g function value at first observation f_3_new (float): updated Lagrange’s f function value at third observation g_3_new (float): updated Lagrange’s g function value at third observation
Return type: r1 (1x3 array)
-
orbitdeterminator.kep_determination.gauss_method.
get_observations_data
(mpc_object_data, inds)[source]¶ Extract three ra/dec observations from MPC observation data file.
Parameters: - mpc_object_data (string) – file path to MPC observation data of object
- inds (int array) – indices of requested data
Returns: ra/dec observation data obs_t (1x3 Time array): time observation data site_codes (1x3 int array): corresponding codes of observation sites
Return type: obs_radec (1x3 SkyCoord array)
-
orbitdeterminator.kep_determination.gauss_method.
get_observations_data_sat
(iod_object_data, inds)[source]¶ Extract three ra/dec observations from IOD observation data file.
Parameters: - iod_object_data (string) – file path to sat tracking observation data of object
- inds (int array) – indices of requested data
Returns: ra/dec observation data obs_t (1x3 Time array): time observation data site_codes (1x3 int array): corresponding codes of observation sites
Return type: obs_radec (1x3 SkyCoord array)
-
orbitdeterminator.kep_determination.gauss_method.
get_observatory_data
(observatory_code, mpc_observatories_data)[source]¶ Load individual data of MPC observatory corresponding to given observatory code.
Parameters: - observatory_code (int) – MPC observatory code.
- mpc_observatories_data (string) – path to file containing MPC observatories data.
Returns: observatory data corresponding to code.
Return type: ndarray
-
orbitdeterminator.kep_determination.gauss_method.
get_observer_pos_wrt_earth
(sat_observatories_data, obs_radec, site_codes)[source]¶ Compute position of observer at Earth’s surface, with respect to the Earth, in equatorial frame, during 3 distinct instants.
- Args:
- sat_observatories_data (string): path to file containing COSPAR satellite tracking stations data. obs_radec (1x3 SkyCoord array): three rad/dec observations site_codes (1x3 int array): COSPAR codes of observation sites
- Returns:
- R (1x3 array): cartesian position vectors (observer wrt Earth)
-
orbitdeterminator.kep_determination.gauss_method.
get_observer_pos_wrt_sun
(mpc_observatories_data, obs_radec, site_codes)[source]¶ Compute position of observer at Earth’s surface, with respect to the Sun, in equatorial frame, during 3 distinct instants.
- Args:
- mpc_observatories_data (string): path to file containing MPC observatories data. obs_radec (1x3 SkyCoord array): three rad/dec observations site_codes (1x3 int array): MPC codes of observation sites
- Returns:
- R (1x3 array): cartesian position vectors (observer wrt Sun) Ea_hc_pos (1x3 array): cartesian position vectors (Earth wrt Sun)
-
orbitdeterminator.kep_determination.gauss_method.
get_time_of_observation
(year, month, day, hour, minute, second, msecond)[source]¶ creates time variable
Parameters: - year –
- month –
- day –
- hour –
- minute –
- second –
- msecond –
Returns:
-
orbitdeterminator.kep_determination.gauss_method.
inclination
(x, y, z, u, v, w)[source]¶ Compute value of inclination, I.
Parameters: Returns: inclination, I
Return type:
-
orbitdeterminator.kep_determination.gauss_method.
kep_h_norm
(x, y, z, u, v, w)[source]¶ Compute norm of specific angular momentum vector h.
Parameters: Returns: norm of specific angular momentum vector, h.
Return type:
-
orbitdeterminator.kep_determination.gauss_method.
kep_h_vec
(x, y, z, u, v, w)[source]¶ Compute specific angular momentum vector h.
Parameters: Returns: specific angular momentum vector, h.
Return type:
-
orbitdeterminator.kep_determination.gauss_method.
lagrangef
(mu, r2, tau)[source]¶ Compute 1st order approximation to Lagrange’s f function.
Parameters: Returns: Lagrange’s f function value
Return type:
-
orbitdeterminator.kep_determination.gauss_method.
lagrangef_
(xi, z, r)[source]¶ Compute current value of Lagrange’s f function.
Parameters: Returns: Lagrange’s f function value
Return type:
-
orbitdeterminator.kep_determination.gauss_method.
lagrangeg
(mu, r2, tau)[source]¶ Compute 1st order approximation to Lagrange’s g function.
Parameters: Returns: Lagrange’s g function value
Return type:
-
orbitdeterminator.kep_determination.gauss_method.
lagrangeg_
(tau, xi, z, mu)[source]¶ Compute current value of Lagrange’s g function.
Parameters: Returns: Lagrange’s g function value
Return type:
-
orbitdeterminator.kep_determination.gauss_method.
load_mpc_data
(fname)[source]¶ Loads minor planet position observation data from MPC-formatted files. MPC format for minor planet observations is described at https://www.minorplanetcenter.net/iau/info/OpticalObs.html TODO: Add support for comets and natural satellites. Add support for radar observations: https://www.minorplanetcenter.net/iau/info/RadarObs.html See also NOTE 2 in: https://www.minorplanetcenter.net/iau/info/OpticalObs.html
Parameters: fname (string) – name of the MPC-formatted text file to be parsed Returns: array of minor planet position observations following the MPC format. Return type: x (ndarray)
-
orbitdeterminator.kep_determination.gauss_method.
load_mpc_observatories_data
(mpc_observatories_fname)[source]¶ Load Minor Planet Center observatories data using numpy’s genfromtxt function.
Parameters: mpc_observatories_fname (str) – file name with MPC observatories data. Returns: data read from the text file (output from numpy.genfromtxt) Return type: ndarray
-
orbitdeterminator.kep_determination.gauss_method.
longascnode
(x, y, z, u, v, w)[source]¶ Compute value of longitude of ascending node, computed as the angle between x-axis and the vector n = (-hy,hx,0), where hx, hy, are respectively, the x and y components of specific angular momentum vector, h.
- Args:
- x (float): x-component of position y (float): y-component of position z (float): z-component of position u (float): x-component of velocity v (float): y-component of velocity w (float): z-component of velocity
- Returns:
- float: longitude of ascending node
-
orbitdeterminator.kep_determination.gauss_method.
losvector
(ra_rad, dec_rad)[source]¶ Compute line-of-sight (LOS) vector for given values of right ascension and declination. Both angles must be provided in radians.
- Args:
- ra_rad (float): right ascension (rad) dec_rad (float): declination (rad)
- Returns:
- 1x3 numpy array: cartesian components of LOS vector.
-
orbitdeterminator.kep_determination.gauss_method.
object_wrt_sun
(t_utc, a, e, taup, omega, I, Omega)[source]¶ Compute position of celestial object with respect to the Sun, in equatorial frame.
Parameters: Returns: cartesian vector
Return type: (1x3 array)
-
orbitdeterminator.kep_determination.gauss_method.
observer_wrt_sun
(long, parallax_s, parallax_c, t_utc)[source]¶ Compute position of observer at Earth’s surface, with respect to the Sun, in equatorial frame.
- Args:
- long (float): longitude of observing site parallax_s (float): parallax constant S of observing site parallax_c (float): parallax constant C of observing site t_utc (Time): UTC time of observation
- Returns:
- (1x3 array): cartesian vector
-
orbitdeterminator.kep_determination.gauss_method.
observerpos_mpc
(long, parallax_s, parallax_c, t_utc)[source]¶ Compute geocentric observer position at UTC instant t_utc, for Sun-centered orbits, at a given observation site defined by its longitude, and parallax constants S and C. Formula taken from top of page 266, chapter 5, Orbital Mechanics book (Curtis). The parallax constants S and C are defined by: S=rho cos phi’ C=rho sin phi’, where rho: slant range phi’: geocentric latitude
- Args:
- long (float): longitude of observing site parallax_s (float): parallax constant S of observing site parallax_c (float): parallax constant C of observing site t_utc (astropy.time.Time): UTC time of observation
- Returns:
- 1x3 numpy array: cartesian components of observer’s geocentric position
-
orbitdeterminator.kep_determination.gauss_method.
observerpos_sat
(lat, long, elev, t_utc)[source]¶ Compute geocentric observer position at UTC instant t_utc, for Earth-centered orbits, at a given observation site defined by its longitude, geodetic latitude and elevation above reference ellipsoid. Formula taken from bottom of page 265 (Eq. 5.56), chapter 5, Orbital Mechanics book (Curtis).
- Args:
- lat (float): geodetic latitude (deg) long (float): longitude (deg) elev (float): elevation above reference ellipsoid (m) t_utc (astropy.time.Time): UTC time of observation
- Returns:
- 1x3 numpy array: cartesian components of observer’s geocentric position
-
orbitdeterminator.kep_determination.gauss_method.
radec_obs_vec_mpc
(inds, mpc_object_data)[source]¶ Compute vector of observed ra,dec values for MPC tracking data.
Parameters: - inds (int array) – line numbers of data in file
- mpc_object_data (ndarray) – MPC observation data for object
Returns: vector of ra/dec observed values
Return type: rov (1xlen(inds) array)
-
orbitdeterminator.kep_determination.gauss_method.
radec_obs_vec_sat
(inds, iod_object_data)[source]¶ Compute vector of observed ra,dec values for satellite tracking data (IOD-formatted).
Parameters: - inds (int array) – line numbers of data in file
- iod_object_data (ndarray) – observation data
Returns: vector of ra/dec observed values
Return type: rov (1xlen(inds) array)
-
orbitdeterminator.kep_determination.gauss_method.
radec_res_vec_rov_mpc
(x, inds, mpc_object_data, mpc_observatories_data, rov)[source]¶ Compute vector of observed minus computed (O-C) residuals for ra/dec MPC-formatted observations of minor planets (asteroids, comets, etc.), with pre-computed observed radec values vector. Assumes ra/dec observed values vector is contained in rov, and they are stored as rov = [ra1, dec1, ra2, dec2, …].
- Args:
- x (1x6 float array): set of orbital elements (a, e, taup, omega, I, Omega) inds (int array): line numbers of data in file mpc_object_data (ndarray): observation data mpc_observatories_data (ndarray): MPC observatories data rov (1xlen(inds) float-like array): vector of observed ra/dec values
- Returns:
- rv (1xlen(inds) array): vector of ra/dec (O-C) residuals.
-
orbitdeterminator.kep_determination.gauss_method.
radec_res_vec_rov_sat
(x, inds, iod_object_data, sat_observatories_data, rov)[source]¶ Compute vector of observed minus computed (O-C) residuals for ra/dec Earth-orbiting satellite observations with pre-computed observed radec values vector. Assumes ra/dec observed values vector is contained in rov, and they are stored as rov = [ra1, dec1, ra2, dec2, …].
- Args:
- x (1x6 float array): set of orbital elements (a, e, taup, omega, I, Omega) inds (int array): line numbers of data in file iod_object_data (ndarray): observation data sat_observatories_data (ndarray): satellite tracking stations data rov (1xlen(inds) float-like array): vector of observed ra/dec values
- Returns:
- rv (1xlen(inds) array): vector of ra/dec (O-C) residuals.
-
orbitdeterminator.kep_determination.gauss_method.
radec_residual_mpc
(x, t_ra_dec_datapoint, long, parallax_s, parallax_c)[source]¶ Compute observed minus computed (O-C) residual for a given ra/dec datapoint, represented as a SkyCoord object, for MPC observation data.
- Args:
- x (1x6 array): set of Keplerian elements t_ra_dec_datapoint (SkyCoord): ra/dec datapoint long (float): longitude of observing site parallax_s (float): parallax constant S of observing site parallax_c (float): parallax constant C of observing site
- Returns:
- (1x2 array): right ascension difference, declination difference
-
orbitdeterminator.kep_determination.gauss_method.
radec_residual_rov_mpc
(x, t, ra_obs_rad, dec_obs_rad, long, parallax_s, parallax_c)[source]¶ Compute right ascension and declination observed minus computed (O-C) residual, using precomputed vector of observed ra/dec values, for MPC observation data.
- Args:
- x (1x6 array): set of Keplerian elements t (Time): time of observation ra_obs_rad (float): observed right ascension (rad) dec_obs_rad (float): observed declination (rad) long (float): longitude of observing site parallax_s (float): parallax constant S of observing site parallax_c (float): parallax constant C of observing site
- Returns:
- (1x2 array): right ascension difference, declination difference
-
orbitdeterminator.kep_determination.gauss_method.
rho_vec
(long, parallax_s, parallax_c, t_utc, a, e, taup, omega, I, Omega)[source]¶ Compute slant range vector.
Parameters: - long (float) – longitude of observing site
- parallax_s (float) – parallax constant S of observing site
- parallax_c (float) – parallax constant C of observing site
- t_utc (Time) – UTC time of observation
- a (float) – semimajor axis
- e (float) – eccentricity
- taup (float) – time of pericenter passage
- omega (float) – argument of pericenter
- I (float) – inclination
- Omega (float) – longitude of ascending node
Returns: cartesian vector
Return type: (1x3 array)
-
orbitdeterminator.kep_determination.gauss_method.
rhovec2radec
(long, parallax_s, parallax_c, t_utc, a, e, taup, omega, I, Omega)[source]¶ Transform slant range vector to ra/dec values.
Parameters: - long (float) – longitude of observing site
- parallax_s (float) – parallax constant S of observing site
- parallax_c (float) – parallax constant C of observing site
- t_utc (Time) – UTC time of observation
- a (float) – semimajor axis
- e (float) – eccentricity
- taup (float) – time of pericenter passage
- omega (float) – argument of pericenter
- I (float) – inclination
- Omega (float) – longitude of ascending node
Returns: right ascension (rad) dec_rad (float): declination (rad)
Return type: ra_rad (float)
-
orbitdeterminator.kep_determination.gauss_method.
rungelenz
(x, y, z, u, v, w, mu)[source]¶ Compute the cartesian components of Laplace-Runge-Lenz vector.
Parameters: Returns: Laplace-Runge-Lenz vector
Return type:
-
orbitdeterminator.kep_determination.gauss_method.
semimajoraxis
(x, y, z, u, v, w, mu)[source]¶ Compute value of semimajor axis, a.
Parameters: Returns: semimajor axis, a
Return type:
-
orbitdeterminator.kep_determination.gauss_method.
t_radec_res_vec_mpc
(x, inds, mpc_object_data, mpc_observatories_data)[source]¶ Compute vector of observed minus computed (O-C) residuals for ra/dec MPC-formatted observations of minor planets (asteroids, comets, etc.), with pre-computed observed radec values vector. Assumes ra/dec observed values vector is contained in rov, and they are stored as rov = [ra1, dec1, ra2, dec2, …].
- Args:
- x (1x6 float array): set of orbital elements (a, e, taup, omega, I, Omega) inds (int array): line numbers of data in file mpc_object_data (ndarray): observation data mpc_observatories_data (ndarray): MPC observatories data rov (1xlen(inds) float-like array): vector of observed ra/dec values
- Returns:
- rv (1xlen(inds) array): vector of ra/dec (O-C) residuals. tv (1xlen(inds) array): vector of observation times.
-
orbitdeterminator.kep_determination.gauss_method.
t_radec_res_vec_sat
(x, inds, iod_object_data, sat_observatories_data, rov)[source]¶ Compute vector of observed minus computed (O-C) residuals for ra/dec Earth-orbiting satellite observations with pre-computed observed radec values vector. Assumes ra/dec observed values vector is contained in rov, and they are stored as rov = [ra1, dec1, ra2, dec2, …].
- Args:
- x (1x6 float array): set of orbital elements (a, e, taup, omega, I, Omega) inds (int array): line numbers of data in file iod_object_data (ndarray): observation data sat_observatories_data (ndarray): satellite tracking stations data rov (1xlen(inds) float-like array): vector of observed ra/dec values
- Returns:
- rv (1xlen(inds) array): vector of ra/dec (O-C) residuals. tv (1xlen(inds) array): vector of observation times.
-
orbitdeterminator.kep_determination.gauss_method.
taupericenter
(t, e, f, n)[source]¶ Compute the time of pericenter passage.
Parameters: Returns: time of pericenter passage
Return type:
-
orbitdeterminator.kep_determination.gauss_method.
trueanomaly5
(x, y, z, u, v, w, mu)[source]¶ Compute the true anomaly from cartesian state.
Parameters: Returns: true anomaly
Return type:
-
orbitdeterminator.kep_determination.gauss_method.
univkepler
(dt, x, y, z, u, v, w, mu, iters=5, atol=1e-15)[source]¶ Compute the current value of the universal Kepler anomaly, xi.
Parameters: - dt (float) – time interval
- x (float) – x-component of position
- y (float) – y-component of position
- z (float) – z-component of position
- u (float) – x-component of velocity
- v (float) – y-component of velocity
- w (float) – z-component of velocity
- mu (float) – gravitational parameter
- iters (int) – number of iterations of Newton-Raphson process
- atol (float) – absolute tolerance of Newton-Raphson process
Returns: alpha = 1/a
Return type:
Least squares¶
Computes the least-squares optimal Keplerian elements for a sequence of cartesian position observations.
-
orbitdeterminator.kep_determination.least_squares.
gauss_LS_mpc
(filename, bodyname, obs_arr, r2_root_ind_vec=None, obs_arr_ls=None, gaussiters=0, plot=True)[source]¶ Minor planets orbit determination high-level function from MPC-formatted ra/dec tracking data. Preliminary orbit determination via Gauss method is performed. Roots of 8-th order Gauss polynomial are computed using np.roots function. Note that if r2_root_ind_vec is not specified by the user, then the first positive root returned by np.roots is used by default.
- Args:
- filename (string): path to MPC-formatted observation data file bodyname (string): user-defined name of minor planet obs_arr (int vector): line numbers in data file to be processed in Gauss preliminary orbit determination r2_root_ind_vec (1xlen(obs_arr) int array): indices of Gauss polynomial roots. obs_arr (int vector): line numbers in data file to be processed in least-squares fit gaussiters (int): number of refinement iterations to be performed plot (bool): if True, plots data.
- Returns:
- x (tuple): set of Keplerian orbital elements (a, e, taup, omega, I, omega, T)
-
orbitdeterminator.kep_determination.least_squares.
gauss_LS_sat
(filename, bodyname, obs_arr, r2_root_ind_vec=None, obs_arr_ls=None, gaussiters=0, plot=True)[source]¶ Earth satellites orbit determination high-level function from IOD-formatted ra/dec tracking data. IOD angle subformat 2 is assumed. Preliminary orbit determination via Gauss method is performed. Roots of 8-th order Gauss polynomial are computed using np.roots function. Note that if r2_root_ind_vec is not specified by the user, then the first positive root returned by np.roots is used by default.
- Args:
- filename (string): path to IOD-formatted observation data file bodyname (string): user-defined name of satellite obs_arr (int vector): line numbers in data file to be processed in Gauss preliminary orbit determination r2_root_ind_vec (1xlen(obs_arr) int array): indices of Gauss polynomial roots. obs_arr (int vector): line numbers in data file to be processed in least-squares fit gaussiters (int): number of refinement iterations to be performed plot (bool): if True, plots data.
- Returns:
- x (tuple): set of Keplerian orbital elements (a, e, taup, omega, I, omega, T)
-
orbitdeterminator.kep_determination.least_squares.
get_weights
(resid)[source]¶ This function calculates the weights per (x,y,z) by using the inverse of the squared residuals divided by the total sum of the inverse of the squared residuals.
-
orbitdeterminator.kep_determination.least_squares.
radec_res_vec_rov_mpc_w
(x, inds, mpc_object_data, mpc_observatories_data, rov, weights)[source]¶ Compute vector of observed minus computed weighted (O-C) residuals for ra/dec MPC-formatted observations of minor planets (asteroids, comets, etc.), with pre-computed observed radec values vector. Assumes ra/dec observed values vector is contained in rov, and they are stored as rov = [ra1, dec1, ra2, dec2, …].
- Args:
- x (1x6 float array): set of orbital elements (a, e, taup, omega, I, Omega) inds (int array): line numbers of data in file mpc_object_data (ndarray): observation data mpc_observatories_data (ndarray): MPC observatories data rov (1xlen(inds) float-like array): vector of observed ra/dec values
- Returns:
- rv (1xlen(inds) array): vector of ra/dec (O-C) residuals.
-
orbitdeterminator.kep_determination.least_squares.
radec_res_vec_rov_sat_w
(x, inds, iod_object_data, sat_observatories_data, rov, weights)[source]¶ Compute vector of observed minus computed (O-C) weighted residuals for ra/dec Earth-orbiting satellite observations with pre-computed observed radec values vector. Assumes ra/dec observed values vector is contained in rov, and they are stored as rov = [ra1, dec1, ra2, dec2, …].
- Args:
- x (1x6 float array): set of orbital elements (a, e, taup, omega, I, Omega) inds (int array): line numbers of data in file iod_object_data (ndarray): observation data sat_observatories_data (ndarray): satellite tracking stations data rov (1xlen(inds) float-like array): vector of observed ra/dec values
- Returns:
- rv (1xlen(inds) array): vector of ra/dec weighted (O-C) residuals.
Propagation:¶
Propagation Model¶
-
class
orbitdeterminator.propagation.sgp4.
SGP4
[source]¶ -
-
compute_necessary_kep
(kep, b_star=2.1109e-05)[source]¶ Initializes the necessary class variables using keplerian elements which are needed in the computation of the propagation model.
Parameters: Returns: NIL
-
compute_necessary_tle
(line1, line2)[source]¶ Initializes the necessary class variables using TLE which are needed in the computation of the propagation model.
Parameters: Returns: NIL
-
propagate
(t1, t2)[source]¶ Invokes the function to compute state vectors and organises the final result.
The function first checks if compute_necessary_xxx() is called or not if not then a custom exception is raised stating that call this function first. Then it computes the state vector for the next 8 hours (28800 seconds in 8 hours) at every time epoch (28800 time epcohs) using the sgp4 propagation model. The values of state vector is formatted upto five decimal points and then all the state vectors got appended in a list which stores the final output.
Parameters: Returns: vector containing all state vectors
Return type: numpy.ndarray
-
propagation_model
(tsince)[source]¶ From the time epoch and information from TLE, applies SGP4 on it.
The function applies the Simplified General Perturbations algorithm SGP4 on the information extracted from the TLE at the given time epoch ‘tsince’ and computes the state vector from it.
Parameters: tsince (int) – time epoch Returns: position and velocity vector Return type: tuple
-
classmethod
recover_tle
(pos, vel)[source]¶ Recovers TLE back from state vector.
First of all, only necessary information (which are inclination, right ascension of the ascending node, eccentricity, argument of perigee, mean anomaly, mean motion and bstar) that are needed in the computation of SGP4 propagation model are recovered. It is using a general format of TLE. State vectors are used to find orbital elements which are then inserted into the TLE format at their respective positions. Mean motion and bstar is calculated separately as it is not a part of orbital elements. Format of TLE: x denotes that there is a digit, c denotes a character value, underscore(_) denotes a plus/minus(+/-) sign value and period(.) denotes a decimal point.
Parameters: Returns: line1 and line2 of TLE
Return type:
-
Cowell Method¶
Numerical orbit propagator based on RK4. Takes into account J2 and drag perturbations.
-
orbitdeterminator.propagation.cowell.
drag
(s)[source]¶ Returns the drag acceleration for a given state.
Parameters: s (1x6 numpy array) – the state vector [rx,ry,rz,vx,vy,vz] Returns: the drag acceleration [ax,ay,az] Return type: 1x3 numpy array
-
orbitdeterminator.propagation.cowell.
j2_pert
(s)[source]¶ Returns the J2 acceleration for a given state.
Parameters: s (1x6 numpy array) – the state vector [rx,ry,rz,vx,vy,vz] Returns: the J2 acceleration [ax,ay,az] Return type: 1x3 numpy array
-
orbitdeterminator.propagation.cowell.
propagate_state
(s, t0, tf)[source]¶ Equivalent to the rk4 function.
-
orbitdeterminator.propagation.cowell.
rk4
(s, t0, tf, h=30)[source]¶ Runge-Kutta 4th Order Numerical Integrator
- Args:
- s(1x6 numpy array): the state vector [rx,ry,rz,vx,vy,vz] t0(float) : initial time tf(float) : final time h(float) : step-size
Returns: the state at time tf Return type: 1x6 numpy array
-
orbitdeterminator.propagation.cowell.
rkf45
(s, t0, tf, h=10, tol=1e-06)[source]¶ Runge-Kutta Fehlberg 4(5) Numerical Integrator
- Args:
- s(1x6 numpy array): the state vector [rx,ry,rz,vx,vy,vz] t0(float) : initial time tf(float) : final time h(float) : step-size tol(float) : tolerance of error
Returns: the state at time tf Return type: 1x6 numpy array
Simulator¶
-
class
orbitdeterminator.propagation.simulator.
Simulator
(params)[source]¶ A class for the simulator.
-
__init__
(params)[source]¶ Initializes the simulator.
Parameters: params – A SimParams object containing kep,t0,t,period,speed, and op_writer Returns: nothing
-
calc
()[source]¶ Calculates the satellite state at current time and calls itself after a certain amount of time.
-
-
class
orbitdeterminator.propagation.simulator.
SimParams
[source]¶ SimParams class. This is just a container for all the parameters required to start the simulation.
kep(1x6 numpy array): the intial osculating keplerian elements epoch(float): the epoch of the above kep period(float): maximum time period between observations t0(float): starting time of the simulation speed(float): speed of the simulation op_writer(OpWriter): output handling object
-
class
orbitdeterminator.propagation.simulator.
OpWriter
[source]¶ Base output writer class. Inherit this class and override the methods.
-
close
()[source]¶ Anything that has to be executed after finishing writing the output. Runs once.
Example: Closing connection to a database
-
-
class
orbitdeterminator.propagation.simulator.
print_r
[source]¶ Bases:
orbitdeterminator.propagation.simulator.OpWriter
Prints the position vector
-
class
orbitdeterminator.propagation.simulator.
save_r
(name)[source]¶ Bases:
orbitdeterminator.propagation.simulator.OpWriter
Saves the position vector to a file
DGSN Simulator¶
Kalman Filter¶
sgp4_prop¶
SGP4 propagator. This is a wrapper around the PyPI SGP4 propagator. However, this does not generate an artificial TLE. So there is no string manipulation involved. Hence this is faster than sgp4_prop_string.
-
orbitdeterminator.propagation.sgp4_prop.
kep_to_sat
(kep, epoch, bstar=0.21109E-4, whichconst=wgs72, afspc_mode=False)[source]¶ Converts a set of keplerian elements into a Satellite object.
- Args:
- kep(1x6 numpy array): the osculating keplerian elements at epoch epoch(float): the epoch bstar(float): bstar drag coefficient whichconst(float): gravity model. refer pypi sgp4 documentation afspc_mode(boolean): refer pypi sgp4 documentation
Returns: an sgp4 satellite object encapsulating the arguments Return type: Satellite object
-
orbitdeterminator.propagation.sgp4_prop.
propagate_kep
(kep, t0, tf, bstar=2.1109e-05)[source]¶ Propagates a set of keplerian elements.
Parameters: Returns: the position at tf vel(1x3 numpy array): the velocity at tf
Return type: pos(1x3 numpy array)
sgp4_prop_string¶
SGP4 propagator. This is a wrapper around PyPI SGP4 propagator. It constructs an artificial TLE and passes it to the PyPI module.
Utils:¶
kep_state¶
Takes a set of keplerian elements (a, e, i, ω, Ω, v) and transforms it into a state vector (x, y, z, vx, vy, vz) where v is the velocity of the satellite
-
orbitdeterminator.util.kep_state.
kep_state
(kep)[source]¶ Converts the keplerian elements to position and velocity vector
Parameters: kep (numpy array) – a 1x6 matrix which contains the following variables kep(0): semi major axis (km) kep(1): eccentricity (number) kep(2): inclination (degrees) kep(3): argument of perigee (degrees) kep(4): right ascension of the ascending node (degrees) kep(5): true anomaly (degrees) Returns: 1x6 matrix which contains the position and velocity vector r(0),r(1),r(2): position vector (x,y,z) km r(3),r(4),r(5): velocity vector (vx,vy,vz) km/s Return type: numpy array
read_data¶
Reads the positional data set from a .csv file
-
orbitdeterminator.util.read_data.
load_data
(filename)[source]¶ Loads the data in numpy array for further processing in tab delimiter format
Parameters: filename (string) – name of the csv file to be parsed Returns: array of the orbit positions, each point of the orbit is of the format (time, x, y, z) Return type: numpy array
state_kep¶
Takes a state vector (x, y, z, vx, vy, vz) where v is the velocity of the satellite and transforms it into a set of keplerian elements (a, e, i, ω, Ω, v)
-
orbitdeterminator.util.state_kep.
state_kep
(r, v)[source]¶ Converts state vector to orbital elements.
Parameters: - r (numpy array) – position vector
- v (numpy array) – velocity vector
Returns: array of the computed keplerian elements kep(0): semimajor axis (kilometers) kep(1): orbital eccentricity (non-dimensional)
(0 <= eccentricity < 1)
kep(2): orbital inclination (degrees) kep(3): argument of perigee (degress) kep(4): right ascension of ascending node (degrees) kep(5): true anomaly (degrees)
Return type: numpy array
input_transf¶
Converts cartesian co-ordinates to spherical co-ordinates and vice versa
-
orbitdeterminator.util.input_transf.
cart_to_spher
(data)[source]¶ Takes as an input a data set containing points in cartesian format (time, x, y, z) and returns the computed spherical coordinates (time, azimuth, elevation, r)
Parameters: data (numpy array) – containing the cartesian coordinates in format of (time, x, y, z) Returns: array of spherical coordinates in format of (time, azimuth, elevation, r) Return type: numpy array
-
orbitdeterminator.util.input_transf.
spher_to_cart
(data)[source]¶ Takes as an input a data set containing points in spherical format (time, azimuth, elevation, r) and returns the computed cartesian coordinates (time, x, y, z).
Parameters: data (numpy array) – containing the spherical coordinates in format of (time, azimuth, elevation, r) Returns: array of cartesian coordinates in format of (time, x, y, z) Return type: numpy array
rkf78¶
Uses Runge Kutta Fehlberg 7(8) numerical integration method to compute the state vector in a time interval tf
golay_window¶
-
orbitdeterminator.util.golay_window.
window
(error, data)[source]¶ Calculates the constant c which is needed to determine the savintzky - golay filter window window = len(data) / c ,where c is a constant strongly related to the error contained in the data set
Parameters: - error (float) – the a-priori error estimation for each measurment
- data (numpy array) – the positional data set
Returns: constant which describes the window that needs to be inputed to the savintzky - golay filter
Return type:
anom_conv¶
Vectorized anomaly conversion scripts
-
orbitdeterminator.util.anom_conv.
ecc_to_mean
(E, e)[source]¶ Converts eccentric anomaly to mean anomaly.
Parameters: - E (numpy array) – array of eccentric anomalies (in radians)
- e (float) – eccentricity
Returns: array of mean anomalies (in radians)
Return type: numpy array
new_tle_kep_state¶
This module computes the state vector from keplerian elements.
-
orbitdeterminator.util.new_tle_kep_state.
kep_to_state
(kep)[source]¶ This function converts from keplerian elements to the position and velocity vector
Parameters: kep (1x6 numpy array) – kep contains the following variables kep[0] = semi-major axis (kms) kep[1] = eccentricity (number) kep[2] = inclination (degrees) kep[3] = argument of perigee (degrees) kep[4] = right ascension of ascending node (degrees) kep[5] = true anomaly (degrees) Returns: r: 1x6 numpy array which contains the position and velocity vector
r[0],r[1],r[2] = position vector [rx,ry,rz] km r[3],r[4],r[5] = velocity vector [vx,vy,vz] km/s
-
orbitdeterminator.util.new_tle_kep_state.
tle_to_state
(tle)[source]¶ This function converts from TLE elements to position and velocity vector
Parameters: tle (1x6 numpy array) – tle contains the following variables tle[0] = inclination (degrees) tle[1] = right ascension of the ascending node (degrees) tle[2] = eccentricity (number) tle[3] = argument of perigee (degrees) tle[4] = mean anomaly (degrees) tle[5] = mean motion (revs per day) Returns: r: 1x6 numpy array which contains the position and velocity vector
r[0],r[1],r[2] = position vector [rx,ry,rz] km r[3],r[4],r[5] = velocity vector [vx,vy,vz] km/s
teme_to_ecef¶
Converts coordinates in TEME frame to ECEF frame.
-
orbitdeterminator.util.teme_to_ecef.
conv_to_ecef
(coords)[source]¶ Converts coordinates in TEME frame to ECEF frame.
Parameters: coords (nx4 numpy array) – list of coordinates in the format [t,x,y,z] Returns: - list of coordinates in the format
- [t, latitude, longitude, altitude]
Note that these coordinates are with respect to the surface of the Earth. Latitude, longitude are in degrees.
Return type: nx4 numpy array
Tutorials¶
* Run the program with main.py¶
For the first example we will showcase how you can use the full features of the package with main.py. Simply executing the main.py by giving the name of .csv file that contains the positional data of the satellite, as an argument in the function process(data_file):
def process(data_file, error_apriori):
'''
Given a .csv data file in the format of (time, x, y, z) applies both filters, generates a filtered.csv data
file, prints out the final keplerian elements computed from both Lamberts and Interpolation and finally plots
the initial, filtered data set and the final orbit.
Args:
data_file (string): The name of the .csv file containing the positional data
error_apriori (float): apriori estimation of the measurements error in km
Returns:
Runs the whole process of the program
'''
Simply input the name of the .csv file in the format of (time, x, y, z) and tab delimiter like the orbit.csv that is located in the src folder and the process will run. You also need to input a apriori estimation of the measurements errors, which in the example case is 20km per point (points every 1 second). In the case you are using your own positional data set you need to estimate this value and input it because it is critical for the filtering process:
run = process("example_data/orbit.csv")
Warning
If the format of you data is (time, azimuth, elevation, distance) you can use the input_transf function first and be sure that the delimiter for the data file is tab delimiter since this is the one read_data supports.
The process that will run with the use of the process function is, first the program reads your data from the .csv file then, applies both filters (Triple moving average and Savintzky - Golay), generates a .csv file called filtered, that included the filtered data set, computes the keplerian elements of the orbit with both methods (Lamberts - Kalman and Spline Interpolation) and finally prints and plots some results. More specifically, the results printed by this process will be first the sum and mean value of the residuals (difference between filtered and initial data), the computed keplerian elements in format of (a - semi major axis, e - eccentricity, i - inclination, ω - argument of perigee, Ω - right ascension of the ascending node, v - true anomaly) and a 3d matplotlib graph that plots the initial, filtered data set and the final computed orbit described by the keplerian elements (via the interpolation method).
Process¶
- Reads the data
- Uses both filters on them (Triple moving average and Savintzky - Golay )
- Generates a .csv file called filtered that includes the filtered data set
- Computes keplerian elements with both methods (Lamberts - Kalman and Spline Interpolation)
- Prints results and plot a 3d matplotlib graph
Results¶
- Sum and mean of the residuals (differences between filtered and initial data set)
- Final keplerian elements from both methods (first column : Lamberts - Kalman, second column : Spline Interpolation)
- 3d matplotlib graph with the initial, filtered data set and the final orbit described by the keplerian elements from Spline Interpolation
Warning
Measurement unit for distance is kilometer and for angle degrees
The output should look like the following image.

* Run the program with automated.py¶
automated.py is another flavour of main.py that is supposed to run on a server. It keeps listening for new files in a particular directory and processes them when they arrive.
Note
All the processing invloved in this module is identical to that of main.py.
For testing purpose some files have already put in a folder named src. These are raw unprocessed files. There is another folder named dst which contains processed files along with a graph saved in the form of svg.
To execute this script, change the directory to the script’s directory:
cd orbitdeterminator/
and run the code using python3:
python3 automated.py
and thats it. This will keep listening for new files and process them as they arrive.

Process¶
- Initialize an empty git repository in src folder
- Read the untracked files of that folder and put them in a list
- Process the files in this list and save the results(processed data and graph) to dst folder
- Stage the processed file in the src folder in order to avoid processing the same files multiple times.
- Check for any untracked files in src and apply steps 2-4 again.
* Using certain modules¶
In this example we are not going to use the main.py, but some of the main modules provided. First of all lets clear the path we are going to follow which is fairly straightforward. Note that we are going to use the same example_data/orbit.csv that is located inside the src folder and has tab delimeter (read_data.py reads with this delimiter).
Process¶
- Read the data
- Filter the data
- Compute keplerian elements for the final orbit
So first we read the data using the util/read_data.load_data function. Just input the .csv file name into the function and it will create a numpy array with the positional data ready to be processed:
data = read_data.load_data("example_data/orbit.csv")
Warning
If the format of you data is (time, azimuth, elevation, distance) you can use the util/input_transf.spher_to_cart function first. And it is critical for the x, y, z to be in kilometers.
We continue by applying the Triple moving average filter:
data_after_filter = triple_moving_average.generate_filtered_data(data, 3)
We suggest using 3 as the window size of the filter. Came to this conclusion after a lot of testing. Next we apply the second filter to the data set which will be of a larger window size so that we can smooth the data set in a larger scale. The optimal window size for the Savintzky - Golay filter is being computed by the function golay_window.c(error_apriori) in which we only have to input the apriori error estimation for the initial data set (or the measurements error):
error_apriori = 20.0
c = golay_window.c(error_apriori)
window = len(data) / c
window = int(window)
The other 2 lines after the use of the golay_window.c(error_apriori) are needed to compute the window size for the Savintzky - Golay filter and again for the polynomial parameter of the filter we suggest using 3:
data_after_filter = sav_golay.golay(data_after_filter, window, 3)
At this point we have the filtered positional data set ready to be inputed into the Lamberts - Kalman and Spline interpolation algorithms so that the final keplerian elements can be computed:
kep_lamb = lamberts_kalman.create_kep(data_after_filter)
kep_final_lamb = lamberts_kalman.kalman(kep_lamb, 0.01 ** 2)
kep_inter = interpolation.main(data_after_filter)
kep_final_inter = lamberts_kalman.kalman(kep_inter, 0.01 ** 2)
With the above 4 lines of code the final set of 6 keplerian elements is computed by the two methods. The output format is (semi major axis (a), eccentricity (e), inclination (i), argument of perigee (ω), right ascension of the ascending node (Ω), true anomaly (v)). So finally, in the variables kep_final_lamb and kep_final_inter a numpy array 1x6 has the final computed keplerian elements.
Warning
If the orbit you want to compute is polar (i = 90) then we suggest you to use only the interpolation method.
Using ellipse_fit method¶
If a lot of points are available spread over the entire orbit, then the ellipse fit method can be used for orbit
determination. The module kep_determination.ellipse_fit
has two methods - determine_kep
and plot_kep
.
As the name suggests, determine_kep
is used to determine the orbit and plot_kep
is used to plot it.
Call determine_kep
with:
kep,res = determine_kep(data)
where data is a nx3 numpy array. The ellipse_fit method does not use time information at all. Hence, the input format is [(x,y,z),…]. The method results two arguments - the first output is the Keplerian elements while the second output is the list of residuals.
Plot the results using the plot_kep
method. Call it with:
plot_kep(kep,data)
where kep is the Keplerian elements we got in the last step and data is the original data. The result should look like this.

Using propagation modules¶
Cowell Method¶
The module propagation.cowell
propagates a satellite along its orbit using numerical integration. It takes
into account the oblateness of the Earth and atmospheric drag. The module has many methods for calculating
drag and J2 acceleration, and integrating them. However, here we will discuss only the important ones. One is
propagate_state
and the other is time_period
. propagate_state
propagates a state vector from t1 to t2.
time_period
finds out the nodal time period of an orbit, given a state vector. Call propagate_state
like this.:
sf = propagate_state(si,t0,tf)
where si is the state at t0 and sf is the state at tf.
Note
In all propagation related discussions a state vector is the numpy array [rx,ry,rz,vx,vy,vz].
Similarly to find out time period call time_period
like this.:
t = time_period(s)
DGSN Simulator¶
The module propagation.dgsn_simulator
can be used for simulating the DGSN. Given a satellite, it propagates
the satellite along its orbit and periodically outputs its location. The location will have some associated with
it. Observations will also not be exactly periodic. There will be slight variations. And sometimes observations
might not be available (for example, the satellite is out of range of the DGSN).
To use this simulator, 3 classes are used.
- The SimParams class - This is a collection of all the simulation parameters.
- The OpWriter class - This class tells the simulator what to do with the output.
- The DGSNSimulator class - This is the actual simulator class.
To start, we must choose an OpWriter class. This will tell the simulator what to do with the output. To use it,
extend the class and override its write
method. Several sample classes have been provided. For this example we
will use the default print_r
class. This just prints the output.
Now create a SimParams object. For now, only set the kep, epoch and t0.:
epoch = 1531152114
t0 = epoch
iss_kep = np.array([6785.6420,0.0003456,51.6418,290.0933,266.6543,212.4306])
params = SimParams()
params.kep = iss_kep
params.epoch = epoch
params.t0 = t0
Now initialize the simulator with these parameters and start it.:
s = DGSNSimulator(params)
s.simulate()
The program should start printing the time and the corresponding satellite coordinates on the terminal.
Note
The module propagation.simulator
is similar to this module. The only difference is that it doesn’t
add any noise. So it can be used for comparison purposes.
Kalman Filter¶
The module propagation.kalman_filter
can be used to combine observation data and simulation data with a
Kalman Filter. This module keeps on checking a file for new observation data and applies the filter accordingly.
We can use the DGSN Simulator module to create observation data in real time. First, we must setup the simulator.
We must configure it to save the output to a file instead of printing it. For this, we will use the in-built
save_r
class.
Run the simulator with the following commands.:
epoch = 1531152114
t0 = epoch
iss_kep = np.array([6785.6420,0.0003456,51.6418,290.0933,266.6543,212.4306])
params = SimParams()
params.kep = iss_kep
params.epoch = epoch
params.t0 = t0
params.r_jit = 15
params.op_writer = save_r('ISS_DGSN.csv')
s = DGSNSimulator(params)
s.simulate()
Now the program will start writing observations into the file ISS_DGSN.csv
. Now we need to setup the Kalman
Filter with the same parameters. Use util.new_tle_kep_state
to convert Keplerian elements into a state
vector. In this tutorial, it is already done. Run the filter by passing the state and the name of the file to read.:
s = np.array([2.87327861e+03,5.22872234e+03,3.23884457e+03,-3.49536799e+00,4.87267295e+00,-4.76846910e+00])
t0 = 1531152114
KalmanFilter().process(s,t0,'ISS_DGSN.csv')
The program should start printing filtered values on the terminal.
Using utility modules¶
new_tle_kep_state¶
new_tle_kep_state
is used to convert a TLE or a set of Keplerian elements into a state vector. To convert a TLE
make an array out of the 2nd line of the TLE. The array should be of the form:
- tle[0] = inclination (in degrees)
- tle[1] = right ascension of ascending node (in degrees)
- tle[2] = eccentricity
- tle[3] = argument of perigee (in degrees)
- tle[4] = mean anomaly (in degrees)
- tle[5] = mean motion (in revs per day)
Now call tle_to_state
. For example:
tle = np.array([51.6418, 266.6543, 0.0003456, 290.0933, 212.4518, 15.54021918])
r = tle_to_state(tle)
print(r)
Similarly a Keplerian set can also be converted into a state vector.
teme_to_ecef¶
teme_to_ecef
is used to convert coordinates from TEME frame (inertial frame) to ECEF frame (rotating Earth fixed frame).
The module accepts a list of coordinates of the form [t1,x,y,z] and outputs a list of latitudes, longitudes and altitudes
in Earth fixed frame. These coordinates can be directly plotted on a map.
For example:
ecef_coords = conv_to_ecef(np.array([[1521562500,768.281,5835.68,2438.076],
[1521562500,768.281,5835.68,2438.076],
[1521562500,768.281,5835.68,2438.076]]))
The resulting latitudes and longitudes can be directly plotted on an Earth map to visualize the satellite location with respect to the Earth.
Gauss method: Earth-centered and Sun-centered orbits¶
In this section, we will show a couple of examples to determine the orbit of Earth satellites and Sun-orbiting minor planets, from right ascension and declination tracking data, using the Gauss method.
gauss_method_sat¶
gauss_method_sat
allows us to determine the Keplerian orbit of an Earth satellite from
a file containing right ascension and declination (“ra/dec”, for short)
observations in IOD format. The IOD format is described at:
http://www.satobs.org/position/IODformat.html. For this example, we will use the
file “SATOBS-ML-19200716.txt”in the example_data folder, which corresponds to
ra/dec observations of the ISS performed in July 2016 by Marco Langbroek, who
originally posted these observations at the mailing list of the satobs
organization (http://www.satobs.org).
First, we import the least_squares submodule:
from orbitdeterminator.kep_determination.gauss_method import gauss_method_sat
Then, in the string filename we specify the path of the file where the IOD-formatted data has been stored. In the bodyname string, we type an user-defined identifier for the satellite::
# path of file of ra/dec IOD-formatted observations
# the example contains tracking data for ISS (25544)
filename = '/full/path/to/example_data/SATOBS-ML-19200716.txt'
# body name
bodyname = 'ISS (25544)'
Note that the each line in filename must refer to the same satellite. Next, we select the observations that we will use for our computation. Our file has actually six lines, but we will select only observations 2 through 5::
#lines of observations file to be used for preliminary orbit determination via Gauss method
obs_arr = [1, 4, 6]
Remember that the Gauss method needs at least three ra/dec observations, so if selecting obs_arr consisted of more observations, then gauss_method_sat would take consecutive triplets. For example if we had obs_arr = [2, 3, 4, 5] then Gauss method would be performed over (2,3,4), and then over (3,4,5). The resulting orbital elements correspond to an average over these triplets. Now, we are ready to call the gauss_method_sat function:
x = gauss_method_sat(filename, bodyname, obs_arr)
The variable x stores the set of Keplerian orbital elements determined from averaging over the consecutive observation triplets as described above. The on-screen output is the following::
*** ORBIT DETERMINATION: GAUSS METHOD ***
Observational arc:
Number of observations: 3
First observation (UTC) : 2016-07-20 01:31:32.250
Last observation (UTC) : 2016-07-20 01:33:42.250
AVERAGE ORBITAL ELEMENTS (EQUATORIAL): a, e, taup, omega, I, Omega, T
Semi-major axis (a): 6693.72282229624 km
Eccentricity (e): 0.011532050419770104
Time of pericenter passage (tau): 2016-07-20 00:45:14.648 JDUTC
Argument of pericenter (omega): 252.0109594208592 deg
Inclination (I): 51.60513143468057 deg
Longitude of Ascending Node (Omega): 253.86985926046927 deg
Orbital period (T): 90.83669828522193 min
Besides printing the orbital elements in human-readable format, gauss_method_sat prints a plot of the orbit.

If the user wants to supress the plot from the output, then the optional argument plot must be set as plot=False in the function call.
gauss_method_mpc¶
gauss_method_mpc
allows us to determine the Keplerian orbit of a Sun-orbiting body
(e.g., asteroid, comet, etc.) from a file containing right ascension and
declination (“ra/dec”, for short) observations in the Minor Planet Center (MPC)
format. MPC format for optical observations is described at
https://www.minorplanetcenter.net/iau/info/OpticalObs.html. A crucial difference
with respect to the Earth-centered orbits is that the position of the Earth with
respect to the Sun at the time of each observation must be known. For this, we
use internally the JPL DE432s ephemerides via the astropy package
(astropy.org). For this example, we
will use the text file “mpc_eros_data.txt” from the example_data folder, which
corresponds to 223 ra/dec observations of the Near-Earth asteroid Eros performed
from March through July, 2016 by various observatories around the world, and
which may be retrieved from https://www.minorplanetcenter.net/db_search.
First, we import the least_squares submodule:
from orbitdeterminator.kep_determination.gauss_method import gauss_method_mpc
Then, in the string filename we specify the path of the file where the MPC-formatted data has been stored. In the bodyname string, we type an user-defined identifier for the celestial body:
# path of file of optical MPC-formatted observations
filename = '/full/path/to/example_data/mpc_eros_data.txt'
#body name
bodyname = 'Eros'
Next, we select the observations that we will use for our computation. Our file has 223 lines, but we will select only 13 observations from that file:
#lines of observations file to be used for orbit determination
obs_arr = [1, 14, 15, 24, 32, 37, 68, 81, 122, 162, 184, 206, 223]
Remember that the Gauss method needs at least three ra/dec observations, so if selecting obs_arr consisted of more observations, then gauss_method_mpc would take consecutive triplets. In this particular case we selected 13 observations, so the Gauss method will be performed over the triplets (1, 14, 15), (14, 15, 24), etc. The resulting orbital elements correspond to an average over these triplets. Now, we are ready to call the gauss_method_mpc function:
x = gauss_method_mpc(filename, bodyname, obs_arr)
The variable x stores the set of heliocentric, ecliptic Keplerian orbital elements determined from averaging over the consecutive observation triplets as described above. The on-screen output is the following:
*** ORBIT DETERMINATION: GAUSS METHOD ***
Observational arc:
Number of observations: 13
First observation (UTC) : 2016-03-12 02:15:09.434
Last observation (UTC) : 2016-08-04 21:02:26.807
AVERAGE ORBITAL ELEMENTS (ECLIPTIC, MEAN J2000.0): a, e, taup, omega, I, Omega, T
Semi-major axis (a): 1.444355337851336 au
Eccentricity (e): 0.23095833398719623
Time of pericenter passage (tau): 2015-07-29 00:08:51.758 JDTDB
Pericenter distance (q): 1.1107694353356776 au
Apocenter distance (Q): 1.7779412403669947 au
Argument of pericenter (omega): 178.13786236175858 deg
Inclination (I): 10.857620761026277 deg
Longitude of Ascending Node (Omega): 304.14390758395615 deg
Orbital period (T): 631.7300241576686 days
Besides printing the orbital elements in human-readable format, gauss_method_mpc prints a plot of the orbit.

If the user wants to supress the plot from the output, then the optional
argument plot must be set as plot=False
in the function call.
Least squares method for ra/dec observations: Earth-centered and Sun-centered orbits¶
In the next two examples we will explain the usage of the least-squares method functions for orbit determination from topocentric ra/dec angle measurements. Currently, the implementation uses equal weights for all observations, but in the future the non-equal weights case will be handled. At the core of the implementation lies the scipy.least_squares function, which finds the set of orbital elements which best fit the observed data. As an a priori estimate for the least squares procedure, the Gauss method is used for an user-specified subset of the observations.
gauss_LS_sat¶
gauss_LS_sat
allows us to determine the Keplerian orbit of an Earth satellite from
a file containing right ascension and declination (“ra/dec”, for short)
observations in IOD format, using the least-squares method. The IOD format is
described at: http://www.satobs.org/position/IODformat.html. For this example,
we will use the file “SATOBS-ML-19200716.txt”in the example_data folder, which
corresponds to 6 ra/dec observations of the ISS performed in July 2016 by Marco
Langbroek, who originally posted these observations at the mailing list of the
satobs organization (http://www.satobs.org).:
from orbitdeterminator.kep_determination.least_squares import gauss_LS_sat
# body name
bodyname = 'ISS (25544)'
# path of file of ra/dec IOD-formatted observations
# the example contains tracking data for ISS (25544)
filename = '/full/path/to/example_data/SATOBS-ML-19200716.txt'
#lines of observations file to be used for preliminary orbit determination via Gauss method
obs_arr = [2, 3, 4, 5] # ML observations of ISS on 2016 Jul 19 and 20
x = gauss_LS_sat(filename, bodyname, obs_arr, gaussiters=10, plot=True)
Note that obs_arr lists the observations to be used in the preliminary orbit determination using Gauss method; whereas the least squares fit is performed against all observations in the file. The output is the following:
*** ORBIT DETERMINATION: GAUSS METHOD ***
Observational arc:
Number of observations: 4
First observation (UTC) : 2016-07-20 01:31:42.250
Last observation (UTC) : 2016-07-20 01:33:32.250
AVERAGE ORBITAL ELEMENTS (EQUATORIAL): a, e, taup, omega, I, Omega, T
Semi-major axis (a): 6512.9804097434335 km
Eccentricity (e): 0.039132413578175554
Time of pericenter passage (tau): 2016-07-20 00:48:29.890 JDUTC
Argument of pericenter (omega): 257.5949251506455 deg
Inclination (I): 51.62127229286804 deg
Longitude of Ascending Node (Omega): 253.87013190557073 deg
Orbital period (T): 87.16321085577762 min
*** ORBIT DETERMINATION: LEAST-SQUARES FIT ***
INFO: scipy.optimize.least_squares exited with code 3
`xtol` termination condition is satisfied.
Total residual evaluated at averaged Gauss solution: 0.0011870173725309226
Total residual evaluated at least-squares solution: 0.0001359925590954739
Observational arc:
Number of observations: 6
First observation (UTC) : 2016-07-20 01:31:32.250
Last observation (UTC) : 2016-07-20 01:33:42.250
ORBITAL ELEMENTS (EQUATORIAL): a, e, taup, omega, I, Omega, T
Semi-major axis (a): 6611.04596268806 km
Eccentricity (e): 0.023767719808264066
Time of pericenter passage (tau): 2016-07-20 00:48:29.394 JDUTC
Argument of pericenter (omega): 261.3870956809373 deg
Inclination (I): 51.60163313538592 deg
Longitude of Ascending Node (Omega): 253.78319395213362 deg
Orbital period (T): 89.15896487460995 min


The plots may be supressed from the output via the optional argument plot=False, whose default value is set to True.
gauss_LS_mpc¶
gauss_LS_mpc
allows us to determine the Keplerian orbit of a Sun-orbiting body
(e.g., asteroid, comet, etc.) from a file containing right ascension and
declination (“ra/dec”, for short) observations in the Minor Planet Center (MPC)
format. MPC format for optical observations is described at
https://www.minorplanetcenter.net/iau/info/OpticalObs.html. A crucial difference
with respect to the Earth-centered orbits is that the position of the Earth with
respect to the Sun at the time of each observation must be known. For this, we
use internally the JPL DE432s ephemerides via the astropy package
(astropy.org). For this example, we
will use the text file “mpc_eros_data.txt” from the example_data folder, which
corresponds to 223 ra/dec observations of the Near-Earth asteroid Eros performed
from March through July, 2016 by various observatories around the world, and
which may be retrieved from https://www.minorplanetcenter.net/db_search.
from orbitdeterminator.kep_determination.least_squares import gauss_LS_mpc
# body name
bodyname = 'ISS (25544)'
# path of file of ra/dec IOD-formatted observations
# the example contains tracking data for ISS (25544)
filename = '/full/path/to/example_data/SATOBS-ML-19200716.txt'
#lines of observations file to be used for preliminary orbit determination via Gauss method
obs_arr = [2, 3, 4, 5] # ML observations of ISS on 2016 Jul 19 and 20
x = gauss_LS_mpc(filename, bodyname, obs_arr, gaussiters=10, plot=True)
Note that obs_arr lists the observations to be used in the preliminary orbit determination using Gauss method; whereas the least squares fit is performed against all observations in the file. The output is the following:
*** ORBIT DETERMINATION: GAUSS METHOD ***
Observational arc:
Number of observations: 13
First observation (UTC) : 2016-03-12 02:15:09.434
Last observation (UTC) : 2016-08-04 21:02:26.807
AVERAGE ORBITAL ELEMENTS (ECLIPTIC, MEAN J2000.0): a, e, taup, omega, I, Omega, T
Semi-major axis (a): 1.4480735104613598 au
Eccentricity (e): 0.22819064873287978
Time of pericenter passage (tau): 2015-07-28 15:54:50.410 JDTDB
Pericenter distance (q): 1.1176366766962835 au
Apocenter distance (Q): 1.778510344226436 au
Argument of pericenter (omega): 178.3972723754007 deg
Inclination (I): 10.839923364302797 deg
Longitude of Ascending Node (Omega): 304.2038071213996 deg
Orbital period (T): 635.5354281199104 days
*** ORBIT DETERMINATION: LEAST-SQUARES FIT ***
INFO: scipy.optimize.least_squares exited with code 3
`xtol` termination condition is satisfied.
Total residual evaluated at averaged Gauss solution: 2.0733339155943096e-05
Total residual evaluated at least-squares solution: 5.317059382557655e-08
Observational arc:
Number of observations: 223
First observation (UTC) : 2016-03-12 02:15:09.434
Last observation (UTC) : 2016-08-04 21:02:26.807
ORBITAL ELEMENTS (ECLIPTIC, MEAN J2000.0): a, e, taup, omega, I, Omega, T
Semi-major axis (a): 1.4580878512138113 au
Eccentricity (e): 0.22251573305525377
Time of pericenter passage (tau): 2015-07-26 14:45:43.817 JDTDB
Pericenter distance (q): 1.1336403641420103 au
Apocenter distance (Q): 1.7825353382856124 au
Argument of pericenter (omega): 178.79580475222656 deg
Inclination (I): 10.828740077068593 deg
Longitude of Ascending Node (Omega): 304.3310255890526 deg
Orbital period (T): 643.0932691074535 days


The plots may be supressed from the output via the optional argument plot=False, whose default value is set to True.