Aerodynamic aircraft design for mission performance by multipoint optimization

Size: px
Start display at page:

Download "Aerodynamic aircraft design for mission performance by multipoint optimization"

Transcription

1 Aerodynamic aircraft design for mission performance by multipoint optimization François Gallard Airbus Opérations SAS, 316 route de Bayonne, TOULOUSE CEDEX 9, France. Matthieu Meaux EADS - Innovation works, Campus Engineering, BP 90112, BLAGNAC CEDEX, France. Marc Montagnac Centre Europén de Recherche et de Formation en Calcul Scientifique, Computational Fluid Dynamics, 42, avenue Gaspard Coriolis, TOULOUSE CEDEX 1, France Bijan Mohammadi Université Montpellier II Mathématiques, CC51, MONTPELLIER, France. This paper addresses the problem of multiple operating conditions design, in the context of optimal aircraft mission performance and from the aerodynamic point of view. In particular, the choice of the flight conditions to be included in the optimization problem from desired condition ranges has to be done such that the optimization problem is wellpoised with a minimal computational cost. To this aim, a new method called Gradient Span Analysis is given, based on the analysis of the linear dependencies provided by adjoint sensitivities. A wing-body configuration is presented as test case and optimization results show the interest in terms of computational time savings. Physical interpretation of the method is also given. Nomenclature AoA C s Cd Cd p Cd w Cd ind Cd vp Cl g H k J j LoD M m Angle of Attack Jet engines fuel specific consumption Drag coefficient Pressure drag coefficient Wave drag coefficient Induced drag coefficient Viscous pressure drag coefficient Lift coefficient Earth gravity acceleration Hessian matrix approximation by BFGS formula Optimization objective function Any post processed function such as Cl or Cd. Cl/Cd : Lift over drag ratio Initial sampling size of the operating condition ranges Minimal sampling size of the operating condition ranges PhD student Research Engineer Research Engineer Professor 1 of 17

2 n p R S s s k S ref T t t 0 t f V W w X y k O ad I Subscripts k Symbols α χ w λ χ ω Design variables number Operating condition ranges number Flow state equation, typically Reynolds Averaged Navier-Stokes residuals Aircraft skin nodes coordinates Line-search step Design variables vector difference between two iterates Aircraft reference surface Engines thrust Time Take-off time Landing time Aircraft air speed Flow state vector of conservative variables Aircraft mass Computational domain mesh Gradient difference between two iterates Optimization admissible domain Operating condition ranges, α I Optimization iteration index Operating condition, typically a (Mach number, Angle of Attack, Reynolds) tuple Design variables vector Fuel overall consumption Discrete adjoint vector Gradient vector of total derivatives with respect to χ Weights of an aggregate objective function I. Introduction Aircraft design for performance is often viewed as a single point problem, such as minimizing the drag at a typical cruise flight condition. However, during its flight, an aircraft encounters continuous ranges of operating conditions. The Mach number for example varies because of air traffic control constraints. Moreover, the fuel burn reduces the mass, which has an impact on the optimal flight altitude and the lift coefficient, hence the angle of attack. In the end, the block fuel, or mission overall fuel consumption depends on the aircraft performance at every encountered flight condition. Aerodynamic shape design must then take these flight conditions into account since single condition design is known to lead to poor offdesign performance, which has been reported as drag-creep, 1 single-point optimization effect 2 or localized optimization. 3 Aircraft design involves complex and strongly non-linear phenomena; the anticipation of the impact of a shape modification on the flow and the performance at multiple flight conditions seems beyond human comprehension. Optimization techniques are a way to assist the designer in this task. Gradient-based methods are efficient when the variations of aerodynamic forces with respect to the geometry are computed with adjoint formulations. The method was applied to aircraft gradient-based optimization in the pioneering work by Jameson. 4 Recent work by Liem et al. 5 demonstrated the interest of the multipoint approach for fuel efficiency, where the choice of designed operating conditions is based on surrogate models. The aim of this paper is to demonstrate that the aerodynamic design of an aircraft for its optimal mission performance can be obtained using a multipoint optimization based on the Gradient Span Analysis (GSA). 6 In this way, the operating conditions ranges are sampled such that the computation cost is minimal and the problem is well-poised. 2 of 17

