Orbit Propagation Using Gauss-Legendre Collocation

Size: px
Start display at page:

Download "Orbit Propagation Using Gauss-Legendre Collocation"

Transcription

1 Orbit Propagation Using Gauss-Legendre Collocation Brandon A. Jones University of Colorado, Boulder, CO, 839, USA This paper discusses the application of Gauss-Legendre collocation for orbit propagation. Previous presentations of collocation propagators for astrodynamics used a fixed-step implementation, thereby limiting their effectiveness for eccentric orbits. The presented formulation uses a variable-step implementation, thereby improving its use for scenarios where the necessary time step varies over time. Additionally, low- and high-fidelity force models are combined to reduce the overall computation time for the integration. The method was compared to other commonly employed integration tools for both two-body and higher-fidelity propagation, and matched or reduced the number of high-fidelity force function calls required for accurate propagation. These tests only considered a serial implementation of the Gauss-Legendre propagator, but parallel methods and their implications for computationally efficient orbit propagation are also discussed. Nomenclature α β ǫ θ j ξ j τ A a i,j b b i c c i d i e F f() h k i l j () N M m p s t u w j y Empirically determined scale parameter Step size predictor safety factor Matrix of changes in initial state per unit time for each node Integration tolerance Integrator interpolation weights Gaussian quadrature node Scaled time in integration interval Integration matrix Coefficients in the integration matrix s-vector of integration weights Integration weights s-vector of integration nodes Integration nodes Intermediate values in initial step size calculation Integration error Matrix of forces at each integrator stage Force model Integrator step size (s) Force-model output for integrator state i Lagrange interpolating polynomial of order j Number of Gaussian quadrature nodes Maximum number of iterations in nonlinear solver Number of iterations required for the nonlinear solver Dimension of the integrated state vector Number of integration nodes (or stages) Time (s) Generic polynomial Gaussian quadrature weight p-vector for the integrated state Research Associate, Colorado Center for Astrodynamics Research, UCB 431, AIAA Member. 1 of 16

2 I. Introduction This paper examines the use of Gauss-Legendre (GL) collocation for satellite orbit propagation. Such methods have several stability and computation qualities of benefit to satellite orbit propagation, some of which are demonstrated in this research. The presented method includes a variable-step formulation to improve its efficiency for orbits with non-zero eccentricities, and compares its performance to several of the more common orbit propagation methods currently employed by the astrodynamics community. Although not commonly used, applications of collocation methods in astrodynamics have increased in recent years. Barrio, et al. 1 compares the use of Chebyshev collocation methods and an eighth-order embedded Runge-Kutta (RK) technique for orbit propagation. Chapter 7 of Beutler 2 describes the application of collocation methods to orbit propagation, and defines a general method based on the location of the zeroes of the underlying polynomial. This discussion also includes tests using polynomials defined by equally-spaced nodes and a brief comparison between Chebyshev and Legendre collocation methods in a small number of toy problems. Those results demonstrate that Legendre collocation outperforms Chebyshev collocation by about an order of magnitude in accuracy. However, these comparisons use polynomials of equal degree without compensating for the order of the resulting integration method. More recent research considers a Chebyshev-polynomial-based method that is very similar to collocation, and demonstrates a parallel implementation to further reduce overall CPU time. 3 Applications of collocation integrators also exist for boundary value problems, specifically to aid in trajectory optimization. Previous uses of the Lobatto IIIA methods include trajectory optimization for Earth-Moon trajectories. 4,5 These same Lobatto IIIA methods were used for trajectory design for solar sail 6,7 and low-thrust trajectories 8,9 in the N-body problem for Lunar pole coverage. The two papers by Bradley, et al. 1 and Jones and Anderson 11 recently discussed and presented results for orbit propagation using other forms of collocation. Jones and Anderson 11 described a fixed-step implementation of integration using GL nodes, and provided sample results based on tests with a small number of nodes ( 4). As discussed in Bradley, et al., 1 methods such as those based on GL or Chebyshev nodes exhibit oversampling towards the ends of the integration interval. This oversampling results in an insensitivity in the step size with increases in the number of nodes. Hence, the maximum step size possible, which is desired for long-term propagation, increases slowly with heightend computation cost. However, no demonstration of this limitation could be found in the literature for astrodynamics applications. To reduce this oversampling, Bradley, et al. 1 presented the BandLimited Collocation using Implicit Runge-Kutta (BLC-IRK) method that provides a more uniform distribution of points and combines low- and high-fidelity force models to reduce computation time. Both of these papers demonstrated that collocation methods may be used to provide an efficient means of orbit propagation, but were not optimal for scenarios with high eccentricities. Hence, a variable-step method for collocation integrators is desired. This paper presents an implementation of the GL integrator that allows for more efficient propagation of eccentric orbits when compared to the previous demonstrations of collocation methods. The variable-step implementation uses the rate of convergence for the implicit method to determine a step size appropriate for the next integration step. To further reduce computation time, the method uses a combination of high- and low-fidelity force models to reduce the number of evaluations of the most computationally expensive portions of the software. This is similar to the BLC-IRK method previously described. The paper then compares this method to other commonly used ordinary differential equation (ODE) solvers in astrodynamics. Through this research, we hope to quantify the maximum number of nodes useful in GL collocation for astrodynamics, and begin developing a variable-step method with applications to other collocation methods. The paper is organized as follows. Section II provides a general discussion of integration using GL nodes in the form of an implicit Runge-Kutta(IRK) scheme. Section III then describes the implementation considered in this paper. Results for two-body propagation are presented, followed by higher-fidelity propagation that includes perturbations in the gravity field. Finally, the paper is summarized and conclusions are presented in Section VI. II. Gauss-Legendre Methods Research into integration using the GL nodes accelerated in the 195s, and was partially motivated by the discovery of features of the method that are desirable in solving the initial value problem. Identification of the GL methods began with a reinterpretation of the common implicit trapezoid rule as a collocation 2 of 16

3 solution using the quadratic, shifted Legendre polynomial. 12 Butcher 13 later defined an IRK method using the shifted Legendre polynomials of any degree, 13 which corresponded to the first general definition of integration using the GL nodes. The GL collocation methods are optimal in terms of the number of nodes for a given order of the integration method. Specifically, a method using a Legendre polynomials of order s has an integration order of 2s. 14,15 Additionally, such methods are symmetric (due to the distribution of nodes in [,1]), A-stable, 16 B-stable, 17 and symplectic. 18 Since this integrator is A-stable, it may be used for generating a solution to a system of ODEs that are stiff. Unfortunately, such stability properties may be lost with implementation. 19 Also, when compared to other symplectic integrators, the GL methods tend to be less efficient. 2,14 However, the combination of these properties increases the versatility of the GL methods when compared to other algorithms used in special perturbations propagation, thereby motivating their study for use in astrodynamics. This paper considers this collocation integrator, but reformulated as an IRK method. Hence, this section first presents a very basic overview of the RK solver. Then, the basics of collocation are described, along with the methods required to generate the necessary RK schemes for any number of integration nodes. II.A. Runge-Kutta Methods Runge-Kutta methods provide a single-step solution to the initial value problem. 21,22 In a generalized form, a s-stage RK method may be written as s = f t n +hc i,y n +h a ij k j, i = 1,...,s (1) k i y n+1 = y n +h j=1 s b j k j (2) j=1 where the integration state vector y n at time t n is of length p, f(t,y) is the ODE describing the dynamic model and returns a p-vector, h is the step size, and the a ij, c i, and b j coefficients are specific to a given RK scheme. The coefficients are often expressed in terms of the Butcher table c A s s b T where the integration (or Runge-Kutta) matrix A is comprised of the terms a ij, and the vectors c and b include the c i and b j coefficients, respectively. RK methods are typically classified by their order and the number of stages s. Efficient methods minimize s for a given order, and higher order methods allow for larger h. When a ij = for j i, this yields an explicit method in which each of the k i terms may be determined sequentially. When this is not the case, i.e. the Runge-Kutta scheme is implicit, a nonlinear solver must be used to generate k i. The most common methods of RK-based orbit propagation use explicit schemes, which are easier to implement and benefit from decades of development. One important advantage of the explicit RK methods is the development of variable-step techniques to autonomously determine the step size required. Such methods usually select a time step that constrains the maximum local error of the solution. The most efficient of these methods are the embedded schemes that produce one solution and require only one additional evaluation of f(t,y) to generate a solution of a higher or lower order. By comparing these two solutions, the local integration error is approximated and the step size may be predicted. The most commonly used of these methods are those developed by Dormand and Prince. 23,24 In this study, the developed GL integrator is compared to the thirteen-stage DOPRI 8(7), or DP 8(7), method, 24 which yields an eighth order solution and uses a seventh order solution for step size control. Comparisons with the seven-stage DOPRI 5(4) (DP 5(4)) scheme 23 are also provided. The commonly employed explicit methods fail to utilize the multi-core processing capabilities of modern computers in the sense that evaluations of the force model function cannot be computed in parallel. This is increasingly important since, for high fidelity orbit propagation, most of the computation time is spent in the force model. While concepts exist to define an explicit RK scheme that allows for the parallel computation of the s stages, such methods result in a reduced order scheme [25, p. 171]. However, implicit methods allow for parallelization in the generation of the solution to the nonlinear system. With the use iterative solvers, the evaluations of f(t, y) may be executed in parallel for a single iteration. Additionally, such techniques 3 of 16

