Processing math: 100%

Procedures

ProcedureLocationProcedure TypeDescription
angle_between_vectors vector_module Function

The angle between two vectors (in radians).

axis_angle_rotation vector_module Subroutine

Rotate a 3x1 vector in space, given an axis and angle of rotation.

Read more…
axis_angle_rotation_to_rotation_matrix vector_module Subroutine

Computes the rotation matrix that corresponds to a rotation about the axis k by an angle theta.

balanc eispack_module Subroutine

Balance a real general matrix and isolate eigenvalues whenever possible.

Read more…
balbak eispack_module Subroutine

Form the eigenvectors of a real general matrix from the eigenvectors of matrix output from BALANC.

Read more…
barker kepler_module Function

Barker time of flight equation

base_class_equal base_class_module Function

== operator for base_class variables. To be equal, they must be the same type and have the same ID.

base_class_not_equal base_class_module Function

/= operator for base_class variables. To be equal, they must be the same type and have the same ID.

bisection_special_2 geodesy_module Subroutine
bisection_special_3 geodesy_module Subroutine
box_product vector_module Function

Computes the box product (scalar triple product) of the three vectors.

bplane bplane_module Subroutine

Compute B-plane parameters from position and velocity.

Read more…
bplane_test bplane_module Subroutine

Unit test for bplane_module.

brent_test brent_module Subroutine

Test of the fmin and zeroin functions.

c_ptr_to_f_string c_interface_module Subroutine

Convert a c_ptr to a string into a Fortran string.

calcelements standish_module Subroutine

Calculate current elements z(jd) for planet j from jpl data

calculate_bplane_data bplane_module Subroutine

Compute B-plane parameters from position and velocity -- alternate version.

Read more…
calendar_date_realsec time_module Subroutine

Returns the year, month, day, hr, min, sec for the specified Julian date.

Read more…
cartesian_to_equinoctial modified_equinoctial_module Subroutine

Convert Cartesian coordinates to modified equinoctial elements (posigrade formulation).

cartesian_to_geodetic_triaxial geodesy_module Subroutine

Function computes the geodetic latitude (phi), longitude (lambda) and height (h) of a point related to an ellipsoid defined by its three semiaxes ax, ay and b (0 < b <= ay <= ax) given Cartesian coordinates Xi, Yi, Zi and tolerance (tol). Latitude and longitude are returned in radians.

Read more…
cartesian_to_geodetic_triaxial_2 geodesy_module Subroutine

Cartesian to geodetic for Triaxial Ellipsoid.

Read more…
cartesian_to_spherical vector_module Subroutine

Convert Cartesian (x,y,z) to spherical (r,alpha,beta).

CartesianIntoGeodeticI geodesy_module Subroutine

Cartesian to Geodetic I

Read more…
CartesianIntoGeodeticII geodesy_module Subroutine

Cartesian into Geodetic II

Read more…
cdiv eispack_module Subroutine

Compute the complex quotient of two complex numbers.

Read more…
central_diff complex_step_module Subroutine

Compute the first derivative using a 2-point central difference [-h,h].

central_diff_4 complex_step_module Subroutine

Compute the first derivative using a 4-point central difference [-2h,-h,h,2h].

close_ephemeris jpl_ephemeris_module Subroutine

Close the ephemeris.

close_spice_ephemeris spice_ephemeris_module Subroutine

Close the SPICE ephemeris and unload all the kernels.

complex_step_derivative complex_step_module Subroutine

Compute the first derivative using the complex-step method. This is Equation 6 from Reference [1].

complex_step_test complex_step_module Subroutine

Unit test for the complex_step module.

compute_crtpb_parameter crtbp_module Function

Compute μ, the normalized CRTBP parameter. It is equal to M2/(M1+M2).

Read more…
compute_eigenvalues_and_eigenvectors eispack_module Subroutine

Compute the eigenvalues and, optionally, the eigenvectors of a real general matrix.

Read more…
compute_gravity_acceleration_kuga_carrara geopotential_module Subroutine

Wrapper for Kuga/Carrara method.

Read more…
compute_gravity_acceleration_lear geopotential_module Subroutine

Wrapper for Lear method.

compute_gravity_acceleration_mueller geopotential_module Subroutine

Wrapper for Mueller method.

compute_gravity_acceleration_normalized_pines geopotential_module Subroutine

Wrapper for normalized Pines method.

compute_gravity_acceleration_pines geopotential_module Subroutine

Wrapper for Pines method.

compute_halo_monodromy_matrix halo_orbit_module Subroutine

Compute the halo orbit monodromy matrix (which is the state transition matrix propagated for one period) The input should be the result from the halo_to_rv_diffcorr routine.

compute_jacobi_constant crtbp_module Function

Compute the CRTBP Jacobi constant, given the state.

compute_libration_points crtbp_module Subroutine

Compute the coordinates of the libration points (L1,L2,L3,L4,L5). L1-L3 are computed using Newton's method. L4-L5 are known analytically.

Read more…
compute_libration_points_v2 crtbp_module Subroutine

Compute the coordinates of the libration points (L1,L2,L3,L4,L5).

Read more…
compute_monodromy_matrix_eigenvalues halo_orbit_module Subroutine

Compute the eigenvalues of the monodromy matrix.

Read more…
compute_real_eigenvalues_and_normalized_eigenvectors eispack_module Subroutine

Returns only the real eigenvalues and the associated eigenvectors. Wrapper for compute_eigenvalues_and_eigenvectors.

compute_stepsize rk_module_variable_step Subroutine

Compute the new step size using the specific method.

compute_vinf_vectors bplane_module Subroutine

Compute the incoming and/or outgoing v-infinity vectors, given the position and velocity of a hyperbola.

Read more…
convert geopotential_module Subroutine

Based on the CONVERT subroutine from [1]. Unnormalizes the C,S coefficients.

Read more…
cross vector_module Function

Cross product of two 3x1 vectors

cross_matrix vector_module Function

Computes the cross product matrix, where: cross(a,b) == matmul(cross_matrix(a),b)

crtbp_derivs crtbp_module Subroutine

CRTBP derivatives: state only.

crtbp_derivs_with_stm crtbp_module Subroutine

CRTBP derivatives: state + state transition matrix.

crtbp_test crtbp_module Subroutine

Unit tests for CRTBP routines.

cube_root math_module Function

Cube root of a number (real solution only).

cw_equations relative_motion_module Function

Clohessy-Wiltshire equations for relative motion.

Read more…
cw_propagator relative_motion_module Subroutine

Clohessy-Wiltshire propagation routine.

Read more…
d_kepde kepler_module Function

Derivative of kepde w.r.t de.

d_kepdh kepler_module Function

Derivative of kepdh w.r.t dh.

d_kepds kepler_module Function
d_kepe kepler_module Function

Derivative of kepe w.r.t. e

dcbsol gooding_module Function

Solution to a*x**3 + 3*b*x - 2c = 0, where a and b**3 + a*c**2 are both non-negative (zero generated, in lieu of infinity, if a = b = 0)

dcubrt gooding_module Function

Cube root computed accurately, by incorporating one Newton-Raphson iteration.

deriv_func rk_module Interface
destroy rk_module_variable_step Subroutine

Destructor for rk_variable_step_class.

destroy rk_module Subroutine

Destructor for rk_class.

destroy_geopotential_model c_interface_module Subroutine

This is just a wapper for destroy in geopotential_model.

Read more…
destroy_geopotential_model geopotential_module Subroutine

Destroy a gravity model.

destroy_stepsize_class rk_module_variable_step Subroutine

Destructor for stepsize_class.

direct geodesy_module Subroutine

Solve the "direct" geodetic problem: given the latitude and longitude of one point and the azimuth and distance to a second point, determine the latitude and longitude of that second point. The solution is obtained using the algorithm by Vincenty.

Read more…
direct_inverse_test geodesy_module Subroutine

Unit test for the direct and inverse geodetic routines.

distance_from_point_to_line geometry_module Function

Compute the distance between the point X and the line defined by the two points X1 and X2.

Read more…
distance_from_point_to_line_segment geometry_module Function

Compute the distance between a line segment and a point.

Read more…
distance_from_point_to_path geometry_module Function

Compute the distance between a point and a polygonal path. Given a point (x0,y0), and a path (x(n),y(n)), the distance to the path is the distance to the closest line segment (x(i),y(i)).

dogleg minpack_module Subroutine

given an m by n matrix a, an n by n nonsingular diagonal matrix d, an m-vector b, and a positive number delta, the problem is to determine the convex combination x of the gauss-newton and scaled gradient directions that minimizes (ax - b) in the least squares sense, subject to the restriction that the euclidean norm of dx be at most delta.