3 II. Aircraft mission performance The aircraft mission performance can be defined by its fuel overall consumption. The lift-weight and drag-thrust equilibrium in cruise gives aircraft balance equations: { 1 2 ρcls ref V 2 = wg, 1 2 ρcds (1) ref V 2 = T Combining the two equations and writing that for a jet engine the fuel consumption is proportional to the thrust, the Breguet equation is obtained: dw(t) dt = C s(α(t))g(t) w(t) (2) LoD(χ, α(t), w(t)) This first order differential equation can be integrated once on the time variable, on the range [t 0, t f ]. The fuel overall consumption is the difference between take-off and landing mass w = w(t 0 ) w(t f ), and with Eq. (2): t=tf w (χ) = t=t 0 dw(t) t=tf dt = dt t=t 0 C s (α(t))w(t)g(t) dt (3) LoD(χ, α(t), w(t)) One can minimize this quantity, paying attention to the dependencies between terms, in particular the mass drives the lift coefficient through Eq. (1), and the lift over drag is a direct function of lift. On the other hand, when a high number of design variables are involved such as in 3D aircraft configurations, gradient-based algorithms prove to be the most efficient approach, so the derivative of this function with respect to the design variables has to be computed. Assuming that the functions are sufficiently regular to swap derivation and integration operators and that the design variables only impacts the aerodynamic performance and not the engine performance or the structural mass: d w (χ) dχ t=tf = t=t 0 C s (α(t))w(t)g(t) LoD(χ, α(t), w(t)) LoD(χ, α(t), w(t)) 2 dt (4) χ In a numerical optimization process based on CFD, flow calculations are performed at a given angle of attack, mass and altitude, so a discretization of this equation in time is required. d w (χ) dχ = n C s (α(t i ))w(t i )g(t i ) LoD(χ, α(t i ), w(t i )) LoD(χ, α(t i ), w(t i )) 2 δt i (5) χ i=1 Finally, a set of scalar positive functions ω i (χ) can be defined such that: d w (χ) dχ = n i=1 ω i (χ) LoD(χ, α(t i), w(t i )) χ (6) Eq. (6) can be viewed as an aggregate objective function at selected operating conditions with nonconstant weights. From the aerodynamic optimization point of view, the question that rises is how to choose the operating conditions and weights so that the optimization process converges to an interesting engineering solution. As a consequence, the multipoint formulation does not necessarily require mission and aircraft performance models in order to explicitly compute the weighting function ω i (χ). The same reasoning can be made for multi-mission optimization. A larger integration domain in Eq. (3) results in an additional sum on top of Eq. (5) and in the end in a modification of ω i (χ) in Eq. (6). The formulation is therefore multi-mission, as improving the lift-over-drag polar α LoD(χ, α) has a positive influence on all the missions of the aircraft. From an algorithmic point of view, gradient-based algorithms with hessian matrix approximation, as bounds constrained limited memory BFGS 7 generate the next design variables using the gradient of the function but not the function value itself. Their iteration scheme is similar to Eq. (7). χ k+1 = χ k sh 1 k χj(χ), (7) 3 of 17

4 where H k is an approximation of the Hessain matrix Goldfarb Shanno) formula Eq. (10) at the k th iterate. [ ] d 2 J(χ) d 2 χ given by the BFGS (Broyden Fletcher y k = χ J k+1 (χ) χ J k (χ), (8) s k = χ k+1 χ k, (9) H k+1 = I + k T y i y i H is i s T i H i. (10) y it s i s it H i s i i=1 The BFGS formula also does not depend on the function value itself but only on the gradients and design variables history. Only line-search or trust region updates are used to ensure a sufficient decrease of the function value by avoiding too large steps s in Eq. (7) and depend on the function value. As w (χ) is strictly decreasing with every LoD(χ, t i ), if an optimization strategy decreases each of them, then w will decrease. Finally, the aim is to control the continuous function t LoD(χ, α(t), w(t)), and the quantity w in Eq. (3) is a scalar criteria that makes a link between this goal and the optimizer. Because the optimization strategy is based on the gradients of the objective more than the function value itself, the focus has to be made on the gradients LoD(χ,α(ti),w(ti)) χ when α(t) varies. One can also accept a modification of the criteria w, more precisely of the weights ω i (χ) if the approach saves computation time. This leads us to the importance of controlling the continuous function t LoD(χ, α(t), w(t)) through its gradients with a finite set of instants t i and at a minimal cost. III. The GSA method Zing and Elias 8 proposed a technique to automatically select the sampling points in the operating condition ranges. In that approach, the necessity to add an operating condition in the multipoint problem is detected by computing the drag over the whole operating condition ranges at checkpoints during the optimization problem. When a local maximum of the drag is detected between the sampling points, an additional one is added. Li et al 3 made a link between this local maximum and the fact that the gradient of the drag at this point is a new descent direction. In the GSA approach, the linear dependency of the gradients in the operating conditions ranges are used to select the sampling set whereas Li et al. implicitly supposed that the gradients were linearly independent which leads to the conclusion that the operating condition ranges have to be finely sampled. But the physics modeled by fluid state equations at two different operating conditions can be very similar, and that can be exploited from a design point of view. The purpose of the GSA algorithm is to adequately sample the operating conditions ranges to setup a multipoint optimization problem so that the local maximum behavior noticed by Zing and Elias is anticipated and avoided. In a preprocessing step, a relatively fine sampling of the operating conditions is performed on the initial shape and the gradient of the drag with respect to the design variables are computed at those conditions. On this initial set, the linear dependencies of the gradients are calculated and a minimal set of linearly independent conditions are selected by the GSA algorithm Alg. (1), based on a Gram-Schmidt decomposition. This last set will be used to formulate a weighted sum optimization problem. Because the gradient gives the first order variations of the drag, if no descent direction is missed by the algorithm then the local maximum effect will be avoided. The minimal number of sampling points ensuring the control of the drag on the continuous range is another result of the approach. It is equal to the dimension of the vector space spanned by the drag gradients when the operating conditions vary in the ranges. 6 A dynamic process that checks the dimension of the gradient span can be setup, similarly to, 8 but in practice, when the geometrical changes are not too important, this sampling is kept constant. Theorem 1 in 6 expresses that the zero gradient optimality condition on a set of m well chosen conditions implies the optimality of derived problems built on the same m first conditions and any additional one taken 4 of 17

5 in the operating condition ranges I, but with modified weights, as shown in Eq. (11). [( m ) ( )] m+1 α m+1 I ω k χ j(χ, α k ) = 0 = ω k R m R\{0} ω k χ j(χ, α k ) = 0 k=1 k=1 (11) The spanned vector space of a set of vectors is composed of all the possible linear combinations of this set. If the operating conditions are selected such that the condition of Eq. (12) is ensured, it is not possible to find any operating condition α m+1 selected in the ranges I at which the drag j(x, α m+1 ) can be decreased at the first order. Corollary 1 in 6 proves this statement formulated in Eq. (13). Finding an operating condition at which the drag gradient is not linearly dependent of the design operating conditions gradients would mean that the problem is ill-poised and the performance at this point can be improved without degrading the others, as shown by Li et al. 3 Span{ χ j(χ, α k ), k [1... m]} = Span{ χ j(χ, α), α I} (12) (ω 1,..., ω m ) R m m k=1 ω k x j(x, α k ) = 0 = α m+1 I, ( ω 1,.., ω m+1 ) (R m R ), D R n, t R m+1 k=1 ω k j(x + t D, α k ) = m+1 k=1 ω k j(x, α k ) + O(t 2 ) (13) The dimension of the gradient span Span{ χ j(χ, α), α I} defines the minimal number of operating conditions required to control the function j(χ, α) on the continuous set α I. As a consequence, it can be defined as the control dimension of the polar α j(χ, α). The GSA algorithm, selects a minimal set I m that ensures the condition Eq. (12), from an initial fine sampling I M I that is used to estimate Span{ χ j(χ, α), α I}. In the end, the GSA approach avoids the local maximum effect, without taking more operating conditions in the optimization problem than the number of design variables, 3 which is extremely costly. Moreover, the theorem shows why such a condition is over restrictive in practice. Eq. (11) also has a counter-intuitive consequence: adding an additional operating condition to a well-poised problem is equivalent to modifying the weights of the aggregate objective function. IV. The optimization problem The multipoint optimization problem using an aggregate objective function is defined in Eq. (14). I IR p, O ad IR n, (α 1,..., α m ) I m, (ω 1,..., ω m ) R m, Cd C 1 : R n I R Cl C 1 : R n I R m minimize J(χ) = ω k Cd(χ, α k ) χ O ad k=1 subject to {R(W k, χ, α k ) = 0, k [1... m]}, and {Cl(χ, α k ) = Cl 0 (α k ), k [1... m]}. (14) Dedicated Computational Fluid Dynamics solvers compute the flow solution W by solving the fluid state equations R(W, χ, α) = 0 for every α. The discrete adjoint method enables to compute the sensitivities of the drag and the lift at moderate cost. First, the adjoint vector λ j for the function j on the mesh X and for the state vector W at the operating condition α is the solution of the linear system of Eq. (15), j(w, X, α) W + λ T j R(W, X, α) W = 0. (15) 5 of 17

6 Algorithm 1 Gradient Span Analysis Algorithm (GSA) indices {1... M} for j = 1 M do c m 0 for n indices do q j χ j(χ, α j ) for i = 1 j 1 do q j q j π qi (q j ) end for q j qj q j c 0 for i = 1 M do v χ j(χ, α i ) for k = 1 j do v v π qk (v) end for if v < ɛ χ j(χ, α i ) then c c + 1 end if if c > c m then q m q j c m c n m n end if end for q j q m indices indices\{n m } end for if c m = M then END end if end for 6 of 17

7 Total derivatives of functionals with respect to mesh node coordinates is assembled in Eq. (16), dj(x, α) dx = j(w, X, α) dx + λ T j R(W, X, α). (16) X Volume sensitivities can be composed with surface sensitivities to compute the derivative of functions with respect to surface coordinates S, dj(s, α) ds = dj(x, α) dx(s) dx ds. (17) Finally the surface is parametrized with design variables χ and the gradient of the function is calculated, χ j(χ, α) = dj(s, α) ds(χ) ds dχ. (18) From Eq. (18), the gradients of the objective function at various operating conditions α is obtained, and from this information, the GSA algorithm 1 provides the operating conditions set {α k, k (1..m)} to be used in the multipoint optimization problem. The weights ω i, i (1..m) of the objective function are an estimation of the utopia point distance. 9 As a consequence, an estimation of the potential gains expected by the optimization process has to be estimated. To this aim, the pressure drag objective is decomposed in physical components: induced drag Cd ind, wave drag Cd w and viscous pressure drag Cd vp using the ONERA FFD code. 10 The potential gain at each condition is estimated as a fraction of these decompositions as shown in Eq. (19). ω = 1 0.9Cd w + 0.2Cd ind + 0.1Cd vp (19) The gains obtained after a single point optimization can provide a good estimation for the potential gain fractions in Eq. (19), but a rough estimate can be sufficient. In this way, the optimization formulation (14) is fully determined by an automated physical analysis of the problem. V. Numerical methods 11, 12 Numerical computations were performed with the elsa Onera software. This code manages both the flow analysis and the flow sensitivity aspects. It solves the 3D compressible Reynolds-Averaged Navier- Stokes equations using a cell-centered finite-volume method on structured grids as well as the associated discrete adjoint equations. The turbulence model chosen is the one-equation Spalart-Allmaras 13 model. V.A. Flow solver The spatial convective fluxes of the mean flow are discretized with the upwind Roe scheme 14 with the Harten s entropic correction. A MUSCL scheme (Monotone Upstream-centered Schemes for Conservation Laws) 15 associated with a Van Albada limiter 16 provides a second-order accurate scheme. The spatial convective fluxes of the turbulent flow are discretized with the first-order upwind Roe scheme. Spatial diffusive fluxes are approximated with a second-order central scheme. The turbulent equations are solved separately from the mean flow equations at each time step with the same time-marching method. The backward Euler implicit scheme drives the time integration. The resulting linear systems are solved with the scalar Lower-Upper Symmetric Successive Over-Relaxation (LU-SSOR) method. 17 A standard nonlinear multigrid algorithm 18 combined with local time stepping accelerates the convergence to steady-state solutions. V.B. Adjoint solver All of the methods previously described in the flow solver are differentiated by hand. The turbulent eddy viscosity and thermal conductivity are assumed constant 19, 20 during the differentiation. 7 of 17

8 The resolution method to solve the discrete adjoint equation is the preconditioned first-degree iterative method, similar to an approximate Newton method, of Eq. (20). Ã(λ (l+1) λ (l) ) = Aλ (l) b, (20) R where the matrix à is an approximation of the jacobian matrix A = W. The approximation matrix à derives from the linearization of a first-order Steger-Warming flux-vector splitting scheme for the convective flux and the linearization of the diffusive flux neglecting the spatial cross derivatives. The resulting linear systems are solved with a few steps of a block LU-SSOR algorithm at each iteration of the iterative method. VI. The XRF-1 test-case The XRF-1 model is a wing-body aerodynamic configuration representative of modern civil transport aircrafts. In particular, shocks on the wings in transsonic conditions are known to raise problems for multiple Mach numbers optimizations. 1 VI.A. Parametrization An in-house parametric and differentiated CAD engine called PADGE (Parametric And Differentiated Geometrical Engine) is used to build a parametric model. Eleven wing sections are parametrized with airfoils and parametric B-splines to link them together. Finally Coons patches are used to create the surfaces. An analytical reverse mode of the tool is available to compute functional gradients of Eq. (18) from discrete adjoint skin sensitivities. Decreasing the wing thickness would decrease the drag, but it would also increase the mass of the internal structure. The compromise is multidisciplinary. Because no structural sizing is involved in the present aerodynamic optimization process, the two structural beams are built in the wing CAD model and their thickness are geometrical constraints. The whole model, displayed in Fig. 1, contains 91 design variables. Figure 1: Parametric CAD model of the XRF-1 wings VI.B. The initial mesh The Reynolds-Averaged-Navier-Stokes solution and its discrete adjoint are computed on the structured mesh shown in Fig. 2 made of 140 blocks with 22 millions cells. The height of the first layer of cells is such that y + is approximately equal to one, and the mesh is sufficiently fine to capture the physics of the flow in cruise conditions according to best practices for the used numerical schemes, when compared to flight and wind tunnel tests. 8 of 17

9 Figure 2: Multiblocks structured mesh of the XRF-1 model VI.C. Mesh update A mesh deformation approach is used to update the mesh when the CAD model is updated by new design parameters. Subtraction of the initial CAD to the updated one provides a surface deformation field that has to be propagated into the volume mesh. Here, the method relies on an algebraic integral formulation. 21 It is analytically differentiated to provide a reverse mode for the computation of the surface mesh sensitivity from the adjoint volume mesh sensitivity in Eq. (17). In this way, the impact of the mesh deformation on the solution is derived. VII. Operating conditions choice by GSA The operating conditions range is 0.6 Mach 0.87 and 2.3 AoA 2.9, discretized in 38 initial discrete samples. At each of these, the flow, its adjoint and the drag gradient are computed, and the GSA algorithm identifies 5 conditions shown in Fig. 3. Because at the end of the optimization process, the weighted sum of the drag gradients is null, they are linearly dependent. GSA selects linearly independent gradients; so one arbitrary operating condition is added to the problem, it can be operating condition of the single point optimization Original sampling Selected by GSA AoA Figure 3: Flight conditions selected by GSA for the optimization problem Mach Figure 4 shows the drag sensitivity with respect to the surface of Eq. (17) at the 5 operating conditions selected by GSA on the XRF-1 model. 9 of 17

10 Figure 4: Total derivative of the drag with respect to the surface z-coordinate at the five linearly independent flight conditions given by GSA First of all, the design space being of dimension 91, it is noteworthy that only 5 conditions are sufficient to build a basis of the spanned 38 initial conditions drag gradients. It shows the interest of the GSA approach in terms of computation time saving. Then, it is observed that the design conditions in Fig. 4 displays different patterns of surface sensitivities defined in Eq. (17). Shock positions have a particularly large influence on that phenomenon and this position changes when the Mach number changes. Each of these patterns lead to a linearly independent drag gradient when assembled with the CAD sensitivity in Eq. (18). This links the non-linear physical phenomena of shocks displacement when the operating condition varies, to the gradient span dimension and in the end the choice of the operating conditions for the optimization problem. VIII. Single point optimization A single point optimization of the configuration is run at Mach 0.83 and Cl This enables to check the behavior of the optimization process, and to compare the results with the multipoint optimization. The L-BFGS-B code from Zhu et al. 7 is used as optimizer. The lift constraint Cl Cl 0 = 0 is handled in the flow solver by a target lift approach. Newton iterations with finite differences on the function Cl(AoA) are performed during the convergence of the flow and the cost is about 20% more than a fixed AoA calculation. A lagrangian is derived to compute the derivative of the drag at constant lift in Eq. (21), the derivatives being calculated by discrete adjoints of Cl and Cd. This lagrangian is provided to the l-bfgs-b algorithm. χ L(Cd, Cl Cl 0 )(χ) = Cd(χ, AoA) χ Cd(χ,AoA) AoA Cl(χ,AoA) AoA Cl(χ, AoA). (21) χ 10 of 17

11 105 Cdp Mach 0.83 Cl 0.53 Clp Mach 0.83 Cl 0.53 Cd pressure % Cl Iteration Figure 5: Single point optimization convergence history Figure 5 shows that the target lift approach succeeds in maintaining the lift during the optimization by automatic adjustment of the angle of attack. The overall drag reduction of 11% is mainly due to the shock smoothing as shown in Fig. 7, which also leads to a viscous pressure drag reduction. Fig. 6 also shows smooth pressure coefficient iso-lines and the global view of the configuration. Figure 6: Pressure coefficient at single point optimum (a) 15 % Span (b) 40 % Span (c) 80 % Span Figure 7: Cp distributions and airfoil deformations at single point convergence, Mach 0.83 Cl 0.53 In the Fig. 7 the displayed deformations are coherent with the pressure coefficients modifications: material 11 of 17

12 is added behind the upper-wing shock position to lower the re-compression, or removed in the subsonic area to lower the flow acceleration. The resulting wave drag is almost zero at the optimum. The lower and upper deformation curves cross at four points: leading and trailing edge, and the two structural beams intersections, which means that the geometrical constraint of constant beam thickness are respected. The lift repartition across the wingspan is also slightly moved outboard to reduce the induced drag. Resulting gains are summarized in Fig Delta Cd (%) CDw CDi CDvp CDf CDsp Figure 8: Drag gain as percentages of total initial drag for the single point XRF-1 optimization case IX. Multipoint optimization A multipoint optimization is run, with the required operating conditions. The target lift approach is employed, and, as in the single point case, succeeds in ensuring a constant lift during the process. In Fig. 9, the pressure drag history for each operating condition is displayed. Each condition contributes to the overall drag reduction of Eq. (5). As a consequence, the mission fuel burn has been reduced. It also means that the initial design was not on the Pareto front of these 6 operating conditions. Cd pressure % Mach 0.8 Cl 0.46 Mach 0.83 Cl 0.53 Mach 0.86 Cl 0.5 Mach 0.6 Cl 0.36 Mach 0.7 Cl 0.39 Mach 0.75 Cl Iteration Figure 9: Optimizations convergence history In figs. 10 to 16 the pressure coefficient plots give a global view of the flow at the optimum. As expected, the multipoint optimum being a compromise, the shocks in transonic conditions are much stronger than at the single point optimum, which almost achieves a shock-free flow. However, the wave drag is reduced in a significant way as shown in Fig. 17. The other components of the pressure drag are also reduced; the induced drag is decreased by moving outboard the center of lift, as in the single point optimization. The reduction of the shock intensity lowers the boundary layers thicknesses behind the shocks, that reduces the viscous pressure drag. Therefore the viscous pressure drag reduction is a consequence of the wave drag reduction, even if the gradient of this component is not exact in the adjoint solver that assumes frozen turbulence. 12 of 17

13 (a) Mach 0.8 Cl 0.46 (b) Mach 0.83 Cl 0.53 (c) Mach 0.86 Cl 0.5 (d) Mach 0.6 Cl 0.36 (e) Mach 0.7 Cl 0.39 (f) Mach 0.75 Cl 0.48 Figure 10: Pressure coefficient at multiple operating conditions optimum 13 of 17

14 (a) 15 % Span (b) 40 % Span (c) 80 % Span Figure 11: Cp distributions and airfoil deformations at multipoint convergence, Mach 0.8 Cl 0.46 (a) 15 % Span (b) 40 % Span (c) 80 % Span Figure 12: Cp distributions and airfoil deformations at multipoint convergence, Mach 0.83 Cl 0.53 (a) 15 % Span (b) 40 % Span (c) 80 % Span Figure 13: Cp distributions and airfoil deformations at multipoint convergence, Mach 0.86 Cl 0.5 (a) 15 % Span (b) 40 % Span (c) 80 % Span Figure 14: Cp distributions and airfoil deformations at multipoint convergence, Mach 0.6 Cl of 17

15 (a) 15 % Span (b) 40 % Span (c) 80 % Span Figure 15: Cp distributions and airfoil deformations at multipoint convergence, Mach 0.7 Cl 0.39 (a) 15 % Span (b) 40 % Span (c) 80 % Span Figure 16: Cp distributions and airfoil deformations at multipoint convergence, Mach 0.75 Cl 0.48 Delta Cd (%) Mach 0.8 Cl 0.46 Mach 0.83 Cl 0.53 Mach 0.86 Cl 0.5 Mach 0.6 Cl 0.36 Mach 0.7 Cl 0.39 Mach 0.75 Cl CDw CDi CDvp CDf CDsp Figure 17: Drag gain as percentages of total initial drag on the multipoint case The CPU cost of the multipoint optimization was hours on Intel(R) Xeon(R) 2.93GHz processors, taking into account the initial sampling for the GSA algorithm and the optimization run itself. The restitution time is 8 days on 400 CPU. It represents a 90% cost cut compared to an approach where n + 1 samples are selected in the operating condition ranges, 3 without missing any descent direction, so any potential drag gain in the operating condition ranges. The robust optimization cost 8 times more than single point one. X. Conclusion Aircraft mission performance optimization raises the question of improving the aerodynamic lift-overdrag polar under an infinite set of operating conditions such as Mach number, Reynolds and aircraft mass. 15 of 17

16 Robust optimization by weighted sum minimization is a way of addressing it. In that case, the selection of operating conditions to be included in the aggregate objective has a major impact on the cost of the resolution, and the quality of the solution. A new method named Gradient Span Analysis proves to be useful for assisting the optimization problem setup of this class of problem in an efficient way. Based on a mathematically demonstrated approach, it provides substantial computational time savings and the algorithms remain simple. An interpretation is provided to link the polar control dimension with the non-linear physical phenomena occurring on the aircraft such as shock waves. Optimizations of the XRF-1 wing-body configuration, representative of modern civil transport aircrafts, with RANS simulations in single and multiple operating conditions were presented, discussed and compared. The successful usage of the GSA algorithm shows that the adjoint sensitivities can not only enhance the gradient-based optimization effectiveness but also enable a new way of improving the multiple operating conditions optimization procedure. Acknowledgments The Association Nationale de la Recherche et de la Technologie is acknowledged for funding. Airbus is acknowledged for funding and providing computational resources. Renaud Sauvage, Joel Brezillon and Pascal Larrieu from Airbus are acknowledged for their useful advices and support. References 1 Hicks, R. M. and Vanderplaats, G. N., Application of Numerical Optimization to the Design of Supercritical Airfoils without Drag Creep, Business Aircraft Meeting, No. Paper , Society of Automotive Engineers, Wichita, Kansas, March 29 - April Drela, M., Pros and cons of airfoil optimization, chap. Frontiers of Computational Fluid Dynamics, World Scientific, Singapore, 1998, pp Li, W., Huyse, L., and Padula, S., Robust Airfoil Optimization to Achieve Consistent Drag Reduction Over a Mach Range, Structural and Multidisciplinary Optimization, Vol. 24, No. 1, 2002, pp Jameson, A., Aerodynamic design via control theory, J. Sci. Comput., Vol. 3, No. 3, 1988, pp Liem, R. P., Kenway, G. K. W., and Martins, J. R. R. A., Multi-point, multi-mission, high-fidelity aerostructural optimization of a long-range aircraft configuration, 14th AIAA/ISSMO Multidisciplinary Analysis and Optimization Conference, Indianapolis, IN, 09/ Gallard, F., Montagnac, M., Mohammadi, B., and Meaux, M., Robust parametric shape design by multipoint optimization, Tech. Rep. TR/CFD/12/33, CERFACS, September Zhu, C., Byrd, R. H., Lu, P., and Nocedal, J., L-BFGS-B - Fortran Subroutines for Large-Scale Bound Constrained Optimization, Tech. rep., ACM Trans. Math. Software, Zingg, D. and Elias, S., On Aerodynamic Optimization Under a Range of Operating Conditions, AIAA Journal, Vol. 44, No. 11, 2006, pp Koski, J. and Silvennoinen, R., Norm methods and partial weighting in multicriterion optimization of structures, International Journal for Numerical Methods in Engineering, Vol. 24, No. 6, 1987, pp Destarac, D., Far-field/near field drag balance and applications of drag extraction in CFD, VKI Lecture Series, 2003, pp Cambier, L., Gazaix, M., Heib, S., Plot, S., Poinot, M., Veuillot, J.-P., Boussuge, J.-F., and Montagnac, M., CFD Platforms and Coupling : An Overview of the Multi-Purpose elsa Flow Solver, Aerospace Lab, Vol. 2, March Puigt, G., Gazaix, M., Montagnac, M., Pape, M.-C. L., de la Llave Plata, M., Marmignon, M., Boussuge, J.-F., and Couaillier, V., Development of a new hybrid compressible solver inside the CFD elsa software, 20th AIAA Computational Fluid Dynamics Conference, No. AIAA , Honolulu (HI), USA, June Spalart, P. R. and Allmaras, S. R., A One-Equation Turbulence Transport Model for aerodynamic flows, 30th AIAA Aerospace Sciences Meeting and Exhibit, AIAA Paper , Reno, Nevada, Jan Roe, P. L., Approximate Riemann Solvers, Parameter Vectors and Difference Schemes, Journal of Computational Physics, Vol. 43, No. 2, October 1981, pp van Leer, B., Towards the ultimate conservative difference scheme. V. A second-order sequel to Godunov s method, Journal of Computational Physics, Vol. 32, No. 1, 1979, pp van Albada, G. D., van Leer, B., and Roberts, W. W., A Comparative Study of Computational Methods in Cosmic Gas Dynamics, Astronomy and Astrophysics, Vol. 108, 1982, pp Yoon, S. and Jameson, A., Lower-Upper Symmetric-Gauss-Seidel Method for the Euler and Navier-Stokes Equations, AIAA Journal, Vol. 26, No. 9, 1988, pp Jameson, A., Steady State Solutions of the Euler Equations for Transonic Flow by a Multigrid Method, chap. Advances in Scientific Computing, Academic press, 1982, pp Jameson, A., Martinelli, L., and Pierce, N. A., Optimum Aerodynamic Design Using the Navier-Stokes Equations, Theoretical and Computational Fluid Dynamics, Vol. 10, No. 1-4, 1998, pp of 17

17 20 Nielsen, E. J. and Anderson, W. K., Aerodynamic Design Optimization on Unstructured Meshes Using the Navier-Stokes Equations, AIAA Journal, Vol. 37, No. 11, 1999, pp M. Meaux, M. C. and Voizard, G., Viscous aerodynamic shape optimization based on the discrete adjoint state for 3D industrial configurations, European Congress on Computational Methods in Applied Sciences and Engineering ECCOMAS, of 17

Toward Practical Aerodynamic Design Through Numerical Optimization

Toward Practical Aerodynamic Design Through Numerical Optimization Toward Practical Aerodynamic Design Through Numerical Optimization David W. Zingg, and Laura Billing, Institute for Aerospace Studies, University of Toronto 4925 Dufferin St., Toronto, Ontario M3H 5T6,

More information

A Multi-Dimensional Limiter for Hybrid Grid

A Multi-Dimensional Limiter for Hybrid Grid APCOM & ISCM 11-14 th December, 2013, Singapore A Multi-Dimensional Limiter for Hybrid Grid * H. W. Zheng ¹ 1 State Key Laboratory of High Temperature Gas Dynamics, Institute of Mechanics, Chinese Academy

More information

Challenges and Complexity of Aerodynamic Wing Design

Challenges and Complexity of Aerodynamic Wing Design Chapter 1 Challenges and Complexity of Aerodynamic Wing Design Kasidit Leoviriyakit and Antony Jameson Department of Aeronautics and Astronautics Stanford University, Stanford CA kasidit@stanford.edu and

More information

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Per-Olof Persson and Jaime Peraire Massachusetts Institute of Technology 7th World Congress on Computational Mechanics

More information

A COUPLED-ADJOINT METHOD FOR HIGH-FIDELITY AERO-STRUCTURAL OPTIMIZATION

A COUPLED-ADJOINT METHOD FOR HIGH-FIDELITY AERO-STRUCTURAL OPTIMIZATION A COUPLED-ADJOINT METHOD FOR HIGH-FIDELITY AERO-STRUCTURAL OPTIMIZATION Joaquim Rafael Rost Ávila Martins Department of Aeronautics and Astronautics Stanford University Ph.D. Oral Examination, Stanford

More information

COMPUTATIONAL STUDY OF SEPARATION CONTROL MECHANISM WITH THE IMAGINARY BODY FORCE ADDED TO THE FLOWS OVER AN AIRFOIL

COMPUTATIONAL STUDY OF SEPARATION CONTROL MECHANISM WITH THE IMAGINARY BODY FORCE ADDED TO THE FLOWS OVER AN AIRFOIL COMPUTATIONAL STUDY OF SEPARATION CONTROL MECHANISM WITH THE IMAGINARY BODY FORCE ADDED TO THE FLOWS OVER AN AIRFOIL Kengo Asada 1 and Kozo Fujii 2 ABSTRACT The effects of body force distribution on the

More information

The Computations of Jet Interaction on a Generic Supersonic Missile

The Computations of Jet Interaction on a Generic Supersonic Missile The Computations of Jet Interaction on a Generic Supersonic Missile *Jinbum Huh 1) and Seungsoo Lee 2) 1), 2) Department of Aerospace Engineering, Inha Univ., Incheon, Korea 2) slee@inha.ac.kr ABSTRACT