4 typically reduce the number of stages required for a given order, but at the expense of solving the nonlinear system. Before the proliferation of multi-core processing, theoretical studies of parallel methods looked at the effective number of evaluations, i.e., the number of function evaluations assuming a given number of processors [25, p. 171]. When comparing the GL propagator to other methods, we present some results in terms of the number of effective stages. For this case, it is assumed that the number of available processors is greater than or equal to s. Of course, this does not capture the inherent overhead in the generation of and communication between the threads for a parallel implementation. Many of the operations required in the RK solver may be expressed in terms of linear algebra operations. For an explicit RK solver where each of the k i are found in sequence, a linear system formulation is of little benefit. The same is not the case for implicit methods. Such techniques must iterate on the solution, which allows for evaluating the series in Eq. (1) for all i before any calls to the force models. Let where Then, Eq. (1) may be written as where i indicates the i-th row of. The final solution is then = FA T (3) ] F = [k 1 k. (4) s p s F i = k i = f (t n +hc i,y n +h i ) (5) y n+1 = y n +hfb. (6) With this formulation, the sums in Eqs. (1) and (2) may be performed using Basic Linear Algebra Subprograms, or BLAS, library functions. BLAS routines are more computationally efficient than typical for-loop implementations, and are especially advantageous as the number of stages s or the size of the state p increases. II.B. Collocation Methods Collocation methods approximate the continuous solution to an ODE using a polynomial basis that exactly equals the solution at a set of nodes. In these methods, the first derivatives of the polynomial equal the slopes of the continuous solution y(t) at a given set of nodes c i. Given c i [,1] where i = 1,...,s, a collocation solution satisfies u(t n ) = y n (7) u(t n +hc i ) = ẏ(t n +hc i,u(t n +hc i )) (8) which then results in y n+1 = u(t n + h). It is noted that the resulting polynomial u(t) provides a continuous approximation of the system, and the formulation may easily be extended to a vector y n. Practical implementations of collocation methods generate a solution that satisfies Eq. (8) to a finite accuracy. Gauss Nodes Lobatto Nodes Chebyshev Nodes Figure 1. Node locations for various collocation polynomials as the number of nodes increases. Figure 1 illustrates the location of nodes c i for three ofthe most commonly used collocationmethods. For these polynomials, the concentration of c i increases towards the endpoints of the time interval. This results 4 of 16

5 in oversampling and high-frequency oscillations at the ends (Runge phenomenon), which reduces the overall efficiency of the integration method for high order schemes. An alternative method for orbit propagation reduces node density at the ends by using collocation with band-limited functions. 1 This is designed to sacrifice some accuracy for the sake of computation speed, symplecticity, and improved stability. Although several methods exist for using a polynomial basis to generate a solution to the initial value problem, all collocation methods may be expressed as an IRK method. 26 Given a set of nodes c defined by the collocation polynomial, the integrator is equivalent to a s-stage Runge-Kutta integration method with 26,14,15 ci 1 a ij = l j (γ)dγ, b i = l i (γ)dγ (9) where l j (γ) is the Lagrange interpolating polynomial l j (γ) = l j γ c l c j c l. (1) These equations may then be used to generate an IRK scheme when given the zeros, or nodes, of the collocation method, and they provide an analytic means for generating the Butcher table for a method of arbitrary order. Equation (9) may be evaluated using Gaussian quadrature, which provides a numerically stable method for generating the RK scheme. Software for generating the nodes ξ j [ 1,1] and the weights w j of the quadratures may be found online a, and these nodes correspond to the zeros of the Legendre polynomials. Given these quadratures, the nodes of the shifted Legendre polynomials c j [,1] are c i = (ξ i +1)/2. (11) Since the integrals in Eq. (9) are expressed in terms of the Legendre polynomials, evaluations of the integrals in this way is exact when using Gaussian quadrature of the same degree. Hence, if c j and w j are accurate to quadruple precision, evaluation of the integrals will be accurate to the same precision. The solution for the RK scheme is then and a ij = ci = ξ i +1 4 = ξ i +1 4 b i = = 1 2 = l i (γ)dγ (12) 1 l i (ξ)dξ (13) N w k l i (ξ k ) (14) k=1 l j (γ)dγ (15) 1 1 ( ) 1 l j 2 (ξ(ξ i +1)+ξ i 1) dξ (16) N ( ) 1 w k l j 2 (ξ k(ξ i +1)+ξ i 1). (17) k=1 For the current implementation of the GL integrator, schemes for s = 2,...,6 are generated in quadruple precision and stored in double precision for future use in orbit propagation. This minimizes round-off errors resulting from the terms in the integration coefficients. III. Variable-Step GL Propagator Implementation The GL propagator considered in this paper uses the variable-step implementation suggested by van der Houwen and Sommeijer 27 with some alterations to customize its use for orbit propagation. In their paper, a For example, the GAUSSQ routine may be found on netlib ( 5 of 16

6 van der Houwen and Sommeijer demonstrate that a variable-step implementation may be developed by approximating the local truncation error by the rate of convergence for the iterative process. This technique is implemented with the GL collocation method expressed as a IRK solver. Other methods of generating a variable step integrator for an IRK method exist, 19,28,29 but were not considered in this study. For easy identification of this integrator, the implementation described here is denoted VGL-s where s is the number of nodes in the scheme. III.A. Step-Size Selection As mentioned previously, generic solutions using an IRK scheme require an iterative solver for the nonlinear system in Eq. (5). The current implementation uses fixed point, or Picard, iteration. Given a solution for the forces F (m) at iteration m, (m) = F (m) A T, F (m+1) i ( = f t n +hc i,y n +h (m) i ). (18) This process is repeated with m = m+1 until convergence is achieved. As demonstrated by van der Houwen and Sommeijer, 27 the resulting solution of the RK solver y (m) n+1 = y n +hf (m) b (19) provides a solution of increasing order with each iteration m. Hence, y (m) may be considered an embedded solution of order m and compared to the lower-order solution y (m 1). This method requires no additional evaluations of the force model since it is already calculated in the process of generating y n+1. After m iterations, the local error is then e = 1 p y (m) i y (m 1) ( i p ), (2) max 1., i=1 y (m) i andthesolutionisconsideredconvergedife < ǫwhereǫisauserdefinedrelativetolerance. Ifthisconvergence is not achieved within a maximum number of iterations M, then the step size is rejected and the final value of e is used to generate a new step size. Such rejections can be expensive, and care must be taken to minimize their number. This may be accomplished by limiting the change in the step size or generating a more accurate step size prediction. A possible candidate for the later was presented by Gustafsson. 3 To set the maximum number of iterations, the current implementation uses int [ ] s M = 3 s > 5 (21) s s 5 which was found to allow for a sufficient number of iterations to converge while limiting the accumulation of floating-point error. After the iteration process is complete, regardless of the success of convergence, the predicted step size is h = h β min ( 6., max ( ( )) ǫ 1/(2s+1).1,. (22) e) where β is a safety factor commonly employed in such a step size predictor. The values 6. and.1 ensure that the time step does not increase or decrease by a given factor after a single step. If the nonlinear solver failed to converge, this new step size is used with the iterative process restarted. Implementations of Eq. (22) in common embedded RK methods set β [.8,.95]. However, Hairer, et al. [19, p. 124] recommends altering β to account for the rate of convergence when iterating. Similar to the formulation of Haier, et al., 19 this implementation uses ( ) min.9 3M 2M+m β =,1. e < ǫ. (23).8 e ǫ This selectionofβ yields avalue of.9ifthe maximumnumber ofiterationswererequired, and imposesafactor of.8 if the previous step failed to converge on the solution. Testing of this implementation demonstrated 6 of 16

7 that allowing too many iterations yields faster accumulation of floating point error for long integration time spans. Conversely, reducing this threshold results in small step sizes to satisfy the constrained number of iterations and reduces integrator efficiency. Thus, Eqs. (21) and (23) provided an adequate balance, and are effectively design parameters for this integration method. III.B. Initial Step Size Selection Selection of the initial step size for the VGL-s integrator influences integrator efficiency. For a step size that is too large, the method must reject integrator steps until an appropriate value has been determined. For a value too small, early steps through the integrator are smaller than necessary until the step size has settled on the appropriate value. In some cases, the user may already known an appropriate value. For those cases without such a value, a method for proper step size selection is desired. This selection outlines a method based on the one presented in Hairer, et al. [31, p. 169] with alterations empirically determined in this research. This method for step size selection is based on the assumption that local error Ch m+1 y (m+1) (t ), (24) i.e. the truncation error in the Taylor expansion of order m. Since, for the currently implemented integrator, only y (1) = f(t,x) is known, y (p+1) is approximated using a small Euler step and the first derivatives. The algorithm is then presented in Algorithm 1 the computed norms are based on Eq. (2), but with no reference. The parameter α is empirically determined in Section V.C, and is a function of the orbit. Algorithm 1 Initial Step Size Selection f 1 = f(t,xy ) d = y, d 1 = f 1 h =.1 (d /d 1 ) if d or d 1 < 1 5 then h = 1 6 end if y 1 = y +hf 1 f 2 = f(t +h,y 1 ) d 2 = f 2 f 1 /h h 1 = (.1/max(d 1,d 2 )) 1/(p+1) if max(d 1,d 2 ) 1 15 then h 1 = max(1 6,h 1 3 ) end if h = min(1 h 1,α h 2 ) III.C. Continuous Approximation The solution to the GL-based collocation method also provides a continuous approximation to the ODE solution. Specifically, interpolation using the the collocation polynomial provides a solution of order s [14, p. 326]. Specialized code may be written for each polynomial, however a generalize algorithm may be employed for any scheme where the node locations are the zeroes of the polynomial [14, p. 335]. For this method, s y(t) = y n +h θ j (t)f(t n +hc j,y n +h j ) (25) j=1 where the θ j (t) are coefficients defined by the integration scheme, t [t n,t n+1 ], and j is the solution at the nodes after convergence. The coefficients θ j (t) are generated by solving the Vandermonde-like system θ 1 (t) τ c 1 c 2 c s θ 2 (t) τ..... = 2 /2 (26)... c1 s 1 c2 s 1 cs s 1 θ s (t) τ s /s s s s 1 s 1 7 of 16

8 with τ = t t n h. (27) Assuming the Vandermonde matrix is non-singular (which is the case for the GL methods), the inverse is precomputed and later used to define a polynomial in τ. This yields a general method applicable to all collocation methods formulated as IRK. It is noted that such a method may be used for extrapolation ( τ > 1), which is also a common method used to initialize the iteration procedure in the next time step. III.D. Stage Initialization Several techniques exist for initializing the nonlinear solver, with each attempting to provide the most accuratestartingvaluetoreducethe totalnumberofiterations. Thesimplest choicecallsforsettingf () =, but this fails to incorporate any of the information already available for stage prediction. Other methods for stage prediction include: the previously mentioned extrapolation using the collocation polynomial, 14 additional evaluations of the RHS function in an explicit integration method, 32 equistage approximation, 33 or two-step, explicit methods. 34,35 However, presentations of all of these methods except the polynomial extrapolation assume a relatively small number of nodes. Since this paper considers up to 3 nodes, the current method is limited to the polynomial extrapolation. To generate a more accurate initialization of the stages, the polynomial extrapolation is combined with a lowfidelity propagation to reduce the overall computation time. To accomplish this, iterations of the nonlinear system of equations are first performed using dominant forces with relatively low computation time, e.g., the two-body equation and the J 2 gravity perturbation. After the solution has converged to within a given tolerance, then the high-fidelity force model is used until convergence to ǫ. This provides a warm start for the iterations, and reduces the overall computation cost. A discussion of the effects of the low-fidelity convergence tolerance may be found in Section V.D. Further research may also allow for improved efficiency in stage initialization. IV. Two-Body Propagation The VGL-s integrator is compared to several common propagators to assess computational efficiency and accuracy. As mentioned previously, the DP 8(7) and DP 5(4) propagators are used as a basis of comparison. The DP 5(4) includes a first-same-as-last (FSAL) implementation to reduce the number of force evaluations per integration step by one. A comparison with an eighth-order Gauss-Jackson propagator (GJ 8) is also included. Implementation of this integrator is based on Berry and Healy 36 with usually only one correction per time step, i.e., one force-model evaluation per integrator step. Hull, et al. 37 introduced a series of tests that consider two-body propagation with orbits of various eccentricities. The results of a given ODE solver may then be compared to the analytic result of Kepler s equation. Such tests were also used in the more extensive solver comparison by Montenbruck. 38 These tests are designated as D1 through D5, with eccentricities ranging from.1 to.9 in increments of.2. This section presents results of a similar test with the DP 5(4), DP 8(7), GJ 8, and VGL-s methods. Additionally, a D test is added with an eccentricity of.. The normalized initial conditions of the propagators are then defined such that the semimajor axis is 1., the inclination is 45, and the gravitational parameter is also 1.. The orbits are propagated until t f = 2, which corresponds to approximately 3.2 revolutions. Since only two-body dynamics are considered for this case, combining low- and high-fidelity descriptions of the satellilte forces is not possible. Hence, the stage initialization only uses extrapolation of the collocation polynomial and the reported number of function calls is the total calls to the two-body force model. These tests are provided here to compare the methods using already existing test cases in the community, and provide some insight into the effects of design parameters on the orbit propagation in a simplified system. Before comparing to the other integrators, Fig. 2 illustrates the variations in the integrator efficiency as a function of the maximum number of iterations M and the number of nodes s. Precision is defined as ( 6 ) 1/2 precision = log (y i (t f ) ŷ i (t f )) 2 (28) i=1 where ŷ i is the i-th component of the solution generated via Kepler s equation. The number of effective function calls designates the number of evaluations if computations for each node are run in parallel, and 8 of 16

9 Function Calls Function Calls Effective Fcn. Calls Precision s = 5, M = 1 s = 1, M = 2 s = 15, M = 2 s = 2, M = 26 s = 25, M = 33 Effective Fcn. Calls Precision s = 5, M = 5 s = 1, M = 1 s = 15, M = 5 s = 2, M = 7 s = 25, M = 9 Figure 2. Work-precision plots for the D (left) and D4 (right) cases for different design parameter s and M. only represent a theoretical value for computation work load. These results indicate a coupling between the eccentricity, s, and M for the optimal method. Additionally, arbitrarily increasing the number of nodes, even though it increases the order of the integrator, may yield an increase in the total number of function evaluations. This is contrary to the explicit methods where higher order methods typically allow for longer step sizes and reduced computation times. As mentioned previously, this is due to the oversampling at the endpoints as s increases. Fcn. Calls Fcn. Calls Fcn. Calls 8 7 D D D Precision DP 5(4) DP 8(7) GJ 8 VGL-s D1 D3 D Precision VGL-s, eff. Figure 3. D-D5 work-precision diagrams for various integration methods. Figure 3 provides a comparison of the different integrators for the D through D5 test cases. The presented results come in the form of work-precision plots. Here, the VGL-s methods use 2 nodes for the D-D2 cases, 15 nodes for D3, and 1 nodes for D4 and D5. For highly accurate solutions, the VGL-s methods require the same number of function calls as the DP 8(7) methods for the D-D2 cases. The work required for the VGL-s method then increases faster as a function of eccentricity than DP 8(7). However, it still performs better than DP 5(4). In terms of effective stages, the VGL-s methods prove to be the most efficient for these two-body cases. 9 of 16

10 V. Higher Fidelity Propagation This section presents the efficiency of the VGL-s methods for higher fidelity propagation. As explained below, the forces describing the satellite motion are expanded for a collection of more realistic scenarios. At this point, the combination of low- and high-fidelity propagations is introduced to reduce total computation time. V.A. Test Description In the remaining sections, the tests of the VGL-s methods consider three orbits: a low-earth orbit (LEO), a geosynchronous orbit (GEO), and a Molniya orbit. Initial conditions for these cases may be found in Table 1. Perturbing accelerations include the Cartesian formulation of the spherical harmonic model 39 using the 7 7 GGM2C coefficients, 4 and Sun/Moon third-body perturbations. The positions of the third bodies are determined via the Jet Propulsion Laboratory planetary and lunar ephemerides model DE Each orbit is propagated for three orbit periods with a start time of March 28, 21 :: UTC. Orbit Semimajor Axis (km) Eccentricity Table 1. Orbit Initial Conditions Inclination (deg) Right Ascension of Ascending Node (deg) Argument of Perigee (deg) True Anomaly (deg) LEO Molniya 26, GEO 42, Since no analytic solution exists for orbit propagation using special perturbations, a reference trajectory must be defined to assess propagator accuracy. For this purpose, we use a solution based on the GJ 8 propagatorwith a step size of1s. This step size wasselected to minimize h without causing any accumulated floating point error that creates bias in the precision results. Reported global errors are then the RSS difference between the solution for a given integrator and this trajectory at the final time. V.B. VGL-s Setup To accommodate the increase in propagator fidelity, the VGL-s integrator is modified slightly in comparison with the two-body tests. Specifically, the low-fidelity iteration method previously described is employed for stage initialization. As demonstrated later, this reduces the number of evaluations for the more expensive forces. Here, the low-fidelity model includes the gravitational force of the primary body and the J 2 gravity term, and the reported number of function calls indicates the number of high-fidelity evaluations. Other design parameters for the higher fidelity tests may be found in Table 2. Section III.B discussed a method for initial step size determination, but did not state a specific value for α. Tests demonstrated that the optimal value varies with the orbit, with a brief treatment of the effects of initial step size selection provided in Section V.C. Design parameters used to automatically determine the step size in future tests may also be found in Table 2. A more robust method for determining an initial step size is a subject of future work. Table 2. Orbit Initial Step Size Design Parameters Orbit s α LEO 2 1. Molniya 2 33,333. GEO of 16

11 V.C. Initial Step-Size Selection For these more realistic propagation tests, the initial step size proved to effect the overall performance of the integrator. Although it is not demonstrated here, the step size selection for the embedded RK methods tends to have a relatively small effect on overall efficiency. The results of this section demonstrate some effects on initial step size selection on accuracy and efficiency. Figures 4 and 5 illustrate the effects of step size selection on efficiency and accuracy for the LEO and GEO cases. As seen in the plots on the left, selection of a step size that is too big or small can take a long time to settle on the optimal value. The sharp drop at the end of the plots correspond to rapid reductions in step size to match the final time of the integration. The LEO case exhibits two values where step sizes settle. These are largely determined by the design parameters in Eq. (22), and tests that included different values verified this hypothesis. For the 1, s case, this introduces global error into the solution as indicated by the plot on the right. For the GEO case, any initial step sizes larger than approximately 12. s are rejected due to the lack of convergence in the nonlinear solver. The plots on the right indicate that, as expected, small initial step sizes fail to improve results and are limited by the accumulation of floating-point error Time Step (s) Time (orbit periods) Auto Precision (meters) Initial Step Size (s) Number of Function Calls Figure 4. Evolution of the step size over time for different initial step sizes (left) and the effects of the initial step size on global integration accuracy (right) for the LEO satellite Time Step (s) Time (orbit periods) Auto Precision (meters) Initial Step Size (s) Number of Function Calls Figure 5. Evolution of the step size over time for different initial step sizes (left) and the effects of the initial step size on global integration accuracy (right) for the GEO satellite. Figure 6 provides the results of the same test for the Molniya orbit, and clearly indicate the evoluation of the time step over the orbit period. In this case, rejected step sizes for the first step prevent any extended settling time, i.e., the solution fails to converge for initial step sizes that are too large. Sharp spikes in the left plot correspond to rejected steps, some of which appear periodic. The exact cause is unknown and will be further investigated. V.D. Low-Fidelity Convergence As mentioned previously, this implementation of the VGL-s propagator uses a combination of low- and highfidelity force models to reduce the overall integrator computation time. Fig. 7 illustrates the effect of the 11 of 16

12 Time Step (s) Time (orbit periods) Auto Precision (meters) Initial Step Size (s) Number of Function Calls Figure 6. Evolution of the step size over time for different initial step sizes (left) and the effects of the initial step size on global integration accuracy (right) for the Molniya satellite. low-fidelity calls on the total number of high-fidelity force model evaluations. Effectively, including one lowfidelity call can reduce the number of more expensive evaluations by approximately 2%. This corresponds to the elimination of 1-2 high-fidelity iterations. These results also indicate that more than one iteration does not improve the propagator efficiency, and may actually increase the number of high-fidelity function calls. This results from differences in the low- and high-fidelity solutions, which grow over time. As demonstrated in the previous section, the VGL-s method allows for time steps on the order of hundreds of seconds. Errors in the propagation using a low-fidelity model grow over time and are largest for nodes towards the end of the integration interval. Hence, further iterations cause the solution to begin converging on a solution different from that of the high-fidelity propagator, and additional iterations may be required to correct this error. Molniya LEO Number of Low-Fidelity Iterations Figure 7. Effect of low-fidelity calls on overall work for the LEO and Molniya orbits. 12 of 16

13 V.E. Propagation Efficiency Figure 8 illustrates the number of high-fidelity force model evaluations required to achieve a given accuracy for the LEO case. For a serial implementation, the GJ 8 provides the most computationally efficient method. This is not surprising given that multistep methods tend to require fewer function evaluations then Runge- Kutta methods for scenarios that only require a constant step size. However, the theoretical number of parallel calls to the force model yields the most efficient method. The VGL-2 method does provide a more efficient solver than the embedded Runge-Kutta methods and approaches the efficiency of the GJ 8 method for high-precision integration. Global Integration Error (meters) VGL-2 VGL-2, effective DP54 DP87 GJ Number of Function Calls Figure 8. Work-Precision Plot for the LEO case. Global Integration Error (meters) VGL-2 VGL-2, effective DP54 DP87 GJ Number of Function Calls Figure 9. Work-Precision Plot for the GEO case. The work-precision plot for the GEO case is provided in Fig. 9. For this case, the VGL-2 method performance is still better than that of the DP 8(7) method for accuracies greater than approximately m. However, there is a larger disparity between the GJ 8 and the VGL-2 method at this altitude. Finally, Figure 1 illustrates the efficiency of the VGL-1 method when propagating a Molniya orbit. In this case, which is expected, the GJ 8 is a poor method for orbit propagation. This results from the unnecessary force model evaluations near apoapsis. When comparing the DP 8(7) and the VGL-1 results, thedp8(7)appearstorequirefewerfunctionevaluationsexceptnearaprecisionof1 4 m. Forthiseccentric 13 of 16

14 Global Integration Error (meters) VGL-1 VGL-1, effective DP54 DP87 GJ Number of Function Calls Figure 1. Work-Precision Plot for the Molniya case. case, the number of effective force evaluations greatly reduces the computation time for this eccentric orbit when compared to all other methods. VI. Conclusion This paper presented a variable-step implementation of integration using Gauss-Legendre nodes for orbit propagation, dubbed VGL-s. In combination with the variable-step implementation, a combination of lowand high-fidelity force models allowed for a further reduction in computation load. For the circular orbits considered, the Gauss-Legendre method required fewer function calls than the Dormand-Prince (DP) 8(7) and 5(4) embedded Runge-Kutta integrators, but still needed more evaluations than an eighth-order Gauss- Jackson method (GJ 8). For the Molniya orbit case, the Gauss-Legendre propagator required fewer function calls than the DP 5(4) and GJ 8 propagators, and matched the DP 8(7) method for high precision cases. Assuming force evaluations at each node within an interval may be performed in parallel for a given iteration, the VGL-s method would require less computation time than all of the sequential methods. However, this only represents a theoretical assessment of the computation time required for a parallel implementation. The tests considered also demonstrated the limited improvements in step size as nodes are added to the Gauss-Legendre method. Such a barrier results from the oversampling that occurs near the beginning and end of the integration interval as the number of nodes increase. This result helps provide a baseline for future endeavors that attempt to surpass this limitation. Several elements were identified that necessitate further research to improve robustness of the VGL-s integrator. In addition to the elements already described, an investigation of the quality of the continuous solution will aid in determining the capabilities of the method. As mentioned previously, collocation methods like the VGL-s integrator allows for a continuos approximation of the orbit, and this may be used to provide information on the propagated orbit at intermediate steps. Finally, a full exploration of the computation times when implemented with parallelization will be addressed with future work. Acknowledgements This research was partially funded by the Air Force Research Laboratories. The author thanks Vladimir Rokhlin of the Yale University Department of Mathematics who wrote the original version of the Fortran software used to calculated the Gaussian quadrature nodes and weights. This software was provided through Gregory Beylkin of the University of Colorado Department of Applied Mathematics, and then converted to quadruple precision for this application. 14 of 16

15 References 1 Barrio, R., Palacios, M., and Elipe, A., Chebyshev Collocation Methods for Fast Orbit Determination, Applied Mathematics and Computation, Vol. 99, 1999, pp Beutler, G., Methods of Celestial Mechanics. I: Physical, Mathematical, and Numerical Principles, Springer-Verlag, Berlin Heidelberg New York, 25, pp Bai, X., Modified Chebyshev-Picard Iteration Methods for Solution of Initial Value Problems and Boundary Value Problems, Ph.d. thesis, Texas A&M University, August Herman, A. L. and Conway, B. A., Direct Optimization Using Collocation Based on High-Order Gauss-Lobatto Rules, Journal of Guidance, Control, and Dynamics, Vol. 19, No. 3, May-June 1996, pp Herman, A. L. and Conway, B. A., Optimal, Low-Thrust, Earth-Moon Orbit Transfer, Journal of Guidance, Control, and Dynamics, Vol. 21, No. 1, January-February 1998, pp Ozimek, M. T., Grebow, D. J., and Howell, K. C., Solar Sails and Lunar South Pole Coverage, AIAA/AAS Astrodynamics Specialist Conference, Honolulu, Hawaii, August Ozimek, M. T., Grebow, D. J., and Howell, K. C., A Collocation Approach for Computing Solar Sail Lunar Pole-Sitter Orbits, AIAA/AAS Astrodynamics Specialist Conference, Pittsburgh, PA, August Grebow, D. J., Ozimek, M. T., and Howell, K. C., Design of Optimal Low-Thrust Lunar Pole-Sitter Missions, 19th Annual AAS/AIAA Spaceflight Mechanics Meeting, Savannah, Georgia, February Grebow, D. J., Ozimek, M. T., and Howell, K. C., Advanced modeling of optimal low-thrust lunar pole-sitter trajectories, Acta Astronautica, Vol. 67, No. 7-8, October-November 21, pp Bradley, B. K., Jones, B. A., Beylkin, G., and Axelrad, P., A New Numerical Integration Technique in Astrodynamics, 22nd Annual AAS/AIAA Space Flight Mechanics Meeting, Charleston, SC, Jan Feb Jones, B. A. and Anderson, R. L., A Survey of Symplectic and Collocation Integration Methods for Orbit Propagation, 212 AAS/AIAA Space Flight Mechanics Meeting, Charleston, SC, Jan Feb Hammer, P. C. and Hollingsworth, J. W., Trapezoidal Methods of Approximating Solutions of Differential Equations, Mathematical Tables and Other Aids to Computation, Vol. 9, No. 51, 1955, pp Butcher, J. C., Implicit Runge-Kutta Processes, Mathematics of Computation, Vol. 18, No. 85, January 1964, pp Hairer, E., Lubich, C., and Wanner, G., Geometric Numerical Integration : Structure-Preserving Algorithms for Ordinary Differential Equations, No. 31 in Springer Series in Computational Mathematics, Springer, New York, 2nd ed., 26, pp. 3-34, 326, Iserles, A., A First Course in the Numerical Analysis of Differential Equations, Cambridge University Press, 2nd ed., 29, pp. 43, Ehle, B. L., High Order A-Stable Methods for the Numerical Solution of Systems of D.E. s, BIT Numerical Mathematics, Vol. 8, No. 4, 1968, pp Butcher, J. C., A stability property of implicit Runge-Kutta methods, BIT Numerical Mathematics, Vol. 15, No. 4, 1975, pp Sanz-Serna, J. M., Runge-Kutta schemes for Hamiltonian Systems, BIT Numerical Mathematics, Vol. 28, No. 4, 1988, pp Hairer, E., Wanner, G., and Nørsett, S. P., Solving Ordinary Differential Equations II: Stiff and Differential-Algebraic Problems, Springer-Verlag, Berlin Heidelberg New York, second revised ed., 1993, pp. 119, Sanz-Serna, J. M. and Calvo, M. P., Numerical Hamiltonian Problems, Chapman and Hall, London, UK, 1994, pp , Runge, C., Ueber die numerische Auflösung von Differentialgleichungen, Mathematische Annalen, Vol. 46, No. 2, June 1895, pp Kutta, W. M., Beitrag zur näherungsweisen Integration totaler Differentialgleichungen, Zeitschrift für Mathematik und Physik, Vol. 46, 191, pp Dormand, J. R. and Prince, R. J., A family of embedded Runge-Kutta formulae, Journal of Computational and Applied Mathematics, Vol. 6, No. 1, March 198, pp Prince, R. J. and Dormand, J. R., High order embedded Runge-Kutta formulae, Journal of Computational and Applied Mathematics, Vol. 7, No. 1, March 1981, pp Burrage, K., Parallel and Sequential Methods for Ordinary Differential Equations, Clarendon Press, Oxford, 1995, p Wright, K., Some relationships between implicit Runge-Kutta, collocation and Lanczos τ methods, and their stability properties, BIT Numerical Mathematics, Vol. 1, No. 2, 197, pp van der Houwen, P. J. and Sommeijer, D. P., Parallel iteration of high-order Runge-Kutta methods with stepsize contol, Journal of Computational and Applied Mathematics, Vol. 29, No. 1, 1 January 199, pp Stoffer, D., Variables steps for reversible integration methods, Computing, Vol. 55, No. 1, 1995, pp Calvo, M. P., López-Marcos, M. A., and Sanz-Serna, J. M., Variable step implementation of geometric integrators, Applied Numerical Mathematics, Vol. 28, No. 1, September 1998, pp Gustafsson, K., Control-Theoretic Techniques for Stepsize Selection in Implicit Runge-Kutta Methods, ACM Transactions on Mathematical Software, Vol. 2, No. 4, December 1994, pp Hairer, E., Wanner, G., and Nørsett, S. P., Solving Ordinary Differential Equations I: Nonstiff Problems, Springer-Verlag, Berlin Heidelberg New York, second revised ed., 1993, p Laburta, M. P., Starting Algorithms for IRK Methods, Journal of Computational and Applied Mathematics, Vol. 83, No. 2, October , pp of 16

16 33 Calvo, M.P., High orderstartingiterates forimplicitrunge-kutta methods: animprovementforvariable-stepsymplectic integerators, IMA Journal of Numerical Analysis, Vol. 22, No. 1, 22, pp Calvo, M. P., Laburta, M. P., and Montijano, J. I., Two-step high order starting values for implicit Runge-Kutta methods, Advances in Computational Mathematics, Vol. 19, No. 4, 23, pp Calvo, M.P., Laburta, M. P., and Montijano, J. I., Starting Algorithms for Gauss Runge-Kutta Methods for Hamiltonian Systems, Computers and Mathematics with Applications, Vol. 45, No. 1-3, 23, pp Berry, M. M. and Healy, L. M., Implementation of Gauss-Jackson Integration for Orbit Propagation, Journal of Astronautical Sciences, Vol. 52, No. 3, July-September 24, pp Hull, T. E., Enright, W. H., Fellen, B. M., and Sedgwick, A. E., Comparing Numerical Methods for Ordinary Differential Equations, SIAM Journal on Numerical Analysis, Vol. 9, No. 4, December 1972, pp Montenbruck, O., Numerical Integration Methods for Orbital Motion, Celestial Mechanics and Dynamical Astronomy, Vol. 53, No. 1, 1992, pp Gottlieb, R. G., Fast Gravity, Gravity Partials, Normalized Gravity, Gravity Gradient Torque and Magnetic Field: Derivation, Code and Data, Tech. Rep. NASA Contractor Report , NASA Lyndon B. Johnson Space Center, Houston, TX, February Tapley, B., Ries, J., Bettadpur, S., Chambers, D., Cheng, M., Condi, F., Gunter, B., Kang, Z., Nagel, P., Pastor, R., Pekker, T., Poole, S., and Wang, F., GGM2 - An Improved Earth Gravity Field Model from GRACE, Journal of Geodesy, Vol. 79, No. 8, 25, pp Standish, E. M., JPL Planetary and Lunar Ephemerides, DE45/LE45, Interoffice memorandum IOM 312F-98-48, Jet Propulsion Laboratory, August of 16

Bandlimited implicit Runge Kutta integration for Astrodynamics

Bandlimited implicit Runge Kutta integration for Astrodynamics Celest Mech Dyn Astr (2014) 119:143 168 DOI 10.1007/s10569-014-9551-x ORIGINAL ARTICLE Bandlimited implicit Runge Kutta integration for Astrodynamics Ben K. Bradley Brandon A. Jones Gregory Beylkin Kristian

More information

Bandlimited Implicit Runge-Kutta Integration for Astrodynamics

Bandlimited Implicit Runge-Kutta Integration for Astrodynamics Celestial Mechanics and Dynamical Astronomy manuscript No. (will be inserted by the editor) Bandlimited Implicit Runge-Kutta Integration for Astrodynamics Ben K. Bradley Brandon A. Jones Gregory Beylkin

More information

RADIALLY ADAPTIVE EVALUATION OF THE SPHERICAL HARMONIC GRAVITY SERIES FOR NUMERICAL ORBITAL PROPAGATION

RADIALLY ADAPTIVE EVALUATION OF THE SPHERICAL HARMONIC GRAVITY SERIES FOR NUMERICAL ORBITAL PROPAGATION AAS 15-440 RADIALLY ADAPTIVE EVALUATION OF THE SPHERICAL HARMONIC GRAVITY SERIES FOR NUMERICAL ORBITAL PROPAGATION Austin B. Probe, * Brent Macomber,* Julie I. Read,* Robyn M. Woollands,* and John L. Junkins

More information

A NEW NUMERICAL INTEGRATION TECHNIQUE IN ASTRODYNAMICS

A NEW NUMERICAL INTEGRATION TECHNIQUE IN ASTRODYNAMICS AAS 12-216 A NEW NUMERICAL INTEGRATION TECHNIQUE IN ASTRODYNAMICS Ben K. Bradley, Brandon A. Jones, Gregory Beylkin, and Penina Axelrad INTRODUCTION This paper describes a new method of numerical integration

More information

Astrodynamics (AERO0024)

Astrodynamics (AERO0024) Astrodynamics (AERO0024) 5. Numerical Methods Gaëtan Kerschen Space Structures & Systems Lab (S3L) Why Different Propagators? Analytic propagation: Better understanding of the perturbing forces. Useful

More information

Orbit and uncertainty propagation: a comparison of Gauss Legendre-, Dormand Prince-, and Chebyshev Picard-based approaches

Orbit and uncertainty propagation: a comparison of Gauss Legendre-, Dormand Prince-, and Chebyshev Picard-based approaches Celest Mech Dyn Astr DOI 1.17/s1569-13-9522-7 ORIGINAL ARTICLE Orbit and uncertainty propagation: a comparison of Gauss Legendre-, Dormand Prince-, and Chebyshev Picard-based approaches Jeffrey M. Aristoff

More information

Terminal Convergence Approximation Modified Chebyshev Picard Iteration for efficient numerical integration of orbital trajectories

Terminal Convergence Approximation Modified Chebyshev Picard Iteration for efficient numerical integration of orbital trajectories Terminal Convergence Approximation Modified Chebyshev Picard Iteration for efficient numerical integration of orbital trajectories Austin B. Probe Texas A&M University Brent Macomber, Donghoon Kim, Robyn

More information

IMPLICIT RUNGE-KUTTA METHODS FOR UNCERTAINTY PROPAGATION

IMPLICIT RUNGE-KUTTA METHODS FOR UNCERTAINTY PROPAGATION IMPLICIT RUNGE-KUTTA METHODS FOR UNCERTAINTY PROPAGATION Jeffrey M. Aristoff, Joshua T. Horwood, and Aubrey B. Poore Numerica Corporation, 485 Hahns Peak Drive, Suite, Loveland CO, 8538 ABSTRACT Accurate

More information

Geometric Numerical Integration

Geometric Numerical Integration Geometric Numerical Integration (Ernst Hairer, TU München, winter 2009/10) Development of numerical ordinary differential equations Nonstiff differential equations (since about 1850), see [4, 2, 1] Adams

More information

Multistage Methods I: Runge-Kutta Methods

Multistage Methods I: Runge-Kutta Methods Multistage Methods I: Runge-Kutta Methods Varun Shankar January, 0 Introduction Previously, we saw that explicit multistep methods (AB methods) have shrinking stability regions as their orders are increased.

More information

Reducing round-off errors in symmetric multistep methods

Reducing round-off errors in symmetric multistep methods Reducing round-off errors in symmetric multistep methods Paola Console a, Ernst Hairer a a Section de Mathématiques, Université de Genève, 2-4 rue du Lièvre, CH-1211 Genève 4, Switzerland. (Paola.Console@unige.ch,

More information

Efficiency of Runge-Kutta Methods in Solving Simple Harmonic Oscillators

Efficiency of Runge-Kutta Methods in Solving Simple Harmonic Oscillators MATEMATIKA, 8, Volume 3, Number, c Penerbit UTM Press. All rights reserved Efficiency of Runge-Kutta Methods in Solving Simple Harmonic Oscillators Annie Gorgey and Nor Azian Aini Mat Department of Mathematics,

More information

Semi-implicit Krylov Deferred Correction Methods for Ordinary Differential Equations

Semi-implicit Krylov Deferred Correction Methods for Ordinary Differential Equations Semi-implicit Krylov Deferred Correction Methods for Ordinary Differential Equations Sunyoung Bu University of North Carolina Department of Mathematics CB # 325, Chapel Hill USA agatha@email.unc.edu Jingfang

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 9 Initial Value Problems for Ordinary Differential Equations Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign

More information

Long-Term Evolution of High Earth Orbits: Effects of Direct Solar Radiation Pressure and Comparison of Trajectory Propagators

Long-Term Evolution of High Earth Orbits: Effects of Direct Solar Radiation Pressure and Comparison of Trajectory Propagators Long-Term Evolution of High Earth Orbits: Effects of Direct Solar Radiation Pressure and Comparison of Trajectory Propagators by L. Anselmo and C. Pardini (Luciano.Anselmo@isti.cnr.it & Carmen.Pardini@isti.cnr.it)

More information

CS 450 Numerical Analysis. Chapter 9: Initial Value Problems for Ordinary Differential Equations

CS 450 Numerical Analysis. Chapter 9: Initial Value Problems for Ordinary Differential Equations Lecture slides based on the textbook Scientific Computing: An Introductory Survey by Michael T. Heath, copyright c 2018 by the Society for Industrial and Applied Mathematics. http://www.siam.org/books/cl80

More information

NUMERICAL INTEGRATION OF A SATELLITE ORBIT WITH KS TRANSFORMATION

NUMERICAL INTEGRATION OF A SATELLITE ORBIT WITH KS TRANSFORMATION NUMERICAL INTEGRATION OF A SATELLITE ORBIT WITH KS TRANSFORMATION Jhonathan Murcia Piñeros 1 Maxime Koffi 1 Helio Koiti Kuga 1, 2 jhonathan.pineros@inpe.br koffi.maxime@yahoo.com helio.kuga@inpe.br 1 INPE

More information

A Gauss Lobatto quadrature method for solving optimal control problems

A Gauss Lobatto quadrature method for solving optimal control problems ANZIAM J. 47 (EMAC2005) pp.c101 C115, 2006 C101 A Gauss Lobatto quadrature method for solving optimal control problems P. Williams (Received 29 August 2005; revised 13 July 2006) Abstract This paper proposes

More information

Solving Orthogonal Matrix Differential Systems in Mathematica

Solving Orthogonal Matrix Differential Systems in Mathematica Solving Orthogonal Matrix Differential Systems in Mathematica Mark Sofroniou 1 and Giulia Spaletta 2 1 Wolfram Research, Champaign, Illinois, USA. marks@wolfram.com 2 Mathematics Department, Bologna University,

More information

Sequential Orbit Determination with the. Cubed-Sphere Gravity Model

Sequential Orbit Determination with the. Cubed-Sphere Gravity Model Sequential Orbit Determination with the Cubed-Sphere Gravity Model Brandon A. Jones 1, George H. Born 2, and Gregory Beylkin 3 University of Colorado, Boulder, CO, 80309, USA The cubed-sphere model provides

More information

Variable Step Runge-Kutta-Nyström Methods for the Numerical Solution of Reversible Systems

Variable Step Runge-Kutta-Nyström Methods for the Numerical Solution of Reversible Systems Variable Step Runge-Kutta-Nyström Methods for the Numerical Solution of Reversible Systems J. R. Cash and S. Girdlestone Department of Mathematics, Imperial College London South Kensington London SW7 2AZ,

More information

Runge-Kutta Theory and Constraint Programming Julien Alexandre dit Sandretto Alexandre Chapoutot. Department U2IS ENSTA ParisTech SCAN Uppsala

Runge-Kutta Theory and Constraint Programming Julien Alexandre dit Sandretto Alexandre Chapoutot. Department U2IS ENSTA ParisTech SCAN Uppsala Runge-Kutta Theory and Constraint Programming Julien Alexandre dit Sandretto Alexandre Chapoutot Department U2IS ENSTA ParisTech SCAN 2016 - Uppsala Contents Numerical integration Runge-Kutta with interval

More information

Energy-Preserving Runge-Kutta methods

Energy-Preserving Runge-Kutta methods Energy-Preserving Runge-Kutta methods Fasma Diele, Brigida Pace Istituto per le Applicazioni del Calcolo M. Picone, CNR, Via Amendola 122, 70126 Bari, Italy f.diele@ba.iac.cnr.it b.pace@ba.iac.cnr.it SDS2010,

More information

Lecture Notes to Accompany. Scientific Computing An Introductory Survey. by Michael T. Heath. Chapter 9

Lecture Notes to Accompany. Scientific Computing An Introductory Survey. by Michael T. Heath. Chapter 9 Lecture Notes to Accompany Scientific Computing An Introductory Survey Second Edition by Michael T. Heath Chapter 9 Initial Value Problems for Ordinary Differential Equations Copyright c 2001. Reproduction

More information

Third Body Perturbation

Third Body Perturbation Third Body Perturbation p. 1/30 Third Body Perturbation Modeling the Space Environment Manuel Ruiz Delgado European Masters in Aeronautics and Space E.T.S.I. Aeronáuticos Universidad Politécnica de Madrid

More information

SOME PROPERTIES OF SYMPLECTIC RUNGE-KUTTA METHODS

SOME PROPERTIES OF SYMPLECTIC RUNGE-KUTTA METHODS SOME PROPERTIES OF SYMPLECTIC RUNGE-KUTTA METHODS ERNST HAIRER AND PIERRE LEONE Abstract. We prove that to every rational function R(z) satisfying R( z)r(z) = 1, there exists a symplectic Runge-Kutta method

More information

Southern Methodist University.

Southern Methodist University. Title: Continuous extensions Name: Lawrence F. Shampine 1, Laurent O. Jay 2 Affil./Addr. 1: Department of Mathematics Southern Methodist University Dallas, TX 75275 USA Phone: +1 (972) 690-8439 E-mail:

More information

Investigation on the Most Efficient Ways to Solve the Implicit Equations for Gauss Methods in the Constant Stepsize Setting

Investigation on the Most Efficient Ways to Solve the Implicit Equations for Gauss Methods in the Constant Stepsize Setting Applied Mathematical Sciences, Vol. 12, 2018, no. 2, 93-103 HIKARI Ltd, www.m-hikari.com https://doi.org/10.12988/ams.2018.711340 Investigation on the Most Efficient Ways to Solve the Implicit Equations

More information

Chapter 6 - Ordinary Differential Equations

Chapter 6 - Ordinary Differential Equations Chapter 6 - Ordinary Differential Equations 7.1 Solving Initial-Value Problems In this chapter, we will be interested in the solution of ordinary differential equations. Ordinary differential equations

More information

Validated Explicit and Implicit Runge-Kutta Methods

Validated Explicit and Implicit Runge-Kutta Methods Validated Explicit and Implicit Runge-Kutta Methods Alexandre Chapoutot joint work with Julien Alexandre dit Sandretto and Olivier Mullier U2IS, ENSTA ParisTech 8th Small Workshop on Interval Methods,

More information

The collocation method for ODEs: an introduction

The collocation method for ODEs: an introduction 058065 - Collocation Methods for Volterra Integral Related Functional Differential The collocation method for ODEs: an introduction A collocation solution u h to a functional equation for example an ordinary

More information

Parallel Methods for ODEs

Parallel Methods for ODEs Parallel Methods for ODEs Levels of parallelism There are a number of levels of parallelism that are possible within a program to numerically solve ODEs. An obvious place to start is with manual code restructuring

More information

CS520: numerical ODEs (Ch.2)

CS520: numerical ODEs (Ch.2) .. CS520: numerical ODEs (Ch.2) Uri Ascher Department of Computer Science University of British Columbia ascher@cs.ubc.ca people.cs.ubc.ca/ ascher/520.html Uri Ascher (UBC) CPSC 520: ODEs (Ch. 2) Fall

More information

Improved Starting Methods for Two-Step Runge Kutta Methods of Stage-Order p 3

Improved Starting Methods for Two-Step Runge Kutta Methods of Stage-Order p 3 Improved Starting Methods for Two-Step Runge Kutta Methods of Stage-Order p 3 J.H. Verner August 3, 2004 Abstract. In [5], Jackiewicz and Verner derived formulas for, and tested the implementation of two-step

More information

CHAPTER 10: Numerical Methods for DAEs

CHAPTER 10: Numerical Methods for DAEs CHAPTER 10: Numerical Methods for DAEs Numerical approaches for the solution of DAEs divide roughly into two classes: 1. direct discretization 2. reformulation (index reduction) plus discretization Direct

More information

NUMERICAL METHODS TO GENERATE SOLAR SAIL TRAJECTORIES

NUMERICAL METHODS TO GENERATE SOLAR SAIL TRAJECTORIES NUMERICAL METHODS TO GENERATE SOLAR SAIL TRAJECTORIES Geoffrey G. Wawrzyniak and Kathleen C. Howell Purdue University, West Lafayette, Indiana gwawrzyn@purdue.edu ABSTRACT Solar sail trajectory design

More information

Astrodynamics (AERO0024)

Astrodynamics (AERO0024) Astrodynamics (AERO0024) 4B. Non-Keplerian Motion Gaëtan Kerschen Space Structures & Systems Lab (S3L) 2. Two-body problem 4.1 Dominant perturbations Orbital elements (a,e,i,ω,ω) are constant Real satellites

More information

Astrodynamics (AERO0024)

Astrodynamics (AERO0024) Astrodynamics (AERO0024) L04: Non-Keplerian Motion Gaëtan Kerschen Space Structures & Systems Lab (S3L) Non-Keplerian Motion 4 Dominant Perturbations Analytic Treatment Numerical Methods Concluding Remarks

More information

LYAPUNOV-BASED ELLIPTICAL TO CIRCULAR PLANAR ORBIT TRANSFERS IN LEVI-CIVITA COORDINATES

LYAPUNOV-BASED ELLIPTICAL TO CIRCULAR PLANAR ORBIT TRANSFERS IN LEVI-CIVITA COORDINATES (Preprint) AAS 2-66 LYAPUNOV-BASED ELLIPTICAL TO CIRCULAR PLANAR ORBIT TRANSFERS IN LEVI-CIVITA COORDINATES Sonia Hernandez, Maruthi R. Akella, and Cesar A. Ocampo INTRODUCTION We consider planar orbit

More information

The Milne error estimator for stiff problems

The Milne error estimator for stiff problems 13 R. Tshelametse / SAJPAM. Volume 4 (2009) 13-28 The Milne error estimator for stiff problems Ronald Tshelametse Department of Mathematics University of Botswana Private Bag 0022 Gaborone, Botswana. E-mail

More information

Starting Methods for Two-Step Runge Kutta Methods of Stage-Order 3 and Order 6

Starting Methods for Two-Step Runge Kutta Methods of Stage-Order 3 and Order 6 Cambridge International Science Publishing Cambridge CB1 6AZ Great Britain Journal of Computational Methods in Sciences and Engineering vol. 2, no. 3, 2, pp. 1 3 ISSN 1472 7978 Starting Methods for Two-Step

More information

THIRD-BODY PERTURBATION USING A SINGLE AVERAGED MODEL

THIRD-BODY PERTURBATION USING A SINGLE AVERAGED MODEL INPE-1183-PRE/67 THIRD-BODY PERTURBATION USING A SINGLE AVERAGED MODEL Carlos Renato Huaura Solórzano Antonio Fernando Bertachini de Almeida Prado ADVANCES IN SPACE DYNAMICS : CELESTIAL MECHANICS AND ASTRONAUTICS,

More information

High-order Symmetric Schemes for the Energy Conservation of Polynomial Hamiltonian Problems 1 2

High-order Symmetric Schemes for the Energy Conservation of Polynomial Hamiltonian Problems 1 2 European Society of Computational Methods in Sciences and Engineering (ESCMSE) Journal of Numerical Analysis, Industrial and Applied Mathematics (JNAIAM) vol 4, no -2, 29, pp 87- ISSN 79 84 High-order

More information

High-order symmetric schemes for the energy conservation of polynomial Hamiltonian problems.

High-order symmetric schemes for the energy conservation of polynomial Hamiltonian problems. High-order symmetric schemes for the energy conservation of polynomial Hamiltonian problems. Felice Iavernaro and Donato Trigiante Abstract We define a class of arbitrary high order symmetric one-step

More information

COMBINED EXPLICIT-IMPLICIT TAYLOR SERIES METHODS

COMBINED EXPLICIT-IMPLICIT TAYLOR SERIES METHODS COMBINED EXPLICIT-IMPLICIT TAYLOR SERIES METHODS S.N. Dimova 1, I.G. Hristov 1, a, R.D. Hristova 1, I V. Puzynin 2, T.P. Puzynina 2, Z.A. Sharipov 2, b, N.G. Shegunov 1, Z.K. Tukhliev 2 1 Sofia University,

More information

Optimization of Orbital Transfer of Electrodynamic Tether Satellite by Nonlinear Programming

Optimization of Orbital Transfer of Electrodynamic Tether Satellite by Nonlinear Programming Optimization of Orbital Transfer of Electrodynamic Tether Satellite by Nonlinear Programming IEPC-2015-299 /ISTS-2015-b-299 Presented at Joint Conference of 30th International Symposium on Space Technology

More information

On Directional Measurement Representation in Orbit Determination

On Directional Measurement Representation in Orbit Determination On Directional Measurement Representation in Orbit Determination Evan M. Ward and Greg Carbott U.S. Naval Research Lab, Washington, DC 20375 Precision Orbit Determination (OD) is often critical for successful

More information

A SYMBOLIC-NUMERIC APPROACH TO THE SOLUTION OF THE BUTCHER EQUATIONS

A SYMBOLIC-NUMERIC APPROACH TO THE SOLUTION OF THE BUTCHER EQUATIONS CANADIAN APPLIED MATHEMATICS QUARTERLY Volume 17, Number 3, Fall 2009 A SYMBOLIC-NUMERIC APPROACH TO THE SOLUTION OF THE BUTCHER EQUATIONS SERGEY KHASHIN ABSTRACT. A new approach based on the use of new

More information

The family of Runge Kutta methods with two intermediate evaluations is defined by

The family of Runge Kutta methods with two intermediate evaluations is defined by AM 205: lecture 13 Last time: Numerical solution of ordinary differential equations Today: Additional ODE methods, boundary value problems Thursday s lecture will be given by Thomas Fai Assignment 3 will

More information

Fourth-order symplectic exponentially-fitted modified Runge-Kutta methods of the Gauss type: a review

Fourth-order symplectic exponentially-fitted modified Runge-Kutta methods of the Gauss type: a review Fourth-order symplectic exponentially-fitted modified Runge-Kutta methods of the Gauss type: a review G. Vanden Berghe and M. Van Daele Vakgroep Toegepaste Wiskunde en Informatica, Universiteit Gent, Krijgslaan

More information

Butcher tableau Can summarize an s + 1 stage Runge Kutta method using a triangular grid of coefficients

Butcher tableau Can summarize an s + 1 stage Runge Kutta method using a triangular grid of coefficients AM 205: lecture 13 Last time: ODE convergence and stability, Runge Kutta methods Today: the Butcher tableau, multi-step methods, boundary value problems Butcher tableau Can summarize an s + 1 stage Runge

More information

Numerical Methods for Differential Equations

Numerical Methods for Differential Equations Numerical Methods for Differential Equations Chapter 2: Runge Kutta and Multistep Methods Gustaf Söderlind Numerical Analysis, Lund University Contents V4.16 1. Runge Kutta methods 2. Embedded RK methods

More information

A SYMPLECTIC KEPLERIAN MAP FOR PERTURBED TWO-BODY DYNAMICS. Oier Peñagaricano Muñoa 1, Daniel J. Scheeres 2

A SYMPLECTIC KEPLERIAN MAP FOR PERTURBED TWO-BODY DYNAMICS. Oier Peñagaricano Muñoa 1, Daniel J. Scheeres 2 AIAA/AAS Astrodynamics Specialist Conference and Exhibit 8 - August 008, Honolulu, Hawaii AIAA 008-7068 AIAA 008-7068 A SYMPLECTIC KEPLERIAN MAP FOR PERTURBED TWO-BODY DYNAMICS Oier Peñagaricano Muñoa,

More information

REVERSIBLE LONG-TERM INTEGRATION WITH VARIABLE STEPSIZES. 1. Introduction. We consider the numerical treatment of systems

REVERSIBLE LONG-TERM INTEGRATION WITH VARIABLE STEPSIZES. 1. Introduction. We consider the numerical treatment of systems SIAM J. SCI. COMPUT. c 1997 Society for Industrial and Applied Mathematics Vol. 18, No. 1, pp. 257 269, January 1997 014 REVERSIBLE LONG-TERM INTEGRATION WITH VARIABLE STEPSIZES ERNST HAIRER AND DANIEL

More information

LOW-COST LUNAR COMMUNICATION AND NAVIGATION

LOW-COST LUNAR COMMUNICATION AND NAVIGATION LOW-COST LUNAR COMMUNICATION AND NAVIGATION Keric Hill, Jeffrey Parker, George H. Born, and Martin W. Lo Introduction Spacecraft in halo orbits near the Moon could relay communications for lunar missions

More information

Ordinary differential equations - Initial value problems

Ordinary differential equations - Initial value problems Education has produced a vast population able to read but unable to distinguish what is worth reading. G.M. TREVELYAN Chapter 6 Ordinary differential equations - Initial value problems In this chapter

More information

CHAPTER 5: Linear Multistep Methods

CHAPTER 5: Linear Multistep Methods CHAPTER 5: Linear Multistep Methods Multistep: use information from many steps Higher order possible with fewer function evaluations than with RK. Convenient error estimates. Changing stepsize or order

More information

Study the Numerical Methods for Solving System of Equation

Study the Numerical Methods for Solving System of Equation Study the Numerical Methods for Solving System of Equation Ravi Kumar 1, Mr. Raj Kumar Duhan 2 1 M. Tech. (M.E), 4 th Semester, UIET MDU Rohtak 2 Assistant Professor, Dept. of Mechanical Engg., UIET MDU

More information

ON THE STABILITY OF APPROXIMATE DISPLACED LUNAR ORBITS

ON THE STABILITY OF APPROXIMATE DISPLACED LUNAR ORBITS AAS 1-181 ON THE STABILITY OF APPROXIMATE DISPLACED LUNAR ORBITS Jules Simo and Colin R. McInnes INTRODUCTION In a prior study, a methodology was developed for computing approximate large displaced orbits

More information

8.1 Introduction. Consider the initial value problem (IVP):

8.1 Introduction. Consider the initial value problem (IVP): 8.1 Introduction Consider the initial value problem (IVP): y dy dt = f(t, y), y(t 0)=y 0, t 0 t T. Geometrically: solutions are a one parameter family of curves y = y(t) in(t, y)-plane. Assume solution

More information

369 Nigerian Research Journal of Engineering and Environmental Sciences 2(2) 2017 pp

369 Nigerian Research Journal of Engineering and Environmental Sciences 2(2) 2017 pp 369 Nigerian Research Journal of Engineering and Environmental Sciences 2(2) 27 pp. 369-374 Original Research Article THIRD DERIVATIVE MULTISTEP METHODS WITH OPTIMIZED REGIONS OF ABSOLUTE STABILITY FOR

More information

Orbital and Celestial Mechanics

Orbital and Celestial Mechanics Orbital and Celestial Mechanics John P. Vinti Edited by Gim J. Der TRW Los Angeles, California Nino L. Bonavito NASA Goddard Space Flight Center Greenbelt, Maryland Volume 177 PROGRESS IN ASTRONAUTICS

More information

Global Optimization of Impulsive Interplanetary Transfers

Global Optimization of Impulsive Interplanetary Transfers Global Optimization of Impulsive Interplanetary Transfers R. Armellin, Dipartimento di Ingegneria Aerospaziale, Politecnico di Milano Taylor Methods and Computer Assisted Proofs Barcelona, June, 3 7, 2008

More information

Orbit Representation

Orbit Representation 7.1 Fundamentals 223 For this purpose, code-pseudorange and carrier observations are made of all visible satellites at all monitor stations. The data are corrected for ionospheric and tropospheric delays,

More information

SYMMETRIC PROJECTION METHODS FOR DIFFERENTIAL EQUATIONS ON MANIFOLDS

SYMMETRIC PROJECTION METHODS FOR DIFFERENTIAL EQUATIONS ON MANIFOLDS BIT 0006-3835/00/4004-0726 $15.00 2000, Vol. 40, No. 4, pp. 726 734 c Swets & Zeitlinger SYMMETRIC PROJECTION METHODS FOR DIFFERENTIAL EQUATIONS ON MANIFOLDS E. HAIRER Section de mathématiques, Université

More information

Jovian Problem: Performance of Some High-Order Numerical Integrators

Jovian Problem: Performance of Some High-Order Numerical Integrators American Journal of Computational Mathematics 013 3 195-04 http://dx.doi.org/10.43/acm.013.3308 Published Online September 013 (http://www.scirp.org/ournal/acm) Jovian Problem: Performance of Some High-Order

More information

COVARIANCE DETERMINATION, PROPAGATION AND INTERPOLATION TECHNIQUES FOR SPACE SURVEILLANCE. European Space Surveillance Conference 7-9 June 2011

COVARIANCE DETERMINATION, PROPAGATION AND INTERPOLATION TECHNIQUES FOR SPACE SURVEILLANCE. European Space Surveillance Conference 7-9 June 2011 COVARIANCE DETERMINATION, PROPAGATION AND INTERPOLATION TECHNIQUES FOR SPACE SURVEILLANCE European Space Surveillance Conference 7-9 June 2011 Pablo García (1), Diego Escobar (1), Alberto Águeda (1), Francisco

More information

Four Point Gauss Quadrature Runge Kuta Method Of Order 8 For Ordinary Differential Equations

Four Point Gauss Quadrature Runge Kuta Method Of Order 8 For Ordinary Differential Equations International journal of scientific and technical research in engineering (IJSTRE) www.ijstre.com Volume Issue ǁ July 206. Four Point Gauss Quadrature Runge Kuta Method Of Order 8 For Ordinary Differential

More information

Two-Point Boundary Value Problem and Optimal Feedback Control based on Differential Algebra

Two-Point Boundary Value Problem and Optimal Feedback Control based on Differential Algebra Two-Point Boundary Value Problem and Optimal Feedback Control based on Differential Algebra Politecnico di Milano Department of Aerospace Engineering Milan, Italy Taylor Methods and Computer Assisted Proofs

More information

Faster Kinetics: Accelerate Your Finite-Rate Combustion Simulation with GPUs

Faster Kinetics: Accelerate Your Finite-Rate Combustion Simulation with GPUs Faster Kinetics: Accelerate Your Finite-Rate Combustion Simulation with GPUs Christopher P. Stone, Ph.D. Computational Science and Engineering, LLC Kyle Niemeyer, Ph.D. Oregon State University 2 Outline

More information

Analysis of frozen orbits for solar sails

Analysis of frozen orbits for solar sails Trabalho apresentado no XXXV CNMAC, Natal-RN, 2014. Analysis of frozen orbits for solar sails J. P. S. Carvalho, R. Vilhena de Moraes, Instituto de Ciência e Tecnologia, UNIFESP, São José dos Campos -

More information

Solving Ordinary Differential equations

Solving Ordinary Differential equations Solving Ordinary Differential equations Taylor methods can be used to build explicit methods with higher order of convergence than Euler s method. The main difficult of these methods is the computation

More information

Fifth-Order Improved Runge-Kutta Method With Reduced Number of Function Evaluations

Fifth-Order Improved Runge-Kutta Method With Reduced Number of Function Evaluations Australian Journal of Basic and Applied Sciences, 6(3): 9-5, 22 ISSN 99-88 Fifth-Order Improved Runge-Kutta Method With Reduced Number of Function Evaluations Faranak Rabiei, Fudziah Ismail Department

More information

Experimental Analysis of Low Earth Orbit Satellites due to Atmospheric Perturbations

Experimental Analysis of Low Earth Orbit Satellites due to Atmospheric Perturbations Experimental Analysis of Low Earth Orbit Satellites due to Atmospheric Perturbations Aman Saluja #1, Manish Bansal #2, M Raja #3, Mohd Maaz #4 #Aerospace Department, University of Petroleum and Energy

More information

THE θ-methods IN THE NUMERICAL SOLUTION OF DELAY DIFFERENTIAL EQUATIONS. Karel J. in t Hout, Marc N. Spijker Leiden, The Netherlands

THE θ-methods IN THE NUMERICAL SOLUTION OF DELAY DIFFERENTIAL EQUATIONS. Karel J. in t Hout, Marc N. Spijker Leiden, The Netherlands THE θ-methods IN THE NUMERICAL SOLUTION OF DELAY DIFFERENTIAL EQUATIONS Karel J. in t Hout, Marc N. Spijker Leiden, The Netherlands 1. Introduction This paper deals with initial value problems for delay

More information

IMPLICIT INTERVAL MULTISTEP METHODS FOR SOLVING THE INITIAL VALUE PROBLEM

IMPLICIT INTERVAL MULTISTEP METHODS FOR SOLVING THE INITIAL VALUE PROBLEM COMPUTATIONAL METHODS IN SCIENCE AND TECHNOLOGY 8 (1), 17-30 (2002) IMPLICIT INTERVAL MULTISTEP METHODS FOR SOLVING THE INITIAL VALUE PROBLEM MAŁGORZATA JANKOWSKA 1, ANDRZEJ MARCINIAK 1,2 1 Poznań University

More information

Long simulations of the Solar System: Brouwer s Law and chaos

Long simulations of the Solar System: Brouwer s Law and chaos ANZIAM J. 46 (E) pp.c1086 C1103, 2005 C1086 Long simulations of the Solar System: Brouwer s Law and chaos K. R. Grazier W. I. Newman James M. Hyman Philip. W. Sharp (received 28 October 2004, revised 18

More information

CALCULATION OF POSITION AND VELOCITY OF GLONASS SATELLITE BASED ON ANALYTICAL THEORY OF MOTION

CALCULATION OF POSITION AND VELOCITY OF GLONASS SATELLITE BASED ON ANALYTICAL THEORY OF MOTION ARTIFICIAL SATELLITES, Vol. 50, No. 3 2015 DOI: 10.1515/arsa-2015-0008 CALCULATION OF POSITION AND VELOCITY OF GLONASS SATELLITE BASED ON ANALYTICAL THEORY OF MOTION W. Góral, B. Skorupa AGH University

More information

DEFINITION OF A REFERENCE ORBIT FOR THE SKYBRIDGE CONSTELLATION SATELLITES

DEFINITION OF A REFERENCE ORBIT FOR THE SKYBRIDGE CONSTELLATION SATELLITES DEFINITION OF A REFERENCE ORBIT FOR THE SKYBRIDGE CONSTELLATION SATELLITES Pierre Rozanès (pierre.rozanes@cnes.fr), Pascal Brousse (pascal.brousse@cnes.fr), Sophie Geffroy (sophie.geffroy@cnes.fr) CNES,

More information

Enhancements to Modified Chebyshev-Picard Iteration Efficiency for Perturbed Orbit Propagation

Enhancements to Modified Chebyshev-Picard Iteration Efficiency for Perturbed Orbit Propagation Copyright 2016 Tech Science Press CMES, vol.111, no.1, pp.29-64, 2016 Enhancements to Modified Chebyshev-Picard Iteration Efficiency for Perturbed Orbit Propagation B. Macomber 1, A. B. Probe 1, R. Woollands

More information

16.7 Multistep, Multivalue, and Predictor-Corrector Methods

16.7 Multistep, Multivalue, and Predictor-Corrector Methods 16.7 Multistep, Multivalue, and Predictor-Corrector Methods 747 } free_vector(ysav,1,nv); free_vector(yerr,1,nv); free_vector(x,1,kmaxx); free_vector(err,1,kmaxx); free_matrix(dfdy,1,nv,1,nv); free_vector(dfdx,1,nv);

More information

Almost Runge-Kutta Methods Of Orders Up To Five

Almost Runge-Kutta Methods Of Orders Up To Five Almost Runge-Kutta Methods Of Orders Up To Five ABRAHAM OCHOCHE Department of Information Technology, Federal University of Technology, Minna, Niger State PMB 65, Nigeria abochoche@gmailcom PETER NDAJAH

More information

Verified High-Order Optimal Control in Space Flight Dynamics

Verified High-Order Optimal Control in Space Flight Dynamics Verified High-Order Optimal Control in Space Flight Dynamics R. Armellin, P. Di Lizia, F. Bernelli-Zazzera K. Makino and M. Berz Fourth International Workshop on Taylor Methods Boca Raton, December 16

More information

Rigorous Global Optimization of Impulsive Space Trajectories

Rigorous Global Optimization of Impulsive Space Trajectories Rigorous Global Optimization of Impulsive Space Trajectories P. Di Lizia, R. Armellin, M. Lavagna K. Makino, M. Berz Fourth International Workshop on Taylor Methods Boca Raton, December 16 19, 2006 Motivation

More information

Bindel, Fall 2011 Intro to Scientific Computing (CS 3220) Week 12: Monday, Apr 18. HW 7 is posted, and will be due in class on 4/25.

Bindel, Fall 2011 Intro to Scientific Computing (CS 3220) Week 12: Monday, Apr 18. HW 7 is posted, and will be due in class on 4/25. Logistics Week 12: Monday, Apr 18 HW 6 is due at 11:59 tonight. HW 7 is posted, and will be due in class on 4/25. The prelim is graded. An analysis and rubric are on CMS. Problem du jour For implicit methods

More information

Quadratic SDIRK pair for treating chemical reaction problems.

Quadratic SDIRK pair for treating chemical reaction problems. Quadratic SDIRK pair for treating chemical reaction problems. Ch. Tsitouras TEI of Chalkis, Dept. of Applied Sciences, GR 34400 Psahna, Greece. I. Th. Famelis TEI of Athens, Dept. of Mathematics, GR 12210

More information

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation Lecture slides based on the textbook Scientific Computing: An Introductory Survey by Michael T. Heath, copyright c 2018 by the Society for Industrial and Applied Mathematics. http://www.siam.org/books/cl80

More information

Strathprints Institutional Repository

Strathprints Institutional Repository Strathprints Institutional Repository Docherty, Stephanie and Macdonald, Malcolm (2012) Analytical sun synchronous low-thrust manoeuvres. Journal of Guidance, Control and Dynamics, 35 (2). pp. 681-686.

More information

An Implicit Runge Kutta Solver adapted to Flexible Multibody System Simulation

An Implicit Runge Kutta Solver adapted to Flexible Multibody System Simulation An Implicit Runge Kutta Solver adapted to Flexible Multibody System Simulation Johannes Gerstmayr 7. WORKSHOP ÜBER DESKRIPTORSYSTEME 15. - 18. March 2005, Liborianum, Paderborn, Germany Austrian Academy

More information

VARIABLE-STEP VARIABLE-ORDER 3-STAGE HERMITE-BIRKHOFF-OBRECHKOFF ODE SOLVER OF ORDER 4 TO 14

VARIABLE-STEP VARIABLE-ORDER 3-STAGE HERMITE-BIRKHOFF-OBRECHKOFF ODE SOLVER OF ORDER 4 TO 14 CANADIAN APPLIED MATHEMATICS QUARTERLY Volume 4, Number 4, Winter 6 VARIABLE-STEP VARIABLE-ORDER 3-STAGE HERMITE-BIRKHOFF-OBRECHKOFF ODE SOLVER OF ORDER 4 TO 4 TRUONG NGUYEN-BA, HEMZA YAGOUB, YU ZHANG

More information

Runge-Kutta and Collocation Methods Florian Landis

Runge-Kutta and Collocation Methods Florian Landis Runge-Kutta and Collocation Methods Florian Landis Geometrical Numetric Integration p.1 Overview Define Runge-Kutta methods. Introduce collocation methods. Identify collocation methods as Runge-Kutta methods.

More information

Accurate numerical orbit propagation using Polynomial Algebra Computational Engine PACE. ISSFD 2015 congress, Germany. Dated: September 14, 2015

Accurate numerical orbit propagation using Polynomial Algebra Computational Engine PACE. ISSFD 2015 congress, Germany. Dated: September 14, 2015 Accurate numerical orbit propagation using Polynomial Algebra Computational Engine PACE Emmanuel Bignon (), Pierre mercier (), Vincent Azzopardi (), Romain Pinède () ISSFD 205 congress, Germany Dated:

More information

Optical Studies of Space Debris at GEO - Survey and Follow-up with Two Telescopes

Optical Studies of Space Debris at GEO - Survey and Follow-up with Two Telescopes Optical Studies of Space Debris at GEO - Survey and Follow-up with Two Telescopes Patrick Seitzer University of Michigan, Dept. of Astronomy, 818 Dennison Bldg. Ann Arbor, MI 48109-1090,USA pseitzer@umich.edu

More information

On Sun-Synchronous Orbits and Associated Constellations

On Sun-Synchronous Orbits and Associated Constellations On Sun-Synchronous Orbits and Associated Constellations Daniele Mortari, Matthew P. Wilkins, and Christian Bruccoleri Department of Aerospace Engineering, Texas A&M University, College Station, TX 77843,

More information

Research Statement. James Bremer Department of Mathematics, University of California, Davis

Research Statement. James Bremer Department of Mathematics, University of California, Davis Research Statement James Bremer Department of Mathematics, University of California, Davis Email: bremer@math.ucdavis.edu Webpage: https.math.ucdavis.edu/ bremer I work in the field of numerical analysis,

More information

Aerodynamic Lift and Drag Effects on the Orbital Lifetime Low Earth Orbit (LEO) Satellites

Aerodynamic Lift and Drag Effects on the Orbital Lifetime Low Earth Orbit (LEO) Satellites Aerodynamic Lift and Drag Effects on the Orbital Lifetime Low Earth Orbit (LEO) Satellites I. Introduction Carlos L. Pulido Department of Aerospace Engineering Sciences University of Colorado Boulder Abstract

More information

Fast Gravitational Field Model using Adaptive Orthogonal Finite Element Approximation

Fast Gravitational Field Model using Adaptive Orthogonal Finite Element Approximation Fast Gravitational Field Model using Adaptive Orthogonal Finite Element Approximation Ahmad Bani Younes, Brent Macomber, Robyn M. Woollands, Austin Probe, John L. Junkins Texas A & M University, Aerospace

More information

Symbolic Solution of Kepler s Generalized Equation

Symbolic Solution of Kepler s Generalized Equation Symbolic Solution of Kepler s Generalized Equation Juan Félix San-Juan 1 and Alberto Abad 1 Universidad de La Rioja, 6004 Logroño, Spain juanfelix.sanjuan@dmc.unirioja.es, Grupo de Mecánica Espacial, Universidad

More information

Adaptive nested implicit Runge Kutta formulas of Gauss type

Adaptive nested implicit Runge Kutta formulas of Gauss type Applied Numerical Mathematics 59 (9) 77 7 www.elsevier.com/locate/apnum Adaptive nested implicit Runge Kutta formulas of Gauss type G.Yu. Kulikov, S.K. Shindin School of Computational and Applied Mathematics,

More information