Read more…
dpmpar minpack_module Function

Replacement for the original Minpack routine.

drag_acceleration drag_module Subroutine

Acceleration due to atmospheric drag.

ec2eq standish_module Subroutine

converts cartesian heliocentric j2000 ecliptic to equatorial

ecliptic_frame transformation_module Interface
ecliptic_frame_constructor transformation_module Function

Constructor for a ecliptic_frame

Read more…
eispack_test eispack_module Subroutine

Unit test

ekepl gooding_module Function

Kepler's equation, em = ekepl - (1 - e1)*sin(ekepl), with e1 in range 1 to 0 inclusive, solved accurately (based on ekepl3, but entering e1, not e)

ekepl1 gooding_module Function

Solve kepler's equation, em = ekepl - e*sin(ekepl), with legendre-based starter and halley iterator (function has also been used under the name eafkep)

ekepl2 gooding_module Function

Kepler's equation, em = ekepl - e*sin(ekepl) with e in range 0 to 1 inclusive, solved accurately

el2op standish_module Subroutine

heliocentric coordinates for orbital plane from elements

elmhes eispack_module Subroutine

Reduce a real general matrix to upper Hessenberg form using stabilized elementary similarity transformations.

Read more…
els2pv gooding_module Subroutine

Algorithm for two-dimensional conversion from orbital elements to position and velocity.

els3pv gooding_module Subroutine

Algorithm for three-dimensional conversion from orbital elements to position and velocity

eltran eispack_module Subroutine

Accumulates the stabilized elementary similarity transformations used in the reduction of a real general matrix to upper Hessenberg form by ELMHES.

Read more…
emkep gooding_module Function

Similar to emkepl, except input is 1-e.

emkepl gooding_module Function

Accurate computation of ee - e*sin(ee) when (e, ee) is close to (1, 0)

Read more…
enorm minpack_module Function

given an n-vector x, this function calculates the euclidean norm of x.

Read more…
ephemeris_test jpl_ephemeris_module Subroutine

Ephemeris test routine.

Read more…
eq2ec standish_module Subroutine

converts cartesian heliocentric equatorial to ecliptic

equatorial_to_mean_ecliptic_rotmat obliquity_module Function

Rotation matrix from J2000 to Mean Ecliptic.

equinoctial_to_cartesian modified_equinoctial_module Subroutine

Convert modified equinoctial elements (posigrade formulation) to Cartesian coordinates.

et_to_jd time_module Function

Convert ephemeris time (seconds from J2000 epoch) to Julian date.

event_func rk_module Interface
extract_scalar_from_vector vector_module Subroutine

Extract the value from the vector and update the index

extract_vector vector_module Interface
extract_vector_from_vector vector_module Subroutine

Extract a vector from the vector and update the index

f_string_to_c_ptr c_interface_module Subroutine

Convert a Fortran string to a c_ptr to a string. (the C string must already have been allocated to a fixed size)

failed spice_ephemeris_module Interface
fdjac1 minpack_module Subroutine

this subroutine computes a forward-difference approximation to the n by n jacobian matrix associated with a specified problem of n functions in n variables. if the jacobian has a banded form, then function evaluations are saved by only approximating the nonzero terms.

Read more…
fill_char_vector_with_scalar vector_module Subroutine

Put the value in the vector and update the index (character version)

fill_char_vector_with_vector vector_module Subroutine

Put the vector in the vector and update the index (character version)

fill_vector vector_module Interface
fill_vector_with_scalar vector_module Subroutine

Put the value in the vector and update the index

fill_vector_with_vector vector_module Subroutine

Put the vector in the vector and update the index

FL geopotential_module Function

The FL factorial function from [1].

Read more…
fmin brent_module Function

An approximation x to the point where f attains a minimum on the interval (ax,bx) is determined.

Read more…
forward_diff complex_step_module Subroutine

Compute the first derivative using a forward difference. This is Equation 1 from Reference [1].

from_ijk_to_lvlh relative_motion_module Interface

Conversion from IJK to LVLH

from_ijk_to_lvlh_mat relative_motion_module Subroutine

Compute the transformation matrices to convert IJK to LVLH.

Read more…
from_ijk_to_lvlh_rv relative_motion_module Subroutine

Transform a position (and optionally velocity) vector from IJK to LVLH.

from_ijk_to_rsw relative_motion_module Interface

Conversion from IJK to RSW

from_ijk_to_rsw_mat relative_motion_module Subroutine

Compute the transformation matrices to convert IJK to RSW.

from_ijk_to_rsw_rv relative_motion_module Subroutine

Transform a position (and optionally velocity) vector from IJK to RSW.

from_lvlh_to_ijk relative_motion_module Interface

Conversion from LVLH to IJK

from_lvlh_to_ijk_mat relative_motion_module Subroutine

Compute the transformation matrices to convert LVLH to IJK.

Read more…
from_lvlh_to_ijk_rv relative_motion_module Subroutine

Transform a position (and optionally velocity) vector from LVLH to IJK.

from_lvlh_to_rsw relative_motion_module Interface

Conversion from LVLH to RSW

from_lvlh_to_rsw_rv relative_motion_module Subroutine

Transform a position (and optionally velocity) vector from LVLH to RSW.

from_primary_to_center transformation_module Subroutine

returns the state of the frame center w.r.t. the frame primary body.

from_rsw_to_ijk relative_motion_module Interface

Conversion from RSW to IJK

from_rsw_to_ijk_mat relative_motion_module Subroutine

Compute the transformation matrices to convert RSW to IJK.

from_rsw_to_ijk_rv relative_motion_module Subroutine

Transform a position (and optionally velocity) vector from RSW to IJK.

from_rsw_to_lvlh relative_motion_module Interface

Conversion from RSW to LVLH

from_rsw_to_lvlh_rv relative_motion_module Subroutine

Transform a position (and optionally velocity) vector from RSW to LVLH.

func complex_step_module Interface
furnsh spice_ephemeris_module Interface
geocentric_radius geodesy_module Function

The distance from the center of a celestial body (e.g., the Earth) to a point on the spheroid surface at a specified geodetic latitude.

Read more…
geodetic_to_cartesian geodesy_module Subroutine

Geodetic latitude, longitude, and height to Cartesian position vector.

Read more…
geodetic_to_cartesian_triaxial geodesy_module Subroutine

Function computes the Cartesian coordinates given the geodetic latitude (phi), longitude (lambda) and height (h) of a point related to an ellipsoid defined by its three semiaxes ax, ay and b

Read more…
geodetic_to_cartesian_triaxial_2 geodesy_module Subroutine

Geodetic to Cartesian for Triaxial Ellipsoid.

Read more…
geometry_unit_test geometry_module Subroutine

Unit test routine

Read more…
geopot geopotential_module Subroutine

Compute the gravitational acceleration vector using the Mueller method.

Read more…
geopotential_module_test geopotential_module Subroutine

Unit test routine for geopotential_module

get_acceleration c_interface_module Subroutine

This is just a wapper for get_acc in geopotential_model.

Read more…
get_c_cdot_ecliptic transformation_module Subroutine

rotation matrix for ICRF <-> Mean Ecliptic

get_c_cdot_iau_earth transformation_module Subroutine

rotation matrix for IAU_EARTH <-> ICRF

get_c_cdot_iau_moon transformation_module Subroutine

rotation matrix for IAU_MOON <-> ICRF

get_c_cdot_icrf transformation_module Subroutine

rotation matrix for ICRF <-> ICRF

get_c_cdot_two_body_rotating transformation_module Subroutine

rotation matrix for ROTATING <-> ICRF

get_c_cdot_two_body_rotating_pulsating transformation_module Subroutine

rotation matrix for ROTATING_PULSATING <-> ICRF

get_constants jpl_ephemeris_module Subroutine

Obtain the constants from the ephemeris file.

get_format_statement geopotential_module Subroutine

Returns the format statement from a line in a .GEO gravity coefficient file.

get_random_number random_module Function

Returns a uniform random number x, such that: a <= x < b.

get_rv_from_jpl_ephemeris jpl_ephemeris_module Subroutine

Interface for the ephemeris_module.

get_rv_from_spice_ephemeris spice_ephemeris_module Subroutine

Interface for the ephemeris_module.

Read more…
get_state jpl_ephemeris_module Subroutine

This subroutine reads the JPL planetary ephemeris and gives the position and velocity of the point ntarg with respect to ncent.

Read more…
grav geopotential_module Subroutine

Based on the GRAV subroutine from [1].

Read more…
gravity_j2_j3_j4 gravity_module Subroutine

Gravitational acceleration due to simplified spherical harmonic expansion (only the J2-J4 terms are used).