More information

AERO-STRUCTURAL WING DESIGN OPTIMIZATION USING HIGH-FIDELITY SENSITIVITY ANALYSIS

AERO-STRUCTURAL WING DESIGN OPTIMIZATION USING HIGH-FIDELITY SENSITIVITY ANALYSIS AERO-STRUCTURAL WING DESIGN OPTIMIZATION USING HIGH-FIDELITY SENSITIVITY ANALYSIS Joaquim R. R. A. Martins and Juan J. Alonso Department of Aeronautics and Astronautics Stanford University, Stanford, CA

More information

Reduced order model of three-dimensional Euler equations using proper orthogonal decomposition basis

Reduced order model of three-dimensional Euler equations using proper orthogonal decomposition basis Journal of Mechanical Science and Technology 24 (2) (2010) 601~608 www.springerlink.com/content/1738-494x DOI 10.1007/s12206-010-0106-0 Reduced order model of three-dimensional Euler equations using proper

More information

Discrete and continuous adjoint method for compressible CFD J. Peter ONERA

Discrete and continuous adjoint method for compressible CFD J. Peter ONERA Discrete and continuous adjoint method for compressible CFD J. Peter ONERA J. Peter 1 1 ONERA DMFN October 2, 2014 J. Peter (ONERA DMFN) Adjoint method for compressible CFD October 2, 2014 1 / 60 Outline

More information

Block-Jacobi Implicit Algorithms for the Time Spectral Method

Block-Jacobi Implicit Algorithms for the Time Spectral Method Block-Jacobi Implicit Algorithms for the Time Spectral Method Frédéric Sicot, Guillaume Puigt and Marc Montagnac CERFACS, CFD/AAM, 42 avenue Coriolis F-3057 Toulouse Cedex 0 Many industrial applications

More information

A Crash-Course on the Adjoint Method for Aerodynamic Shape Optimization

A Crash-Course on the Adjoint Method for Aerodynamic Shape Optimization A Crash-Course on the Adjoint Method for Aerodynamic Shape Optimization Juan J. Alonso Department of Aeronautics & Astronautics Stanford University jjalonso@stanford.edu Lecture 19 AA200b Applied Aerodynamics

More information

Unsteady Optimization Using a Discrete Adjoint Approach Applied to Aeroacoustic Shape Design

Unsteady Optimization Using a Discrete Adjoint Approach Applied to Aeroacoustic Shape Design Unsteady Optimization Using a Discrete Adjoint Approach Applied to Aeroacoustic Shape Design Markus P. Rumpfkeil and David W. Zingg University of Toronto Institute for Aerospace Studies 4925 Dufferin Street,

More information

Application of Dual Time Stepping to Fully Implicit Runge Kutta Schemes for Unsteady Flow Calculations