Read more…
gravpot geopotential_module Subroutine

Spencer's implementation of the Pines algorithms from [1]

Read more…
great_circle_distance geodesy_module Function

Great circle distance on a spherical body, using the Vincenty algorithm.

Read more…
halo_orbit_test halo_orbit_module Subroutine

Unit test for the halo orbit module.

halo_to_rv halo_orbit_module Subroutine

Compute the state vector from the halo orbit approximation. This will be an approximation of a halo orbit in the CR3BP system, and will need to be corrected to produce a real halo orbit.

halo_to_rv_diffcorr halo_orbit_module Subroutine

Compute the state vector for a halo orbit. This uses the approximation, which is retargeted in the real CR3BP system to produce a periodic orbit.

Read more…
heikkinen geodesy_module Subroutine

Heikkinen routine for cartesian to geodetic transformation

Read more…
helio standish_module Subroutine

For planet np and julian date jd and using using table itbl, return j2000 ecliptic position (au) and velocity (au/yr). in cartesian coordinates (p(1)-p(6)).

hinit rk_module_variable_step Function

computation of an initial step size guess

Read more…
horner geodesy_module Subroutine

Horner's method to compute B(x-c) in terms of B(x).

hqr eispack_module Subroutine

Compute the eigenvalues of a real upper Hessenberg matrix using the QR method.

Read more…
hqr2 eispack_module Subroutine

Compute the eigenvalues and eigenvectors of a real upper Hessenberg matrix using QR method.

Read more…
hstart rk_module_variable_step Subroutine

Computes a starting step size to be used in solving initial value problems in ordinary differential equations.

Read more…
hybrd minpack_module Subroutine

The purpose of hybrd is to find a zero of a system of n nonlinear functions in n variables by a modification of the powell hybrid method. the user must provide a subroutine which calculates the functions. the jacobian is then calculated by a forward-difference approximation.

Read more…
hybrd1 minpack_module Subroutine

the purpose of hybrd1 is to find a zero of a system of n nonlinear functions in n variables by a modification of the powell hybrid method. this is done by using the more general nonlinear equation solver hybrd. the user must provide a subroutine which calculates the functions. the jacobian is then calculated by a forward-difference approximation.

hybrj minpack_module Subroutine

the purpose of hybrj is to find a zero of a system of n nonlinear functions in n variables by a modification of the powell hybrid method. the user must provide a subroutine which calculates the functions and the jacobian.

Read more…
hybrj1 minpack_module Subroutine

the purpose of hybrj1 is to find a zero of a system of n nonlinear functions in n variables by a modification of the powell hybrid method. this is done by using the more general nonlinear equation solver hybrj. the user must provide a subroutine which calculates the functions and the jacobian.

Read more…
hyperbolic_turning_angle bplane_module Function

Compute the hyperbolic turning angle from the eccentricity.

iau_earth_rotating_frame transformation_module Interface
iau_earth_rotating_frame_constructor transformation_module Function

Constructor for a iau_earth_rotating_frame

iau_moon_rotating_frame transformation_module Interface
iau_moon_rotating_frame_constructor transformation_module Function

Constructor for a iau_moon_rotating_frame

iau_rotation_matrix iau_orientation_module Function

Returns the rotation matrix for a coordinate transformation from the International Celestial Reference Frame (ICRF) frame to the IAU rotating frame associated with a body. The IAU orientation models use three Euler angles to describe the pole and prime meridian location (ra, dec, and w).

iau_test iau_orientation_module Subroutine

Unit test routine for iau_module.

icrf_frame transformation_module Interface
icrf_frame_constructor transformation_module Function

Constructor for a icrf_frame

Read more…
icrf_to_iau_earth iau_orientation_module Function

Rotation matrix from ICRF to IAU_EARTH.

icrf_to_iau_moon iau_orientation_module Function

Rotation matrix from ICRF to IAU_MOON.

initialize rk_module_variable_step Subroutine

Initialize the rk_variable_step_class.

initialize rk_module Subroutine

Initialize the rk_class.

initialize_ephemeris jpl_ephemeris_module Subroutine

Initialize the ephemeris. This routine may be called to load a different ephemeris file. Otherwise, it is called on the first call to get_state, and loads the file specified in the module header.

Read more…
initialize_geopotential_model c_interface_module Function

This is just a wapper for initialize in geopotential_model.

Read more…
initialize_spice_ephemeris spice_ephemeris_module Subroutine

Initialize a SPICE ephemeris by loading the specified kernels.

integrate rk_module_variable_step Subroutine

Main integration routine for the rk_variable_step_class.

integrate rk_module Subroutine

Main integration routine for the rk_class.

integrate_to_event rk_module_variable_step Subroutine

Event-finding integration routine for the rk_variable_step_class. Integrates until g(t,x)=0, or until t=tf (whichever happens first).

Read more…
integrate_to_event rk_module Subroutine

Event-finding integration routine for the rk_class. Integrates until g(t,x)=0, or until t=tf (whichever happens first).

Read more…
interp jpl_ephemeris_module Subroutine

this subroutine differentiates and interpolates a set of chebyshev coefficients to give position and velocity.

inverse geodesy_module Subroutine

INVERSE computes the geodetic azimuth and distance between two points, given their geographic positions.

Read more…
jd_to_et time_module Function

Convert Julian date to ephemeris time (seconds from J2000 epoch).

jd_to_mjd time_module Function

Converts Julian date to Modified Julian date.

Read more…
julian_date time_module Interface

calendar date to julian date

julian_date_intsec time_module Function

Returns the Julian date for the specified YEAR, MONTH, DAY, HR, MIN, SEC.

Read more…
julian_date_realsec time_module Function

Returns the Julian date for the specified YEAR, MONTH, DAY, HR, MIN, SEC.

Read more…
julian_date_to_calendar_date time_module Interface
julian_day time_module Function

Returns the Julian day number (i.e., the Julian date at Greenwich noon) on the specified YEAR, MONTH, and DAY.

Read more…
kclear spice_ephemeris_module Interface
kepde kepler_module Function

Elliptic Kepler's equation written in terms of the eccentric anomaly difference. See Battin, eqn 4.43.

kepdh kepler_module Function

Battin, eqn. 4.64.

kepds kepler_module Function
kepe kepler_module Function

Elliptic Kepler's equation

kepler standish_module Function

solve kepler's equation ma = ea + ec*sin(ea)

kepler_classical kepler_module Subroutine

Classical Kepler propagator for elliptical and hyperbolic orbits. Uses Lagrange formulations from Battin & Newton's method.

Read more…
kepler_goodyear_stienon_klumpp kepler_module Subroutine

Kepler propagator based on the Goodyear code with modifications by Stienon and Klumpp.

Read more…
kepler_shepperd kepler_module Subroutine

Kepler propagation using Shepperd's method.

Read more…
kuga_carrara_geopotential geopotential_module Subroutine

Compute geopotential acceleration using the Kuga/Carrara algorithm. Based on Leg_ForCol_Ac from [1].

Read more…
lambert_test lambert_module Subroutine

Compare the Lambert routines.

locpt geometry_module Subroutine

given a polygonal line connecting the vertices (x(i),y(i)) (i = 1,...,n) taken in this order. it is assumed that the polygonal path is a loop, where (x(n),y(n)) = (x(1),y(1)) or there is an arc from (x(n),y(n)) to (x(1),y(1)).

Read more…
lowercase string_module Subroutine

Convert the string to lowercase.

magnitude math_module Function

Returns a positive number the same magnitude as the input, with only one significant digit.

Read more…
matrix_cofactor matrix_module Function

Compute the cofactors matrix (the transpose of the adjugate matrix).

Read more…
matrix_determinant matrix_module Function

Matrix determinant of an n×n matrix (recursive formulation).

Read more…
matrix_trace matrix_module Function

Compute the matrix trace (sum of the diagonal elements).

maxval_func rk_module_variable_step Function

Use maxval(abs(x)) for computing the vector norm.

mean_ecliptic_to_equatorial_rotmat obliquity_module Function

Rotation matrix from Mean Ecliptic to J2000.

Read more…
mean_obliquity_of_ecliptic_iau1980 obliquity_module Function

Mean obliquity of the ecliptic, IAU 1980 formula.

Read more…
mean_obliquity_of_ecliptic_iau2006 obliquity_module Function

Mean obliquity of the ecliptic, IAU 2006 formula.

mjd_to_jd time_module Function

Converts Modified Julian date to Julian date.

Read more…
modified_equinoctial_derivs modified_equinoctial_module Subroutine

Modified equinoctial elements (posigrade formulation) equations of motion.

modified_equinoctial_test modified_equinoctial_module Subroutine

Unit tests for the modified_equinoctial_module.

newton newton_module Subroutine

Newton's method for root finding of scalar function f(x)

norm2_func rk_module_variable_step Function

Use intrinsic norm2(x) for computing the vector norm.

normalize_variables crtbp_module Subroutine

Convert state in km, km/s units to normalized CRTBP state.

number_of_coefficients geopotential_module Function

Number of (c,s) coefficients for n x m geopotential model Starting with n=2,m=0.

olson geodesy_module Subroutine

Olson routine for cartesian to geodetic transformation.

Read more…
op2ec standish_module Subroutine

heliocentric coordinates j2000 ecliptic plane from orbital plane

orbit_check orbital_mechanics_module Subroutine

Check the orbit for singularities.

orbit_energy orbital_mechanics_module Function

Compute the two-body orbital energy.

orbit_period orbital_mechanics_module Function

Compute the two-body orbital period.

orbital_elements_to_rv orbital_mechanics_module Subroutine

Convert orbital elements to position and velocity vectors.

outer_product vector_module Function

Computes the outer product of the two vectors.

periapsis_apoapsis orbital_mechanics_module Subroutine

Compute the periapsis and apoapsis position and velocity magnitudes.

philambda_quadrant geodesy_module Subroutine
pinesnorm geopotential_module Function

Normalized Pines geopotential code.

Read more…
print_matrix matrix_module Subroutine

Print a matrix to the console.

propagate gooding_module Subroutine

Basic two-body propagator using the Gooding universal element routines.

pv2els gooding_module Subroutine

Algorithm for two-dimensional conversion from position and velocity to orbital elements.

pv3els gooding_module Subroutine

Algorithm for three-dimensional conversion from position and velocity to orbital elements.

qform minpack_module Subroutine

this subroutine proceeds from the computed qr factorization of an m by n matrix a to accumulate the m by m orthogonal matrix q from its factored form.

Read more…
qrfac minpack_module Subroutine

this subroutine uses householder transformations with column pivoting (optional) to compute a qr factorization of the m by n matrix a. that is, qrfac determines an orthogonal matrix q, a permutation matrix p, and an upper trapezoidal matrix r with diagonal elements of nonincreasing magnitude, such that ap = qr. the householder transformation for column k, k = 1,2,...,min(m,n), is of the form

Read more…
r1mpyq minpack_module Subroutine

given an m by n matrix a, this subroutine computes aq where q is the product of 2(n - 1) transformations

Read more…
r1updt minpack_module Subroutine

given an m by n lower trapezoidal matrix s, an m-vector u, and an n-vector v, the problem is to determine an orthogonal matrix q such that

Read more…
read_geopotential_file geopotential_module Subroutine

Read the gravity coefficient file. Example file: ftp://ftp.csr.utexas.edu/pub/grav/EGM96.GEO.Z

relative_motion_test relative_motion_module Subroutine

Unit tests for the relative_motion_module.

report_func rk_module Interface
return_a_string c_interface_module Subroutine

Just a test of f_string_to_c_ptr.

rg eispack_module Subroutine

Compute the eigenvalues and, optionally, the eigenvectors of a real general matrix.

Read more…
rk4 rk_module Subroutine

Take one Runge Kutta 4 integration step: t -> t+h (x -> xf)

rk8_10 rk_module Subroutine

Take one Runge Kutta 8 integration step: t -> t+h (x -> xf) This is Formula (8-10) from Reference [1].

Read more…
rk_test rk_module Subroutine

Unit test of the rk_module. Integrate a two-body orbit around the Earth.

rk_test_variable_step rk_module_variable_step Subroutine

Unit test of the rk_module. Integrate a two-body orbit around the Earth.

rkf108 rk_module_variable_step Subroutine

Feagin's RK8(10) method -- a 10th-order method with an embedded 8th-order method.

Read more…
rkf108_order rk_module_variable_step Function

Returns the order of the rkf108 method.

rkf1210 rk_module_variable_step Subroutine

Feagin's RK12(10) method -- a 12th-order method with an embedded 10th-order method.

Read more…
rkf1210_order rk_module_variable_step Function

Returns the order of the rkf1210 method.

rkf1412 rk_module_variable_step Subroutine

Feagin's RK14(12) - a 14th-order method with an embedded 12th-order method.

Read more…
rkf1412_order rk_module_variable_step Function

Returns the order of the rkf1412 method.

rkf78 rk_module_variable_step Subroutine

Fehlberg's 7(8) algorithm.

Read more…
rkf78_order rk_module_variable_step Function

Returns the order of the rkf78 method.

rkf89 rk_module_variable_step Subroutine

Fehlberg 8(9) method.

Read more…
rkf89_order rk_module_variable_step Function

Returns the order of the rkf89 method.

rkv89 rk_module_variable_step Subroutine

Runge Kutta Verner 8(9)

Read more…
rkv89_order rk_module_variable_step Function

Returns the order of the rkv89 method.

rotation_matrix vector_module Function

The 3x3 rotation matrix for a rotation about the x, y, or z-axis.

Read more…
rotation_matrix_dot vector_module Function

Time derivative of the 3x3 rotation matrix for a rotation about the x, y, or z-axis.

rv_to_orbital_elements orbital_mechanics_module Subroutine

Convert position and velocity vectors to orbital elements.

Read more…
rvcto_rvcfrom_icrf transformation_module Subroutine

Returns the state of the from frame center w.r.t. the to frame center, at the specified ephemeris time et.

set_function brent_module Subroutine

Set the function to be minimized.

shkepl gooding_module Function

Equation el = shkepl + (g1 - 1)*asinh(shkepl), with g1 in range 0 to 1 inclusive, solved accurately.

shmkep gooding_module Function

Accurate computation of s - (1 - g1)*asinh(s) when (g1, s) is close to (0, 0)

simpson_lunar_ephemeris analytical_ephemeris_module Subroutine

A simple analytical lunar ephemeris model. Returns Lunar cartesian coordinates (mean equator and equinox of epoch J2000).

Read more…
solve_lambert_arorarussell lambert_module Subroutine

Solve Lambert's problem using the Arora/Russell method.

Read more…
solve_lambert_gooding lambert_module Subroutine

Solve Lambert's problem using Gooding's method.

Read more…
solve_lambert_izzo lambert_module Subroutine

Solve Lambert's problem using Izzo's method.

Read more…
solve_polynomial geodesy_module Function

Numerical solution to polynomial equation using Newton-Raphson method

special_cases geodesy_module Subroutine

Special cases for lat/lon/altitude

sphere standish_module Subroutine

cartesian to spherical coordinates (angles in radians)

sphere_of_influence orbital_mechanics_module Function

Computes the sphere-of-influence radius of the secondary body.

Read more…
sphere_of_influence_earth_moon orbital_mechanics_module Function

Computes the sphere-of-influence radius of the secondary body.

Read more…
spherical_to_cartesian vector_module Function

Convert spherical (r,alpha,beta) to Cartesian (x,y,z).

spice_id_to_old_id jpl_ephemeris_module Function

Convert the NAIF SPICE ID code to the old one used by the JPL ephemeris. Returns 0 if the body was not found.

spice_id_to_standish_id standish_module Function

Convert the NAIF SPICE ID code to the one used by the standish ephemeris. Returns 0 if the body was not found.

Read more…
spkgeo spice_ephemeris_module Interface
split jpl_ephemeris_module Subroutine

this subroutine breaks a d.p. number into a d.p. integer and a d.p. fractional part.

standish_module_test standish_module Subroutine

Test routine for the standish_module routines.

standish_rv_func standish_module Subroutine

Return the state of the targ body relative to the obs body, in the inertial frame [ICRF].

Read more…
state jpl_ephemeris_module Subroutine

This subroutine reads and interpolates the JPL planetary ephemeris file.

Read more…
step_func rk_module Interface
step_size_test rk_module_variable_step Subroutine

Unit tests for step size adjustment routines.

stepsize_class_constructor rk_module_variable_step Subroutine

Constructor for a stepsize_class.

Read more…
strlen c_interface_module Interface
stumpff_c kepler_module Function

Stumpff function C(z)

stumpff_s kepler_module Function

Stumpff function S(z)

tbl standish_module Function

Determine which data set to use for highest accuracy for the given julian date.

Read more…
third_body_gravity gravity_module Subroutine

Third-body (pointmass) gravitational acceleration.

time_module_test time_module Subroutine

Test routine for the Julian date routines.

transform transformation_module Subroutine

Transform a Cartesian state from one reference frame to another at a specified epoch. The from and to reference_frames may each be defined at a different epoch. The et ephemeris time is the time the transformation is to be done, and accounts for the motion of the two frame centers from from%et and to%et to et.