Application of Dual Time Stepping to Fully Implicit Runge Kutta Schemes for Unsteady Flow Calculations Application of Dual Time Stepping to Fully Implicit Runge Kutta Schemes for Unsteady Flow Calculations Antony Jameson Department of Aeronautics and Astronautics, Stanford University, Stanford, CA, 94305

More information

Royal Aeronautical Society 2016 Applied Aerodynamics Conference Tuesday 19 th Thursday 21 st July Science Centre, Bristol, UK

Royal Aeronautical Society 2016 Applied Aerodynamics Conference Tuesday 19 th Thursday 21 st July Science Centre, Bristol, UK Assessment and validation of aerodynamic performance results for a Natural Laminar Flow transonic wing tested in cryogenic conditions via simulation of turbulent wedges in CFD. Royal Aeronautical Society

More information

NUMERICAL SIMULATION AND MODELING OF UNSTEADY FLOW AROUND AN AIRFOIL. (AERODYNAMIC FORM)

NUMERICAL SIMULATION AND MODELING OF UNSTEADY FLOW AROUND AN AIRFOIL. (AERODYNAMIC FORM) Journal of Fundamental and Applied Sciences ISSN 1112-9867 Available online at http://www.jfas.info NUMERICAL SIMULATION AND MODELING OF UNSTEADY FLOW AROUND AN AIRFOIL. (AERODYNAMIC FORM) M. Y. Habib

More information

Airfoil shape optimization using adjoint method and automatic differentiation

Airfoil shape optimization using adjoint method and automatic differentiation Airfoil shape optimization using adjoint method and automatic differentiation Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 5665

More information

Far Field Noise Minimization Using an Adjoint Approach

Far Field Noise Minimization Using an Adjoint Approach Far Field Noise Minimization Using an Adjoint Approach Markus P. Rumpfkeil and David W. Zingg University of Toronto Institute for Aerospace Studies 4925 Dufferin Street, Toronto, Ontario, M3H 5T6, Canada

More information

NUMERICAL OPTIMIZATION OF THE SHAPE OF A HOLLOW PROJECTILE

NUMERICAL OPTIMIZATION OF THE SHAPE OF A HOLLOW PROJECTILE NUMERICAL OPTIMIZATION OF THE SHAPE OF A HOLLOW PROJECTILE Wessam Mahfouz Elnaggar, Zhihua Chen and Hui Zhang Key Laboratory of Transient Physics, Nanjing University of Science and Technology, Nanjing,

More information

WALL ROUGHNESS EFFECTS ON SHOCK BOUNDARY LAYER INTERACTION FLOWS

WALL ROUGHNESS EFFECTS ON SHOCK BOUNDARY LAYER INTERACTION FLOWS ISSN (Online) : 2319-8753 ISSN (Print) : 2347-6710 International Journal of Innovative Research in Science, Engineering and Technology An ISO 3297: 2007 Certified Organization, Volume 2, Special Issue

More information

A Non-Intrusive Polynomial Chaos Method For Uncertainty Propagation in CFD Simulations

A Non-Intrusive Polynomial Chaos Method For Uncertainty Propagation in CFD Simulations An Extended Abstract submitted for the 44th AIAA Aerospace Sciences Meeting and Exhibit, Reno, Nevada January 26 Preferred Session Topic: Uncertainty quantification and stochastic methods for CFD A Non-Intrusive

More information

Towards Reduced Order Modeling (ROM) for Gust Simulations

Towards Reduced Order Modeling (ROM) for Gust Simulations Towards Reduced Order Modeling (ROM) for Gust Simulations S. Görtz, M. Ripepi DLR, Institute of Aerodynamics and Flow Technology, Braunschweig, Germany Deutscher Luft und Raumfahrtkongress 2017 5. 7. September

More information

An Investigation of the Attainable Efficiency of Flight at Mach One or Just Beyond

An Investigation of the Attainable Efficiency of Flight at Mach One or Just Beyond 45 th Aerospace Sciences Meeting and Exhibit, January 8 11, 2007, Reno, Nevada An Investigation of the Attainable Efficiency of Flight at Mach One or Just Beyond Antony Jameson Department of Aeronautics

More information

Application of a Non-Linear Frequency Domain Solver to the Euler and Navier-Stokes Equations

Application of a Non-Linear Frequency Domain Solver to the Euler and Navier-Stokes Equations Application of a Non-Linear Frequency Domain Solver to the Euler and Navier-Stokes Equations Matthew McMullen and Antony Jameson and Juan J. Alonso Dept. of Aeronautics & Astronautics Stanford University

More information

COMPLETE CONFIGURATION AERO-STRUCTURAL OPTIMIZATION USING A COUPLED SENSITIVITY ANALYSIS METHOD

COMPLETE CONFIGURATION AERO-STRUCTURAL OPTIMIZATION USING A COUPLED SENSITIVITY ANALYSIS METHOD COMPLETE CONFIGURATION AERO-STRUCTURAL OPTIMIZATION USING A COUPLED SENSITIVITY ANALYSIS METHOD Joaquim R. R. A. Martins Juan J. Alonso James J. Reuther Department of Aeronautics and Astronautics Stanford

More information

Computational Fluid Dynamics Study Of Fluid Flow And Aerodynamic Forces On An Airfoil S.Kandwal 1, Dr. S. Singh 2

Computational Fluid Dynamics Study Of Fluid Flow And Aerodynamic Forces On An Airfoil S.Kandwal 1, Dr. S. Singh 2 Computational Fluid Dynamics Study Of Fluid Flow And Aerodynamic Forces On An Airfoil S.Kandwal 1, Dr. S. Singh 2 1 M. Tech Scholar, 2 Associate Professor Department of Mechanical Engineering, Bipin Tripathi

More information

Derivatives for Time-Spectral Computational Fluid Dynamics using an Automatic Differentiation Adjoint

Derivatives for Time-Spectral Computational Fluid Dynamics using an Automatic Differentiation Adjoint Derivatives for Time-Spectral Computational Fluid Dynamics using an Automatic Differentiation Adjoint Charles A. Mader University of Toronto Institute for Aerospace Studies Toronto, Ontario, Canada Joaquim

More information

Aeroelastic Analysis of Engine Nacelle Strake Considering Geometric Nonlinear Behavior

Aeroelastic Analysis of Engine Nacelle Strake Considering Geometric Nonlinear Behavior Aeroelastic Analysis of Engine Nacelle Strake Considering Geometric Nonlinear Behavior N. Manoj Abstract The aeroelastic behavior of engine nacelle strake when subjected to unsteady aerodynamic flows is

More information

DG Methods for Aerodynamic Flows: Higher Order, Error Estimation and Adaptive Mesh Refinement

DG Methods for Aerodynamic Flows: Higher Order, Error Estimation and Adaptive Mesh Refinement HONOM 2011 in Trento DG Methods for Aerodynamic Flows: Higher Order, Error Estimation and Adaptive Mesh Refinement Institute of Aerodynamics and Flow Technology DLR Braunschweig 11. April 2011 1 / 35 Research

More information

Performance. 5. More Aerodynamic Considerations

Performance. 5. More Aerodynamic Considerations Performance 5. More Aerodynamic Considerations There is an alternative way of looking at aerodynamic flow problems that is useful for understanding certain phenomena. Rather than tracking a particle of

More information

There are no simple turbulent flows

There are no simple turbulent flows Turbulence 1 There are no simple turbulent flows Turbulent boundary layer: Instantaneous velocity field (snapshot) Ref: Prof. M. Gad-el-Hak, University of Notre Dame Prediction of turbulent flows standard

More information

An Investigation of the Attainable Efficiency of Flight at Mach One or Just Beyond

An Investigation of the Attainable Efficiency of Flight at Mach One or Just Beyond An Investigation of the Attainable Efficiency of Flight at Mach One or Just Beyond Antony Jameson Department of Aeronautics and Astronautics AIAA Aerospace Sciences Meeting, Reno, NV AIAA Paper 2007-0037

More information

AN UNCERTAINTY ESTIMATION EXAMPLE FOR BACKWARD FACING STEP CFD SIMULATION. Abstract

AN UNCERTAINTY ESTIMATION EXAMPLE FOR BACKWARD FACING STEP CFD SIMULATION. Abstract nd Workshop on CFD Uncertainty Analysis - Lisbon, 19th and 0th October 006 AN UNCERTAINTY ESTIMATION EXAMPLE FOR BACKWARD FACING STEP CFD SIMULATION Alfredo Iranzo 1, Jesús Valle, Ignacio Trejo 3, Jerónimo

More information