transformation_module_test transformation_module Subroutine

Transformation units test

trcoff spice_ephemeris_module Interface
two_body_rotating_frame transformation_module Interface
two_body_rotating_frame_constructor transformation_module Function

Constructor for a two_body_rotating_frame

two_body_rotating_pulsating_frame transformation_module Interface
two_body_rotating_pulsating_frame_constructor transformation_module Function

Constructor for a two_body_rotating_pulsating_frame

ucross vector_module Function

Unit vector of the cross product of two 3x1 vectors

uhat_dot vector_module Function

Time derivative of a unit vector.

unit vector_module Function

Unit vector

unload spice_ephemeris_module Interface
unnormalize_variables crtbp_module Subroutine

Convert normalized CRTBP state to km, km/s units.

Read more…
uppercase string_module Subroutine

Convert the string to uppercase.

vector_projection vector_module Function

The projection of one vector onto another vector.

Read more…
vector_projection_on_plane vector_module Subroutine

Project a vector onto a plane.

Read more…
vector_test vector_module Subroutine

Unit test routine for the vector_module.

vinf_to_energy bplane_module Function

Convert V-infinity magnitude to energy.

wrap_angle math_module Function

Wrap an angle (in rad) from -pi to pi.

xyz2fl geodesy_module Subroutine

Computes the transformation of Cartesian to geodetic coordinates on the surface of the ellipsoid assuming x,y,z are all non-negative Angular coordinates in radians

Read more…
xyz2philambda geodesy_module Subroutine

Determination of the geodetic latitude and longitude

Read more…
zeroin brent_module Subroutine

Find a zero of the function f(x) in the given interval [ax,bx] to within a tolerance 4ϵ|x|+tol, where ϵ is the relative machine precision defined as the smallest representable number such that 1.0+ϵ>1.0.