Chapter 5 Wing design - selection of wing parameters 2 Lecture 20 Topics

Chapter 5 Wing design - selection of wing parameters 2 Lecture 20 Topics Chapter 5 Wing design - selection of wing parameters Lecture 0 Topics 5..4 Effects of geometric parameters, Reynolds number and roughness on aerodynamic characteristics of airfoils 5..5 Choice of airfoil

More information

Is My CFD Mesh Adequate? A Quantitative Answer

Is My CFD Mesh Adequate? A Quantitative Answer Is My CFD Mesh Adequate? A Quantitative Answer Krzysztof J. Fidkowski Gas Dynamics Research Colloqium Aerospace Engineering Department University of Michigan January 26, 2011 K.J. Fidkowski (UM) GDRC 2011

More information

Optimum aerodynamic design using the Navier-Stokes equations

Optimum aerodynamic design using the Navier-Stokes equations Copyright 1997, American Institute of Aeronautics and Astronautics, Inc. AIAA Meeting Papers on Disc, January 1997 A9715189, AF-AFOSR-91-0391, AIAA Paper 97-0101 Optimum aerodynamic design using the Navier-Stokes

More information

CEAS-SCAD, November 2014, Onera Toulouse, France

CEAS-SCAD, November 2014, Onera Toulouse, France 1 NUMERICAL AND EXPERIMENTAL INVESTIGATIONS OF THE BOUNDARY LAYER INGESTION (BLI) AND DISTRIBUTED PROPULSION CONCEPTS O. Atinault, G. Carrier, J.L. Godard, R. Grenon, C. Verbeke, P. Viscat, M Méheut Applied

More information

Local Preconditioning for Low Mach-number Aerodynamic Flow Simulation with a Steady Compressible Navier-Stokes Flow Solver

Local Preconditioning for Low Mach-number Aerodynamic Flow Simulation with a Steady Compressible Navier-Stokes Flow Solver Local Preconditioning for Low Mach-number Aerodynamic Flow Simulation with a Steady Compressible Navier-Stokes Flow Solver Kurt Sermeus and Eric Laurendeau Advanced Aerodynamics Department Bombardier Aerospace

More information

Divergence Formulation of Source Term

Divergence Formulation of Source Term Preprint accepted for publication in Journal of Computational Physics, 2012 http://dx.doi.org/10.1016/j.jcp.2012.05.032 Divergence Formulation of Source Term Hiroaki Nishikawa National Institute of Aerospace,

More information

Design and Computational Studies on Plain Flaps

Design and Computational Studies on Plain Flaps Bonfring International Journal of Industrial Engineering and Management Science, Vol. 3, No. 2, June 2013 33 Design and Computational Studies on Plain Flaps M. Senthil Kumar and K. Naveen Kumar Abstract---

More information

Multidisciplinary Design Optimization of Aerospace Systems

Multidisciplinary Design Optimization of Aerospace Systems Please cite this document as: Martins, Joaquim R. R. A., Multidisciplinary Design Optimization of Aerospace Systems, Advances and Trends in Optimization with Engineering Applications, SIAM, 2017, pp. 249

More information

Copyright 2003 by the American Institute of Aeronautics and Astronautics Inc. All rights reserved

Copyright 2003 by the American Institute of Aeronautics and Astronautics Inc. All rights reserved 1 ISABE29-1225 COMPUTATION OF SECOND-ORDER SENSITIVITIES OF THE TOTAL PRESSURE LOSSES FUNCTIONAL IN CASCADE FLOWS T. Zervogiannis, D.I. Papadimitriou and K.C. Giannakoglou National Technical University

More information

DESIGN & COMPUTATIONAL FLUID DYNAMICS ANALYSES OF AN AXISYMMETRIC NOZZLE AT TRANSONIC FREE STREAM CONDITIONS

DESIGN & COMPUTATIONAL FLUID DYNAMICS ANALYSES OF AN AXISYMMETRIC NOZZLE AT TRANSONIC FREE STREAM CONDITIONS DESIGN & COMPUTATIONAL FLUID DYNAMICS ANALYSES OF AN AXISYMMETRIC NOZZLE AT TRANSONIC FREE STREAM CONDITIONS S Wasim Akram 1, S. Rajesh 2 1 M.Tech Student, Department of Mechanical Engineering, Krishna

More information

MULTIGRID CALCULATIONS FOB. CASCADES. Antony Jameson and Feng Liu Princeton University, Princeton, NJ 08544

MULTIGRID CALCULATIONS FOB. CASCADES. Antony Jameson and Feng Liu Princeton University, Princeton, NJ 08544 MULTIGRID CALCULATIONS FOB. CASCADES Antony Jameson and Feng Liu Princeton University, Princeton, NJ 0544 1. Introduction Development of numerical methods for internal flows such as the flow in gas turbines

More information

How Many Steps are Required to Solve the Euler Equations of Steady, Compressible Flow: In Search of a Fast Solution Algorithm

How Many Steps are Required to Solve the Euler Equations of Steady, Compressible Flow: In Search of a Fast Solution Algorithm AIAA 2 2673 How Many Steps are Required to Solve the Euler Equations of Steady, Compressible Flow: In Search of a Fast Solution Algorithm Antony Jameson Stanford University Stanford, CA 9435 D. A. Caughey

More information

OpenFOAM Simulations for MAV Applications

OpenFOAM Simulations for MAV Applications 16 th Annual CFD Symposium 11th-12th August 2014, Bangalore 1 OpenFOAM Simulations for MAV Applications Syed Zahid*, A. Rajesh, M.B. Subrahmanya, B.N. Rajani *Student, Dept. of Mech. Engg, SDM, Dharwad,

More information

Feedback Control of Aerodynamic Flows

Feedback Control of Aerodynamic Flows 44th AIAA Aerospace Sciences Meeting and Exhibit 9-12 January 26, Reno, Nevada AIAA 26-843 44th AIAA Aerospace Sciences Meeting and Exhibit, Reno, Nevada, 9 12 Jan, 26. Feedback Control of Aerodynamic

More information

Aerodynamic force analysis in high Reynolds number flows by Lamb vector integration

Aerodynamic force analysis in high Reynolds number flows by Lamb vector integration Aerodynamic force analysis in high Reynolds number flows by Lamb vector integration Claudio Marongiu, Renato Tognaccini 2 CIRA, Italian Center for Aerospace Research, Capua (CE), Italy E-mail: c.marongiu@cira.it

More information

Finite volume method on unstructured grids

Finite volume method on unstructured grids Finite volume method on unstructured grids Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in/~praveen

More information

Scalable parallel approach for high-fidelity steady-state aeroelastic analysis and adjoint derivative computations

Scalable parallel approach for high-fidelity steady-state aeroelastic analysis and adjoint derivative computations This is a preprint of the following article, which is available from http://mdolab.engin.umich.edu Gaetan K. W. Kenway, Graeme J. Kennedy, and Joaquim R. R. A. Martins, Scalable Parallel Approach for High-

More information

Drag Computation (1)

Drag Computation (1) Drag Computation (1) Why drag so concerned Its effects on aircraft performances On the Concorde, one count drag increase ( C D =.0001) requires two passengers, out of the 90 ~ 100 passenger capacity, be

More information

RANS Solutions Using High Order Discontinuous Galerkin Methods

RANS Solutions Using High Order Discontinuous Galerkin Methods RANS Solutions Using High Order Discontinuous Galerkin Methods Ngoc Cuong Nguyen, Per-Olof Persson and Jaime Peraire Massachusetts Institute of Technology, Cambridge, MA 2139, U.S.A. We present a practical

More information

Numerical Solution of Partial Differential Equations governing compressible flows

Numerical Solution of Partial Differential Equations governing compressible flows Numerical Solution of Partial Differential Equations governing compressible flows Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore

More information

Resolving the dependence on free-stream values for the k-omega turbulence model

Resolving the dependence on free-stream values for the k-omega turbulence model Resolving the dependence on free-stream values for the k-omega turbulence model J.C. Kok Resolving the dependence on free-stream values for the k-omega turbulence model J.C. Kok This report is based on

More information

LINEARISED FREQUENCY DOMAIN GUST ANALYSIS OF LARGE CIVIL AIRCRAFT

LINEARISED FREQUENCY DOMAIN GUST ANALYSIS OF LARGE CIVIL AIRCRAFT ECCOMAS Congress 2016 VII European Congress on Computational Methods in Applied Sciences and Engineering M. Papadrakakis, V. Papadopoulos, G. Stefanou, V. Plevris (eds.) Crete Island, Greece, 5 10 June

More information

Parametric Investigation of Hull Shaped Fuselage for an Amphibious UAV

Parametric Investigation of Hull Shaped Fuselage for an Amphibious UAV Ninth International Conference on Computational Fluid Dynamics (ICCFD9), Istanbul, Turkey, July 11-15, 2016 ICCFD9-2016-226 Parametric Investigation of Hull Shaped Fuselage for an Amphibious UAV Emre Sazak

More information

Total Pressure Losses Minimization in Turbomachinery Cascades, using a New Continuous Adjoint Formulation

Total Pressure Losses Minimization in Turbomachinery Cascades, using a New Continuous Adjoint Formulation Total Pressure Losses Minimization in Turbomachinery Cascades, using a New Continuous Adjoint Formulation D.I. Papadimitriou, K.C. Giannakoglou Laboratory of Thermal Turbomachines, National Technical University