Read more…
call~~graph~~CallGraph interface~deriv_func~2 deriv_func interface~ecliptic_frame ecliptic_frame proc~ecliptic_frame_constructor ecliptic_frame_constructor interface~ecliptic_frame->proc~ecliptic_frame_constructor interface~event_func~2 event_func interface~extract_vector extract_vector proc~extract_scalar_from_vector extract_scalar_from_vector interface~extract_vector->proc~extract_scalar_from_vector proc~extract_vector_from_vector extract_vector_from_vector interface~extract_vector->proc~extract_vector_from_vector interface~failed failed interface~fill_vector fill_vector proc~fill_char_vector_with_scalar fill_char_vector_with_scalar interface~fill_vector->proc~fill_char_vector_with_scalar proc~fill_char_vector_with_vector fill_char_vector_with_vector interface~fill_vector->proc~fill_char_vector_with_vector proc~fill_vector_with_scalar fill_vector_with_scalar interface~fill_vector->proc~fill_vector_with_scalar proc~fill_vector_with_vector fill_vector_with_vector interface~fill_vector->proc~fill_vector_with_vector interface~from_ijk_to_lvlh from_ijk_to_lvlh proc~from_ijk_to_lvlh_mat from_ijk_to_lvlh_mat interface~from_ijk_to_lvlh->proc~from_ijk_to_lvlh_mat proc~from_ijk_to_lvlh_rv from_ijk_to_lvlh_rv interface~from_ijk_to_lvlh->proc~from_ijk_to_lvlh_rv interface~from_ijk_to_rsw from_ijk_to_rsw proc~from_ijk_to_rsw_mat from_ijk_to_rsw_mat interface~from_ijk_to_rsw->proc~from_ijk_to_rsw_mat proc~from_ijk_to_rsw_rv from_ijk_to_rsw_rv interface~from_ijk_to_rsw->proc~from_ijk_to_rsw_rv interface~from_lvlh_to_ijk from_lvlh_to_ijk proc~from_lvlh_to_ijk_mat from_lvlh_to_ijk_mat interface~from_lvlh_to_ijk->proc~from_lvlh_to_ijk_mat proc~from_lvlh_to_ijk_rv from_lvlh_to_ijk_rv interface~from_lvlh_to_ijk->proc~from_lvlh_to_ijk_rv interface~from_lvlh_to_rsw from_lvlh_to_rsw proc~from_lvlh_to_rsw_rv from_lvlh_to_rsw_rv interface~from_lvlh_to_rsw->proc~from_lvlh_to_rsw_rv interface~from_rsw_to_ijk from_rsw_to_ijk proc~from_rsw_to_ijk_mat from_rsw_to_ijk_mat interface~from_rsw_to_ijk->proc~from_rsw_to_ijk_mat proc~from_rsw_to_ijk_rv from_rsw_to_ijk_rv interface~from_rsw_to_ijk->proc~from_rsw_to_ijk_rv interface~from_rsw_to_lvlh from_rsw_to_lvlh proc~from_rsw_to_lvlh_rv from_rsw_to_lvlh_rv interface~from_rsw_to_lvlh->proc~from_rsw_to_lvlh_rv interface~func func interface~furnsh furnsh interface~iau_earth_rotating_frame iau_earth_rotating_frame proc~iau_earth_rotating_frame_constructor iau_earth_rotating_frame_constructor interface~iau_earth_rotating_frame->proc~iau_earth_rotating_frame_constructor interface~iau_moon_rotating_frame iau_moon_rotating_frame proc~iau_moon_rotating_frame_constructor iau_moon_rotating_frame_constructor interface~iau_moon_rotating_frame->proc~iau_moon_rotating_frame_constructor interface~icrf_frame icrf_frame proc~icrf_frame_constructor icrf_frame_constructor interface~icrf_frame->proc~icrf_frame_constructor interface~julian_date julian_date proc~julian_date_intsec julian_date_intsec interface~julian_date->proc~julian_date_intsec proc~julian_date_realsec julian_date_realsec interface~julian_date->proc~julian_date_realsec interface~julian_date_to_calendar_date julian_date_to_calendar_date proc~calendar_date_realsec calendar_date_realsec interface~julian_date_to_calendar_date->proc~calendar_date_realsec interface~kclear kclear interface~report_func~3 report_func interface~spkgeo spkgeo interface~step_func~2 step_func interface~strlen strlen interface~trcoff trcoff interface~two_body_rotating_frame two_body_rotating_frame proc~two_body_rotating_frame_constructor two_body_rotating_frame_constructor interface~two_body_rotating_frame->proc~two_body_rotating_frame_constructor interface~two_body_rotating_pulsating_frame two_body_rotating_pulsating_frame proc~two_body_rotating_pulsating_frame_constructor two_body_rotating_pulsating_frame_constructor interface~two_body_rotating_pulsating_frame->proc~two_body_rotating_pulsating_frame_constructor interface~unload unload none~operator(==) base_class%operator(==) proc~base_class_equal base_class%base_class_equal none~operator(==)->proc~base_class_equal none~operator(==)~2 ephem%operator(==) none~operator(==)~2->proc~base_class_equal none~operator(==)~3 celestial_body%operator(==) none~operator(==)~3->proc~base_class_equal none~operator(SLASH=) base_class%operator(/=) proc~base_class_not_equal base_class%base_class_not_equal none~operator(SLASH=)->proc~base_class_not_equal none~operator(SLASH=)~2 ephem%operator(/=) none~operator(SLASH=)~2->proc~base_class_not_equal none~operator(SLASH=)~3 celestial_body%operator(/=) none~operator(SLASH=)~3->proc~base_class_not_equal proc~angle_between_vectors angle_between_vectors proc~cross cross proc~angle_between_vectors->proc~cross proc~axis_angle_rotation axis_angle_rotation proc~axis_angle_rotation->proc~cross proc~unit unit proc~axis_angle_rotation->proc~unit proc~axis_angle_rotation_to_rotation_matrix axis_angle_rotation_to_rotation_matrix proc~cross_matrix cross_matrix proc~axis_angle_rotation_to_rotation_matrix->proc~cross_matrix proc~axis_angle_rotation_to_rotation_matrix->proc~unit proc~balanc balanc proc~balbak balbak proc~barker barker proc~bisection_special_2 bisection_special_2 proc~bisection_special_3 bisection_special_3 proc~box_product box_product proc~box_product->proc~cross proc~bplane bplane proc~bplane->proc~cross proc~ucross ucross proc~bplane->proc~ucross proc~bplane->proc~unit proc~bplane_test bplane_test proc~bplane_test->proc~bplane proc~calculate_bplane_data calculate_bplane_data proc~bplane_test->proc~calculate_bplane_data proc~compute_vinf_vectors compute_vinf_vectors proc~bplane_test->proc~compute_vinf_vectors proc~brent_test brent_test proc~fmin brent_class%fmin proc~brent_test->proc~fmin proc~set_function brent_class%set_function proc~brent_test->proc~set_function proc~zeroin brent_class%zeroin proc~brent_test->proc~zeroin proc~c_ptr_to_f_string c_ptr_to_f_string proc~c_ptr_to_f_string->interface~strlen s s proc~c_ptr_to_f_string->s proc~calcelements calcelements proc~kepler kepler proc~calcelements->proc~kepler proc~calculate_bplane_data->proc~cross proc~calculate_bplane_data->proc~unit proc~cartesian_to_equinoctial cartesian_to_equinoctial proc~cartesian_to_equinoctial->proc~cross proc~cartesian_to_equinoctial->proc~unit proc~cartesian_to_geodetic_triaxial cartesian_to_geodetic_triaxial proc~cartesian_to_geodetic_triaxial->proc~bisection_special_2 proc~cartesian_to_geodetic_triaxial->proc~bisection_special_3 proc~philambda_quadrant philambda_quadrant proc~cartesian_to_geodetic_triaxial->proc~philambda_quadrant proc~xyz2fl xyz2fl proc~cartesian_to_geodetic_triaxial->proc~xyz2fl proc~xyz2philambda xyz2philambda proc~cartesian_to_geodetic_triaxial->proc~xyz2philambda proc~cartesian_to_geodetic_triaxial_2 cartesian_to_geodetic_triaxial_2 proc~special_cases special_cases proc~cartesian_to_geodetic_triaxial_2->proc~special_cases proc~cartesian_to_spherical cartesian_to_spherical proc~cartesianintogeodetici CartesianIntoGeodeticI proc~horner horner proc~cartesianintogeodetici->proc~horner proc~cartesianintogeodetici->proc~philambda_quadrant proc~solve_polynomial solve_polynomial proc~cartesianintogeodetici->proc~solve_polynomial proc~cartesianintogeodetici->proc~special_cases proc~cartesianintogeodeticii CartesianIntoGeodeticII proc~cartesianintogeodeticii->proc~philambda_quadrant proc~cartesianintogeodeticii->proc~solve_polynomial proc~cartesianintogeodeticii->proc~special_cases proc~cdiv cdiv proc~central_diff central_diff proc~central_diff_4 central_diff_4 proc~close_ephemeris jpl_ephemeris%close_ephemeris proc~close_spice_ephemeris spice_ephemeris%close_spice_ephemeris proc~close_spice_ephemeris->interface~kclear proc~close_spice_ephemeris->interface~unload proc~complex_step_derivative complex_step_derivative proc~complex_step_test complex_step_test proc~complex_step_test->proc~central_diff proc~complex_step_test->proc~central_diff_4 proc~complex_step_test->proc~complex_step_derivative proc~forward_diff forward_diff proc~complex_step_test->proc~forward_diff proc~compute_crtpb_parameter compute_crtpb_parameter proc~compute_eigenvalues_and_eigenvectors compute_eigenvalues_and_eigenvectors proc~rg rg proc~compute_eigenvalues_and_eigenvectors->proc~rg proc~compute_gravity_acceleration_kuga_carrara geopotential_model_kuga_carrara%compute_gravity_acceleration_kuga_carrara proc~kuga_carrara_geopotential kuga_carrara_geopotential proc~compute_gravity_acceleration_kuga_carrara->proc~kuga_carrara_geopotential proc~compute_gravity_acceleration_lear geopotential_model_lear%compute_gravity_acceleration_lear proc~grav grav proc~compute_gravity_acceleration_lear->proc~grav proc~compute_gravity_acceleration_mueller geopotential_model_mueller%compute_gravity_acceleration_mueller proc~geopot geopot proc~compute_gravity_acceleration_mueller->proc~geopot proc~compute_gravity_acceleration_normalized_pines geopotential_model_normalized_pines%compute_gravity_acceleration_normalized_pines proc~pinesnorm pinesnorm proc~compute_gravity_acceleration_normalized_pines->proc~pinesnorm proc~compute_gravity_acceleration_pines geopotential_model_pines%compute_gravity_acceleration_pines proc~gravpot gravpot proc~compute_gravity_acceleration_pines->proc~gravpot proc~compute_halo_monodromy_matrix compute_halo_monodromy_matrix proc~initialize~2 rk_class%initialize proc~compute_halo_monodromy_matrix->proc~initialize~2 proc~integrate~2 rk_class%integrate proc~compute_halo_monodromy_matrix->proc~integrate~2 proc~compute_jacobi_constant compute_jacobi_constant proc~compute_libration_points compute_libration_points proc~cube_root cube_root proc~compute_libration_points->proc~cube_root proc~compute_libration_points_v2 compute_libration_points_v2 proc~compute_libration_points_v2->proc~compute_libration_points proc~compute_libration_points_v2->proc~cube_root proc~compute_monodromy_matrix_eigenvalues compute_monodromy_matrix_eigenvalues proc~matrix_trace matrix_trace proc~compute_monodromy_matrix_eigenvalues->proc~matrix_trace proc~compute_real_eigenvalues_and_normalized_eigenvectors compute_real_eigenvalues_and_normalized_eigenvectors proc~compute_real_eigenvalues_and_normalized_eigenvectors->proc~compute_eigenvalues_and_eigenvectors proc~compute_stepsize stepsize_class%compute_stepsize proc~compute_vinf_vectors->proc~cross proc~convert convert proc~fl FL proc~convert->proc~fl proc~crtbp_derivs crtbp_derivs proc~crtbp_derivs_with_stm crtbp_derivs_with_stm proc~crtbp_test crtbp_test proc~crtbp_test->proc~compute_crtpb_parameter proc~crtbp_test->proc~compute_jacobi_constant proc~crtbp_test->proc~compute_libration_points proc~crtbp_test->proc~compute_libration_points_v2 proc~crtbp_test->proc~crtbp_derivs proc~crtbp_test->proc~crtbp_derivs_with_stm proc~cw_equations cw_equations proc~cw_propagator cw_propagator proc~cw_propagator->proc~cw_equations proc~d_kepde d_kepde proc~d_kepdh d_kepdh proc~d_kepds d_kepds proc~stumpff_c stumpff_c proc~d_kepds->proc~stumpff_c proc~stumpff_s stumpff_s proc~d_kepds->proc~stumpff_s proc~d_kepe d_kepe proc~dcbsol dcbsol proc~dcubrt dcubrt proc~dcbsol->proc~dcubrt proc~destroy rk_variable_step_class%destroy proc~destroy_geopotential_model destroy_geopotential_model destroy destroy proc~destroy_geopotential_model->destroy proc~destroy_geopotential_model~2 geopotential_model%destroy_geopotential_model proc~destroy_stepsize_class stepsize_class%destroy_stepsize_class proc~destroy~2 rk_class%destroy proc~direct direct proc~direct_inverse_test direct_inverse_test proc~direct_inverse_test->proc~direct proc~inverse inverse proc~direct_inverse_test->proc~inverse proc~distance_from_point_to_line distance_from_point_to_line proc~distance_from_point_to_line->proc~cross proc~distance_from_point_to_line_segment distance_from_point_to_line_segment proc~distance_from_point_to_path distance_from_point_to_path proc~distance_from_point_to_path->proc~distance_from_point_to_line_segment proc~locpt locpt proc~distance_from_point_to_path->proc~locpt proc~dogleg dogleg proc~dpmpar dpmpar proc~dogleg->proc~dpmpar proc~enorm enorm proc~dogleg->proc~enorm proc~drag_acceleration drag_acceleration proc~ec2eq ec2eq proc~eispack_test eispack_test proc~eispack_test->proc~compute_eigenvalues_and_eigenvectors proc~ekepl ekepl proc~ekepl->proc~dcbsol proc~emkep emkep proc~ekepl->proc~emkep proc~ekepl1 ekepl1 proc~ekepl2 ekepl2 proc~emkepl emkepl proc~ekepl2->proc~emkepl proc~el2op el2op proc~elmhes elmhes proc~els2pv els2pv proc~els2pv->proc~dcbsol proc~els2pv->proc~ekepl proc~shkepl shkepl proc~els2pv->proc~shkepl proc~els3pv els3pv proc~els3pv->proc~els2pv proc~eltran eltran proc~ephemeris_test ephemeris_test proc~get_constants jpl_ephemeris%get_constants proc~ephemeris_test->proc~get_constants proc~get_state jpl_ephemeris%get_state proc~ephemeris_test->proc~get_state proc~initialize_ephemeris jpl_ephemeris%initialize_ephemeris proc~ephemeris_test->proc~initialize_ephemeris proc~eq2ec eq2ec proc~equatorial_to_mean_ecliptic_rotmat equatorial_to_mean_ecliptic_rotmat proc~mean_ecliptic_to_equatorial_rotmat mean_ecliptic_to_equatorial_rotmat proc~equatorial_to_mean_ecliptic_rotmat->proc~mean_ecliptic_to_equatorial_rotmat proc~equinoctial_to_cartesian equinoctial_to_cartesian proc~et_to_jd et_to_jd proc~extract_vector_from_vector->interface~extract_vector proc~f_string_to_c_ptr f_string_to_c_ptr proc~f_string_to_c_ptr->interface~strlen proc~f_string_to_c_ptr->s proc~fdjac1 fdjac1 proc~fdjac1->proc~dpmpar proc~fill_char_vector_with_vector->interface~fill_vector proc~fill_vector_with_vector->interface~fill_vector proc~from_ijk_to_lvlh_mat->proc~cross proc~uhat_dot uhat_dot proc~from_ijk_to_lvlh_mat->proc~uhat_dot proc~from_ijk_to_lvlh_mat->proc~unit proc~from_ijk_to_lvlh_rv->interface~from_ijk_to_lvlh proc~from_ijk_to_rsw_mat->proc~cross proc~from_ijk_to_rsw_mat->proc~uhat_dot proc~from_ijk_to_rsw_mat->proc~unit proc~from_ijk_to_rsw_rv->interface~from_ijk_to_rsw proc~from_lvlh_to_ijk_mat->interface~from_ijk_to_lvlh proc~from_lvlh_to_ijk_rv->interface~from_lvlh_to_ijk proc~from_primary_to_center two_body_rotating_frame%from_primary_to_center get_rv get_rv proc~from_primary_to_center->get_rv proc~from_rsw_to_ijk_mat->interface~from_ijk_to_rsw proc~from_rsw_to_ijk_rv->interface~from_rsw_to_ijk proc~geocentric_radius geocentric_radius proc~geodetic_to_cartesian geodetic_to_cartesian proc~geodetic_to_cartesian_triaxial geodetic_to_cartesian_triaxial proc~geodetic_to_cartesian_triaxial_2 geodetic_to_cartesian_triaxial_2 proc~geometry_unit_test geometry_unit_test proc~geometry_unit_test->proc~distance_from_point_to_path proc~geometry_unit_test->proc~locpt proc~geopotential_module_test geopotential_module_test proc~geopotential_module_test->proc~compute_gravity_acceleration_mueller proc~geopotential_module_test->proc~destroy_geopotential_model~2 proc~get_random_number get_random_number proc~geopotential_module_test->proc~get_random_number proc~number_of_coefficients number_of_coefficients proc~geopotential_module_test->proc~number_of_coefficients proc~read_geopotential_file geopotential_model%read_geopotential_file proc~geopotential_module_test->proc~read_geopotential_file proc~spherical_to_cartesian spherical_to_cartesian proc~geopotential_module_test->proc~spherical_to_cartesian proc~get_acceleration get_acceleration get_acc get_acc proc~get_acceleration->get_acc proc~get_c_cdot_ecliptic ecliptic_frame%get_c_cdot_ecliptic proc~get_c_cdot_ecliptic->proc~equatorial_to_mean_ecliptic_rotmat proc~get_c_cdot_ecliptic->proc~mean_ecliptic_to_equatorial_rotmat proc~get_c_cdot_iau_earth iau_earth_rotating_frame%get_c_cdot_iau_earth proc~icrf_to_iau_earth icrf_to_iau_earth proc~get_c_cdot_iau_earth->proc~icrf_to_iau_earth proc~get_c_cdot_iau_moon iau_moon_rotating_frame%get_c_cdot_iau_moon proc~icrf_to_iau_moon icrf_to_iau_moon proc~get_c_cdot_iau_moon->proc~icrf_to_iau_moon proc~get_c_cdot_icrf icrf_frame%get_c_cdot_icrf proc~get_c_cdot_two_body_rotating two_body_rotating_frame%get_c_cdot_two_body_rotating proc~get_c_cdot_two_body_rotating->proc~cross proc~get_c_cdot_two_body_rotating->proc~cross_matrix proc~get_c_cdot_two_body_rotating->proc~unit proc~get_c_cdot_two_body_rotating->get_rv proc~get_c_cdot_two_body_rotating_pulsating two_body_rotating_pulsating_frame%get_c_cdot_two_body_rotating_pulsating proc~get_c_cdot_two_body_rotating_pulsating->proc~get_c_cdot_two_body_rotating proc~get_format_statement get_format_statement proc~get_rv_from_jpl_ephemeris jpl_ephemeris%get_rv_from_jpl_ephemeris proc~get_rv_from_jpl_ephemeris->proc~et_to_jd proc~get_rv_from_jpl_ephemeris->proc~get_state proc~spice_id_to_old_id spice_id_to_old_id proc~get_rv_from_jpl_ephemeris->proc~spice_id_to_old_id proc~get_rv_from_spice_ephemeris spice_ephemeris%get_rv_from_spice_ephemeris proc~get_rv_from_spice_ephemeris->interface~failed proc~get_rv_from_spice_ephemeris->interface~spkgeo proc~state jpl_ephemeris%state proc~get_state->proc~state proc~gravity_j2_j3_j4 gravity_j2_j3_j4 proc~great_circle_distance great_circle_distance proc~halo_orbit_test halo_orbit_test proc~halo_to_rv halo_to_rv proc~halo_orbit_test->proc~halo_to_rv proc~halo_to_rv->proc~compute_crtpb_parameter proc~halo_to_rv->proc~compute_libration_points proc~halo_to_rv_diffcorr halo_to_rv_diffcorr proc~halo_to_rv_diffcorr->proc~compute_crtpb_parameter proc~halo_to_rv_diffcorr->proc~halo_to_rv proc~hybrd1 hybrd1 proc~halo_to_rv_diffcorr->proc~hybrd1 proc~halo_to_rv_diffcorr->proc~initialize~2 proc~integrate_to_event~2 rk_class%integrate_to_event proc~halo_to_rv_diffcorr->proc~integrate_to_event~2 proc~halo_to_rv_diffcorr->proc~integrate~2 proc~wrap_angle wrap_angle proc~halo_to_rv_diffcorr->proc~wrap_angle proc~heikkinen heikkinen proc~helio helio proc~helio->proc~calcelements proc~helio->proc~el2op proc~op2ec op2ec proc~helio->proc~op2ec proc~tbl tbl proc~helio->proc~tbl proc~hinit rk_variable_step_class%hinit proc~hqr hqr proc~hqr2 hqr2 proc~hqr2->proc~cdiv proc~hstart rk_variable_step_class%hstart proc~hybrd hybrd proc~hybrd->proc~dogleg proc~hybrd->proc~dpmpar proc~hybrd->proc~enorm proc~hybrd->proc~fdjac1 proc~qform qform proc~hybrd->proc~qform proc~qrfac qrfac proc~hybrd->proc~qrfac proc~r1mpyq r1mpyq proc~hybrd->proc~r1mpyq proc~r1updt r1updt proc~hybrd->proc~r1updt proc~hybrd1->proc~hybrd proc~hybrj hybrj proc~hybrj->proc~dogleg proc~hybrj->proc~dpmpar proc~hybrj->proc~enorm proc~hybrj->proc~qform proc~hybrj->proc~qrfac proc~hybrj->proc~r1mpyq proc~hybrj->proc~r1updt proc~hybrj1 hybrj1 proc~hybrj1->proc~hybrj proc~hyperbolic_turning_angle hyperbolic_turning_angle proc~iau_rotation_matrix iau_rotation_matrix proc~rotation_matrix rotation_matrix proc~iau_rotation_matrix->proc~rotation_matrix proc~iau_test iau_test proc~iau_test->proc~icrf_to_iau_earth proc~iau_test->proc~icrf_to_iau_moon proc~icrf_to_iau_earth->proc~iau_rotation_matrix proc~icrf_to_iau_moon->proc~iau_rotation_matrix proc~initialize rk_variable_step_class%initialize proc~initialize->proc~destroy proc~initialize_geopotential_model initialize_geopotential_model proc~initialize_geopotential_model->proc~c_ptr_to_f_string proc~initialize_geopotential_model->destroy initialize initialize proc~initialize_geopotential_model->initialize proc~initialize_spice_ephemeris spice_ephemeris%initialize_spice_ephemeris proc~initialize_spice_ephemeris->interface~furnsh proc~initialize_spice_ephemeris->interface~trcoff proc~initialize~2->proc~destroy~2 proc~integrate rk_variable_step_class%integrate proc~integrate->proc~compute_stepsize proc~integrate->proc~hinit proc~integrate->proc~hstart order order proc~integrate->order step step proc~integrate->step proc~integrate_to_event rk_variable_step_class%integrate_to_event proc~integrate_to_event->proc~compute_stepsize proc~integrate_to_event->proc~hinit proc~integrate_to_event->proc~hstart proc~integrate_to_event->proc~set_function proc~integrate_to_event->proc~zeroin proc~integrate_to_event->order proc~integrate_to_event->step proc~integrate_to_event~2->proc~set_function proc~integrate_to_event~2->proc~zeroin proc~integrate_to_event~2->step proc~integrate~2->step proc~interp jpl_ephemeris%interp proc~jd_to_et jd_to_et proc~jd_to_mjd jd_to_mjd proc~julian_date_intsec->proc~julian_date_realsec proc~julian_day julian_day proc~julian_date_realsec->proc~julian_day proc~kepde kepde proc~kepdh kepdh proc~kepds kepds proc~kepds->proc~stumpff_c proc~kepds->proc~stumpff_s proc~kepe kepe proc~kepler_classical kepler_classical proc~newton newton proc~kepler_classical->proc~newton proc~kepler_goodyear_stienon_klumpp kepler_goodyear_stienon_klumpp proc~kepler_shepperd kepler_shepperd proc~lambert_test lambert_test proc~lambert_test->proc~get_random_number proc~pv3els pv3els proc~lambert_test->proc~pv3els proc~solve_lambert_arorarussell solve_lambert_arorarussell proc~lambert_test->proc~solve_lambert_arorarussell proc~solve_lambert_gooding solve_lambert_gooding proc~lambert_test->proc~solve_lambert_gooding proc~solve_lambert_izzo solve_lambert_izzo proc~lambert_test->proc~solve_lambert_izzo proc~lowercase lowercase proc~magnitude magnitude proc~matrix_cofactor matrix_cofactor proc~matrix_determinant matrix_determinant proc~matrix_cofactor->proc~matrix_determinant proc~matrix_determinant->proc~matrix_determinant proc~maxval_func maxval_func proc~mean_obliquity_of_ecliptic_iau1980 mean_obliquity_of_ecliptic_iau1980 proc~mean_ecliptic_to_equatorial_rotmat->proc~mean_obliquity_of_ecliptic_iau1980 proc~mean_obliquity_of_ecliptic_iau2006 mean_obliquity_of_ecliptic_iau2006 proc~mjd_to_jd mjd_to_jd proc~modified_equinoctial_derivs modified_equinoctial_derivs proc~modified_equinoctial_test modified_equinoctial_test proc~modified_equinoctial_test->proc~cartesian_to_equinoctial proc~modified_equinoctial_test->proc~equinoctial_to_cartesian proc~modified_equinoctial_test->proc~modified_equinoctial_derivs proc~norm2_func norm2_func proc~normalize_variables normalize_variables proc~olson olson proc~orbit_check orbit_check proc~orbit_energy orbit_energy proc~orbit_period orbit_period proc~orbital_elements_to_rv orbital_elements_to_rv proc~orbital_elements_to_rv->proc~orbit_check proc~outer_product outer_product proc~periapsis_apoapsis periapsis_apoapsis proc~print_matrix print_matrix proc~propagate propagate proc~propagate->proc~els3pv proc~propagate->proc~pv3els proc~pv2els pv2els proc~pv2els->proc~emkep proc~shmkep shmkep proc~pv2els->proc~shmkep proc~pv3els->proc~pv2els proc~qrfac->proc~dpmpar proc~qrfac->proc~enorm proc~r1updt->proc~dpmpar proc~read_geopotential_file->proc~convert proc~read_geopotential_file->proc~destroy_geopotential_model~2 proc~read_geopotential_file->proc~fl proc~read_geopotential_file->proc~get_format_statement proc~read_geopotential_file->proc~number_of_coefficients c c proc~read_geopotential_file->c cnm cnm proc~read_geopotential_file->cnm proc~read_geopotential_file->s snm snm proc~read_geopotential_file->snm proc~relative_motion_test relative_motion_test proc~relative_motion_test->interface~from_ijk_to_lvlh proc~relative_motion_test->interface~from_ijk_to_rsw proc~return_a_string return_a_string proc~return_a_string->proc~f_string_to_c_ptr proc~rg->proc~balanc proc~rg->proc~balbak proc~rg->proc~elmhes proc~rg->proc~eltran proc~rg->proc~hqr proc~rg->proc~hqr2 proc~rk4 rk4_class%rk4 proc~rk8_10 rk8_10_class%rk8_10 proc~rk_test rk_test proc~rk_test->proc~integrate_to_event~2 proc~rk_test->proc~integrate~2 proc~rk_test_variable_step rk_test_variable_step proc~rk_test_variable_step->proc~integrate proc~rk_test_variable_step->proc~integrate_to_event proc~rk_test_variable_step->proc~orbital_elements_to_rv proc~stepsize_class_constructor stepsize_class%stepsize_class_constructor proc~rk_test_variable_step->proc~stepsize_class_constructor proc~rkf108 rkf108_class%rkf108 f f proc~rkf108->f proc~rkf108_order rkf108_class%rkf108_order proc~rkf1210 rkf1210_class%rkf1210 proc~rkf1210->f proc~rkf1210_order rkf1210_class%rkf1210_order proc~rkf1412 rkf1412_class%rkf1412 proc~rkf1412->f proc~rkf1412_order rkf1412_class%rkf1412_order proc~rkf78 rkf78_class%rkf78 proc~rkf78->f proc~rkf78_order rkf78_class%rkf78_order proc~rkf89 rkf89_class%rkf89 proc~rkf89->f proc~rkf89_order rkf89_class%rkf89_order proc~rkv89 rkv89_class%rkv89 proc~rkv89->f proc~rkv89_order rkv89_class%rkv89_order proc~rotation_matrix_dot rotation_matrix_dot proc~rv_to_orbital_elements rv_to_orbital_elements proc~rv_to_orbital_elements->proc~cross proc~rv_to_orbital_elements->proc~orbit_check proc~rv_to_orbital_elements->proc~wrap_angle proc~rvcto_rvcfrom_icrf rvcto_rvcfrom_icrf proc~rvcto_rvcfrom_icrf->proc~from_primary_to_center proc~rvcto_rvcfrom_icrf->get_rv proc~shkepl->proc~dcubrt proc~shkepl->proc~shmkep proc~simpson_lunar_ephemeris simpson_lunar_ephemeris proc~solve_lambert_gooding->proc~cross proc~solve_lambert_gooding->proc~unit proc~solve_lambert_izzo->proc~ucross proc~solve_lambert_izzo->proc~unit proc~sphere sphere proc~sphere_of_influence sphere_of_influence proc~sphere_of_influence_earth_moon sphere_of_influence_earth_moon proc~sphere_of_influence_earth_moon->proc~angle_between_vectors proc~spice_id_to_standish_id spice_id_to_standish_id proc~split split proc~standish_module_test standish_module_test proc~standish_module_test->proc~et_to_jd proc~standish_module_test->proc~helio proc~standish_rv_func standish_ephemeris%standish_rv_func proc~standish_module_test->proc~standish_rv_func proc~standish_rv_func->proc~ec2eq proc~standish_rv_func->proc~et_to_jd proc~standish_rv_func->proc~helio proc~standish_rv_func->proc~spice_id_to_standish_id proc~state->proc~interp proc~state->proc~split proc~step_size_test step_size_test proc~step_size_test->proc~compute_stepsize proc~step_size_test->proc~stepsize_class_constructor proc~third_body_gravity third_body_gravity proc~time_module_test time_module_test proc~time_module_test->interface~julian_date proc~time_module_test->proc~calendar_date_realsec proc~transform reference_frame%transform proc~transform->proc~rvcto_rvcfrom_icrf get_c_cdot get_c_cdot proc~transform->get_c_cdot proc~transformation_module_test transformation_module_test proc~transformation_module_test->proc~get_c_cdot_ecliptic proc~transformation_module_test->proc~initialize_ephemeris proc~transformation_module_test->proc~transform proc~ucross->proc~cross proc~ucross->proc~unit proc~unnormalize_variables unnormalize_variables proc~uppercase uppercase proc~vector_projection vector_projection proc~vector_projection_on_plane vector_projection_on_plane proc~vector_projection_on_plane->proc~vector_projection proc~vector_test vector_test proc~vector_test->proc~axis_angle_rotation proc~vector_test->proc~axis_angle_rotation_to_rotation_matrix proc~vector_test->proc~rotation_matrix proc~vinf_to_energy vinf_to_energy proc~xyz2philambda->proc~geodetic_to_cartesian_triaxial_2
Help