More information

Design of a Droopnose Configuration for a Coanda Active Flap Application. Marco Burnazzi and Rolf Radespiel

Design of a Droopnose Configuration for a Coanda Active Flap Application. Marco Burnazzi and Rolf Radespiel Design of a Droopnose Configuration for a Coanda Active Flap Application Marco Burnazzi and Rolf Radespiel Institute of Fluid Mechanics, Technische Universität Braunschweig, 38108 Braunschweig, Germany

More information

Numerical Simulation of Flow Field around an Inflatable Vehicle during a Reentry Demonstration Flight considering Membrane Deformation

Numerical Simulation of Flow Field around an Inflatable Vehicle during a Reentry Demonstration Flight considering Membrane Deformation Numerical Simulation of Flow Field around an Inflatable Vehicle during a Reentry Demonstration Flight considering Membrane Deformation Dongheun HA 1,Yusuke TAKAHASHI 1 Kazuhiko YAMADA 2 1) Hokkaido Univ.

More information

PROGRESS IN THE PREDICTION OF AEROSERVOELASTIC INSTABILITIES ON LARGE CIVIL TRANSPORT AIRCRAFT

PROGRESS IN THE PREDICTION OF AEROSERVOELASTIC INSTABILITIES ON LARGE CIVIL TRANSPORT AIRCRAFT ICAS 2000 CONGRESS PROGRESS IN THE PREDICTION OF AEROSERVOELASTIC INSTABILITIES ON LARGE CIVIL TRANSPORT AIRCRAFT M.LACABANNE, A.LAPORTE AEROSPATIALE MATRA AIRBUS, 31060 Toulouse Cedex 03, France Abstract

More information

Variable Normalization (nondimensionalization and scaling) for Navier-Stokes equations: a practical guide

Variable Normalization (nondimensionalization and scaling) for Navier-Stokes equations: a practical guide TR-CFD-13-77 Variable Normalization (nondimensionalization and scaling) for Navier-Stokes equations: a practical guide Marc Montagnac Technical Report V. 1.0 October 013 Copyrighted by the author(s) Centre

More information

Introduction to Aerodynamics. Dr. Guven Aerospace Engineer (P.hD)

Introduction to Aerodynamics. Dr. Guven Aerospace Engineer (P.hD) Introduction to Aerodynamics Dr. Guven Aerospace Engineer (P.hD) Aerodynamic Forces All aerodynamic forces are generated wither through pressure distribution or a shear stress distribution on a body. The

More information

Contrasting the Harmonic Balance and Linearized Methods for Oscillating-Flap Simulations

Contrasting the Harmonic Balance and Linearized Methods for Oscillating-Flap Simulations Contrasting the Harmonic Balance and Linearized Methods for Oscillating-Flap Simulations Guillaume Dufour, Frédéric Sicot, Guillaume Puigt European Center for Research and Advanced Training in Scientific

More information

DEVELOPMENT OF A THREE-DIMENSIONAL TIGHTLY COUPLED EULER/POTENTIAL FLOW SOLVER FOR TRANSONIC FLOW

DEVELOPMENT OF A THREE-DIMENSIONAL TIGHTLY COUPLED EULER/POTENTIAL FLOW SOLVER FOR TRANSONIC FLOW DEVELOPMENT OF A THREE-DIMENSIONAL TIGHTLY COUPLED EULER/POTENTIAL FLOW SOLVER FOR TRANSONIC FLOW Yeongmin Jo*, Se Hwan Park*, Duck-Joo Lee*, and Seongim Choi *Korea Advanced Institute of Science and Technology,

More information

Transonic Flutter Prediction of Supersonic Jet Trainer with Various External Store Configurations

Transonic Flutter Prediction of Supersonic Jet Trainer with Various External Store Configurations Transonic Flutter Prediction of Supersonic Jet Trainer with Various External Store Configurations In Lee * Korea Advanced Institute of Science and Technology, Daejeon, 305-701, Korea Hyuk-Jun Kwon Agency

More information

Coupled Fluid and Heat Flow Analysis Around NACA Aerofoil Profiles at Various Mach Numbers

Coupled Fluid and Heat Flow Analysis Around NACA Aerofoil Profiles at Various Mach Numbers International Journal of Engineering Research and Technology. ISSN 0974-3154 Volume 6, Number 2 (2013), pp. 249-258 International Research Publication House http://www.irphouse.com Coupled Fluid and Heat

More information

Applications of adjoint based shape optimization to the design of low drag airplane wings, including wings to support natural laminar flow

Applications of adjoint based shape optimization to the design of low drag airplane wings, including wings to support natural laminar flow Applications of adjoint based shape optimization to the design of low drag airplane wings, including wings to support natural laminar flow Antony Jameson and Kui Ou Aeronautics & Astronautics Department,

More information

Simulation of unsteady muzzle flow of a small-caliber gun

Simulation of unsteady muzzle flow of a small-caliber gun Advances in Fluid Mechanics VI 165 Simulation of unsteady muzzle flow of a small-caliber gun Y. Dayan & D. Touati Department of Computational Mechanics & Ballistics, IMI, Ammunition Group, Israel Abstract

More information

Shape Optimisation of Axisymmetric Scramjets

Shape Optimisation of Axisymmetric Scramjets Shape Optimisation of Axisymmetric Scramjets Hideaki Ogawa 11 th International Workshop on Shock Tube Technology Australian Hypersonics Workshop 2011 University of Queensland, Brisbane 23 rd March 2011

More information

Elliptic Trailing Edge for a High Subsonic Turbine Cascade

Elliptic Trailing Edge for a High Subsonic Turbine Cascade Elliptic Trailing Edge for a High Subsonic Turbine Cascade Mahmoud M. El-Gendi 1, Mohammed K. Ibrahim 2, Koichi Mori 3, and Yoshiaki Nakamura 4 1 Graduate School of Engineering, Nagoya University, Nagoya

More information

AERODYNAMIC SHAPING OF PAYLOAD FAIRING FOR A LAUNCH VEHICLE Irish Angelin S* 1, Senthilkumar S 2

AERODYNAMIC SHAPING OF PAYLOAD FAIRING FOR A LAUNCH VEHICLE Irish Angelin S* 1, Senthilkumar S 2 e-issn 2277-2685, p-issn 2320-976 IJESR/May 2014/ Vol-4/Issue-5/295-299 Irish Angelin S et al./ International Journal of Engineering & Science Research AERODYNAMIC SHAPING OF PAYLOAD FAIRING FOR A LAUNCH

More information

Adjustment of k ω SST turbulence model for an improved prediction of stalls on wind turbine blades

Adjustment of k ω SST turbulence model for an improved prediction of stalls on wind turbine blades Adjustment of k ω SST turbulence model for an improved prediction of stalls on wind turbine blades Tawit Chitsomboon *, Chalothorn Thamthae School of Mechanical Engineering, Institute of Engineering, Suranaree

More information

Numerical study of battle damaged two-dimensional wings

Numerical study of battle damaged two-dimensional wings Advances in Fluid Mechanics IX 141 Numerical study of battle damaged two-dimensional wings S. Djellal, T. Azzam, M. Djellab & K. Lakkaichi Fluid Mechanics Laboratory Polytechnical School Bordj El Bahri,

More information

Eigenmode Analysis of Boundary Conditions for the One-dimensional Preconditioned Euler Equations

Eigenmode Analysis of Boundary Conditions for the One-dimensional Preconditioned Euler Equations NASA/CR-1998-208741 ICASE Report No. 98-51 Eigenmode Analysis of Boundary Conditions for the One-dimensional Preconditioned Euler Equations David L. Darmofal Massachusetts Institute of Technology, Cambridge,

More information

STUDY ON THE IMPROVED KRIGING-BASED OPTIMIZATION DESIGN METHOD

STUDY ON THE IMPROVED KRIGING-BASED OPTIMIZATION DESIGN METHOD 7 TH INTERNATIONAL CONGRESS OF THE AERONAUTICAL SCIENCES STUDY ON THE IMPROVED KRIGING-BASED OPTIMIZATION DESIGN METHOD Song Wenping, Xu Ruifei, Han Zhonghua (National Key Laboratory of Science and Technology

More information

AERODYNAMIC CHARACTERIZATION OF A CANARD GUIDED ARTILLERY PROJECTILE

AERODYNAMIC CHARACTERIZATION OF A CANARD GUIDED ARTILLERY PROJECTILE 45th AIAA Aerospace Sciences Meeting and Exhibit 8-11 January 27, Reno, Nevada AIAA 27-672 AERODYNAMIC CHARACTERIZATION OF A CANARD GUIDED ARTILLERY PROJECTILE Wei-Jen Su 1, Curtis Wilson 2, Tony Farina

More information

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems P.-O. Persson and J. Peraire Massachusetts Institute of Technology 2006 AIAA Aerospace Sciences Meeting, Reno, Nevada January 9,

More information

CFD COMPUTATION OF THE GROUND EFFECT ON AIRPLANE WITH HIGH ASPECT RATIO WING

CFD COMPUTATION OF THE GROUND EFFECT ON AIRPLANE WITH HIGH ASPECT RATIO WING 28 TH INTERNATIONAL CONGRESS OF THE AERONAUTICAL SCIENCES CFD COMPUTATION OF THE GROUND EFFECT ON AIRPLANE WITH HIGH ASPECT RATIO WING Sun Tae Kim*, Youngtae Kim**, Tae Kyu Reu* *Agency for Defense Development,

More information

Near-wall Reynolds stress modelling for RANS and hybrid RANS/LES methods

Near-wall Reynolds stress modelling for RANS and hybrid RANS/LES methods Platzhalter für Bild, Bild auf Titelfolie hinter das Logo einsetzen Near-wall Reynolds stress modelling for RANS and hybrid RANS/LES methods Axel Probst (now at: C 2 A 2 S 2 E, DLR Göttingen) René Cécora,

More information

Numerical Simulations of the Mars Science! Laboratory Supersonic Parachute!

Numerical Simulations of the Mars Science! Laboratory Supersonic Parachute! Numerical Simulations of the Mars Science! Laboratory Supersonic Parachute! Graham V. Candler! Vladimyr Gidzak! William L. Garrard! University of Minnesota! Keith Stein! Bethel University! Supported by

More information

Design and simulation of Open Circuit Blowdown type Wind Tunnel

Design and simulation of Open Circuit Blowdown type Wind Tunnel Design and simulation of Open Circuit Blowdown type Wind Tunnel Sanjeev Kumar Gupta a, V.K.Dwivedi b, Jitendra Kumar Chauhan c, and Rahul Goswami c a Assistant Professor, Department of Mechanical Engineering,

More information

Adjoint code development and optimization using automatic differentiation (AD)

Adjoint code development and optimization using automatic differentiation (AD) Adjoint code development and optimization using automatic differentiation (AD) Praveen. C Computational and Theoretical Fluid Dynamics Division National Aerospace Laboratories Bangalore - 560 037 CTFD

More information

Numerical Methods in Aerodynamics. Turbulence Modeling. Lecture 5: Turbulence modeling

Numerical Methods in Aerodynamics. Turbulence Modeling. Lecture 5: Turbulence modeling Turbulence Modeling Niels N. Sørensen Professor MSO, Ph.D. Department of Civil Engineering, Alborg University & Wind Energy Department, Risø National Laboratory Technical University of Denmark 1 Outline

More information

CFD in Industrial Applications and a Mesh Improvement Shock-Filter for Multiple Discontinuities Capturing. Lakhdar Remaki

CFD in Industrial Applications and a Mesh Improvement Shock-Filter for Multiple Discontinuities Capturing. Lakhdar Remaki CFD in Industrial Applications and a Mesh Improvement Shock-Filter for Multiple Discontinuities Capturing Lakhdar Remaki Outline What we doing in CFD? CFD in Industry Shock-filter model for mesh adaptation

More information

Wall treatments and wall functions

Wall treatments and wall functions Wall treatments and wall functions A wall treatment is the set of near-wall modelling assumptions for each turbulence model. Three types of wall treatment are provided in FLUENT, although all three might

More information

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 1 / 29 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS Hierarchy of Mathematical Models 1 / 29 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 2 / 29

More information

NUMERICAL INVESTIGATIONS ON THE SLENDER AXISYMMETRIC BODIES AERODYNAMICS IN WIDE RANGE OF MACH NUMBERS AND ANGLES OF ATTACK FROM 0 TO 180

NUMERICAL INVESTIGATIONS ON THE SLENDER AXISYMMETRIC BODIES AERODYNAMICS IN WIDE RANGE OF MACH NUMBERS AND ANGLES OF ATTACK FROM 0 TO 180 NUMERICAL INVESTIGATIONS ON THE SLENDER AXISYMMETRIC BODIES AERODYNAMICS IN WIDE RANGE OF MACH NUMBERS AND ANGLES OF ATTACK FROM 0 TO 180 N.V. Voevodenko*, L.G. Ivanteeva*, V.Ju. Lunin* * TsAGI Central

More information

Preliminary Study of Single Particle Lidar for Wing Wake Survey. M.Valla, B. Augère, D. Bailly, A. Dolfi-Bouteyre, E. Garnier, M.

Preliminary Study of Single Particle Lidar for Wing Wake Survey. M.Valla, B. Augère, D. Bailly, A. Dolfi-Bouteyre, E. Garnier, M. Preliminary Study of Single Particle Lidar for Wing Wake Survey M.Valla, B. Augère, D. Bailly, A. Dolfi-Bouteyre, E. Garnier, M. Méheut Context of research Clean Sky Joint Technology Initiative : Aims

More information

Shock/boundary layer interactions

Shock/boundary layer interactions Shock/boundary layer interactions Turbulent compressible channel flows F.S. Godeferd Laboratoire de Mécanique des Fluides et d Acoustique Ecole Centrale de Lyon, France Journée Calcul Intensif en Rhône

More information

AEROSPACE ENGINEERING

AEROSPACE ENGINEERING AEROSPACE ENGINEERING Subject Code: AE Course Structure Sections/Units Topics Section A Engineering Mathematics Topics (Core) 1 Linear Algebra 2 Calculus 3 Differential Equations 1 Fourier Series Topics

More information

A Physical Insight into Counter-Rotating Open Rotor In-Plane Loads

A Physical Insight into Counter-Rotating Open Rotor In-Plane Loads 21ème Congrès Français de Mécanique Bordeaux, 26 au 3 août 213 A Physical Insight into Counter-Rotating Open Rotor In-Plane Loads Ignacio Gonzalez-Martino a, Benjamin François a,b, Benoit Rodriguez c a.

More information

SIMULATION OF GAS FLOW OVER MICRO-SCALE AIRFOILS USING A HYBRID CONTINUUM-PARTICLE APPROACH

SIMULATION OF GAS FLOW OVER MICRO-SCALE AIRFOILS USING A HYBRID CONTINUUM-PARTICLE APPROACH 33rd AIAA Fluid Dynamics Conference and Exhibit 3-6 June 3, Orlando, Florida AIAA 3-44 33 rd AIAA Fluid Dynamics Conference and Exhibit / Orlando, Florida / 3-6 Jun 3 SIMULATION OF GAS FLOW OVER MICRO-SCALE

More information

Efficient Hessian Calculation using Automatic Differentiation

Efficient Hessian Calculation using Automatic Differentiation 25th AIAA Applied Aerodynamics Conference, 25-28 June 2007, Miami Efficient Hessian Calculation using Automatic Differentiation Devendra P. Ghate and Michael B. Giles Oxford University Computing Laboratory,

More information

Active Flutter Control using an Adjoint Method

Active Flutter Control using an Adjoint Method 44th AIAA Aerospace Sciences Meeting and Exhibit 9-12 January 26, Reno, Nevada AIAA 26-844 44th AIAA Aerospace Sciences Meeting and Exhibit, Reno, Nevada, 9 12 Jan, 26. Active Flutter Control using an

More information

Aerodynamic Resonance in Transonic Airfoil Flow. J. Nitzsche, R. H. M. Giepman. Institute of Aeroelasticity, German Aerospace Center (DLR), Göttingen

Aerodynamic Resonance in Transonic Airfoil Flow. J. Nitzsche, R. H. M. Giepman. Institute of Aeroelasticity, German Aerospace Center (DLR), Göttingen Aerodynamic Resonance in Transonic Airfoil Flow J. Nitzsche, R. H. M. Giepman Institute of Aeroelasticity, German Aerospace Center (DLR), Göttingen Source: A. Šoda, PhD thesis, 2006 Slide 2/39 Introduction

More information

An Introduction to the Discontinuous Galerkin Method

An Introduction to the Discontinuous Galerkin Method An Introduction to the Discontinuous Galerkin Method Krzysztof J. Fidkowski Aerospace Computational Design Lab Massachusetts Institute of Technology March 16, 2005 Computational Prototyping Group Seminar

More information

Assessment of Implicit Implementation of the AUSM + Method and the SST Model for Viscous High Speed Flow

Assessment of Implicit Implementation of the AUSM + Method and the SST Model for Viscous High Speed Flow Assessment of Implicit Implementation of the AUSM + Method and the SST Model for Viscous High Speed Flow Simone Colonia, René Steijl and George N. Barakos CFD Laboratory - School of Engineering - University

More information

Drag Characteristics of a Low-Drag Low-Boom Supersonic Formation Flying Concept

Drag Characteristics of a Low-Drag Low-Boom Supersonic Formation Flying Concept Drag Characteristics of a Low-Drag Low-Boom Supersonic Formation Flying Concept Yuichiro Goto, Shigeru Obayashi and Yasuaki Kohama Tohoku University, Sendai, Japan In this paper, a new concept for low-drag,

More information

Further Studies of Airfoils Supporting Non-unique Solutions in Transonic Flow

Further Studies of Airfoils Supporting Non-unique Solutions in Transonic Flow 29th AIAA Applied Aerodynamics Conference 27-30 June 2011, Honolulu, Hawaii AIAA 2011-3509 Further Studies of Airfoils Supporting Non-unique Solutions in Transonic Flow Antony Jameson, John C. Vassberg,

More information

Zonal modelling approach in aerodynamic simulation

Zonal modelling approach in aerodynamic simulation Zonal modelling approach in aerodynamic simulation and Carlos Castro Barcelona Supercomputing Center Technical University of Madrid Outline 1 2 State of the art Proposed strategy 3 Consistency Stability

More information