Aerodynamic Shape Optimization in Three-Dimensional Turbulent Flows Using a Newton-Krylov Approach

Size: px
Start display at page:

Download "Aerodynamic Shape Optimization in Three-Dimensional Turbulent Flows Using a Newton-Krylov Approach"

Transcription

1 Aerodynamic Shape Optimization in Three-Dimensional Turbulent Flows Using a Newton-Krylov Approach Lana M. Osusky and David W. Zingg University of Toronto Institute for Aerospace Studies, 4925 Dufferin Street, Toronto, ON, M3H 5T6, Canada lana@oddjob.utias.utoronto.ca ABSTRACT A parallel Newton-Krylov discrete-adjoint method is presented for gradient-based aerodynamic shape optimization in fully turbulent three-dimensional flow. The use of an integrated B-spline parameterization and mesh movement scheme allows for fast and accurate mesh updates that can accommodate large shape changes. Flow analyses are performed using a parallel Newton-Krylov algorithm with approximate-schur preconditioning. Turbulence is modelled using the Spalart-Allmaras one-equation model. We validate the algorithm with an inverse design optimization. Examples are presented to demonstrate the overall effectiveness of this approach to aerodynamic shape optimization. INTRODUCTION Over the last ten years, fuel costs have eclipsed labour costs to become the dominant operational expenditure of airlines around the world. Given the current economic climate, the airline industry could benefit immensely from a fleet of more efficient aircraft with reduced drag that consequently burn less fuel. Increased demand is being placed on numerical methods to solve aerodynamic design problems accurately and efficiently. Gradient-based optimization has become a popular approach to determining optimal aerodynamic designs, particularly since the introduction of adjointbased methods by Pironneau [] and Jameson [2], which makes the cost of a gradient evaluation virtually independent of the number of design variables. PhD Candidate, AIAA Student Member Professor and Director, Tier Canada Research Chair in Computational Fluid Dynamics, J. Armand Bombardier Foundation Chair in Aerospace Flight Jameson, Reuther, and colleagues applied the adjoint method to two-dimensional inviscid aerodynamic design problems [3] and then extended their work to three-dimensional constrained multi-point problems [4, 5, 6]. Jameson et al. [7] used the continuous adjoint approach to optimize wings and wing-body configurations based on the compressible Navier-Stokes equations. Anderson and Bonhaus [8] performed airfoil optimizations on unstructured grids using a discreteadjoint approach to the Navier-Stokes equations coupled with the one-equation Spalart-Allmaras turbulence model. Nemec and Zingg [9, ] demonstrated the efficiency of a Newton-Krylov scheme in performing two-dimensional aerodynamic shape optimization based on the Navier-Stokes equations and the Spalart- Allmaras turbulence model. Laminar-turbulent transition prediction was incorporated into a gradient-based Newton-Krylov optimization algorithm by Driver and Zingg [] and was used to design a series of highlift airfoils. Hicken and Zingg [2] performed a series of drag minimization studies of non-planar wing configurations in three-dimensional Euler flow; the work presented in this paper is an extension of the Eulerbased optimizer to include viscous and turbulent flow phenomena. 2 GEOMETRY PARAMETERIZATION AND MESH MOVEMENT Each block of a multi-block computational mesh is approximated with a B-spline tensor volume. The subset of B-spline control points associated with the aerodynamic surface geometry is used as the set of design variables for optimization, either individually for local changes, or coupled via a set of planform variables, such as sweep or twist. Mesh movement is carried out using a hybrid approach that combines a robust lin-

2 ear elasticity approach and an algebraic scheme. The nodes of the coarse B-spline control mesh are updated based on the principles of linear elasticity [3, 4]: M (i) (b (i ),b (i) )=K (i) (b (i ) )[b (i) b (i ) ] f (i) =, 3 FLOW ANALYSIS We solve the three-dimensional Navier-Stokes equations using a Newton-Krylov method with a flexible GMRES linear solver and approximate-schur parallel preconditioning [6, 7]. The governing equations are expressed in terms of the curvilinear coordinates by i=,...,m () wherem (i) is the mesh movement residual, b (i) is the set of B-spline control point coordinates for the entire computational domain, K is the global stiffness matrix at increment i, and m is the number of increments. The force vector f (i) at each increment is implicitly defined by the displacements of the surface and far-field control points. We typically perform the control mesh updates of () in five increments, which strikes a balance between speed and robustness in accommodating large changes in the geometry [4]. Because the control mesh is typically hundreds of times smaller than the fine computational mesh, the linear elasticity-based mesh movement requires minimal computational time and reduces the size of the mesh adjoint problem compared to applying the same method to the fine mesh. The fine mesh is updated algebraically based on the equations defining the B-spline volume mappings: x(ξ)= N i N j N k i= j= k= B i jk N (p) i (ξ)n (p) j (η)n (p) k (ζ), (2) where x(ξ) represents the set of Cartesian coordinates of the B-spline volume, N (p) i, j,k are the pth -order basis functions in each of the three coordinate directions, and B i jk are the B-spline control points for the given B-spline volume. We use p = 4, which produces cubic B-spline volumes. Using this hybrid approach allows us to perform mesh updates in a matter of seconds. It has been found that that substantial fitting error is incurred when obtaining B-spline volumes for computational domains with very fine grid spacings, which are required in order to capture turbulent flow features [5]. We avoid this issue by obtaining the B-spline for a relatively coarse mesh with an off-wall spacing of approximately 3 and subsequently refining the computational mesh (not the B-spline control mesh) by either redistributing the existing nodes such that the desired spacings are obtained, inserting additional nodes, or both. t ˆQ+ ξ Ê+ η ˆF+ ζ Ĝ= Re ( ξ Ê v + η ˆF v + ζ Ĝ v ), (3) where Re is the Reynolds number, ˆQ holds the set of conservative flow variables, (Ê, ˆF, Ĝ) are the inviscid fluxes, and (Ê v, ˆF v, Ĝ v ) are the viscous fluxes. Turbulence is represented by the Spalart-Allmaras one-equation turbulence model [8], which can be expressed as ν t = M( ν) ν+p( ν) ν D( ν) ν+t, (4) where M( ν) ν represents advection and diffusion, P( ν) ν is a production source term, D( ν) ν is a wall destruction source term, and T is a trip function representing the transition point at which the flow becomes turbulent. The work in this paper assumes fully turbulent flow; consequently, the trip term is not used. The governing equations are discretized using secondorder accurate summation-by-parts (SBP) operators [9] with the scalar artificial dissipation model first developed by Jameson et al. [2] and refined by Pulliam [2]. Simultaneous Approximation Terms (SATs) are used to enforce boundary conditions and the coupling of adjoining blocks in the computational mesh. The use of SATs allows us to solve the governing equations for a given block with less information required from neighbouring blocks compared to methods that make use of halo nodes. The subsequent reduction in inter-processor communication results in a faster solution method. Mesh generation is also made easier, as the SAT implementation eliminates the need for slope continuity at block interfaces. Further information on the development and implementation of the SBP-SATs can be found in references [6, 7, 22, 23]. The discretized governing equations produce the large, sparse system of linear equations given by R(v,b (m),q)=, (5) where R is the residual vector, v is the vector of design variables, b (m) represents the B-spline control

3 point coordinates for each volume at the completion of the mesh movement, and q is the vector of conservative flow variables. Applying an implicit-euler time-marching method to (5) results in the sparse linear system given by ( ) I t A(n) q (n) = R (n), (6) where n is the outer iteration, t is the time step,i is an identity matrix,r (n) =R(q (n) ), q (n) = q (n+) q (n), and A (n) is the flow Jacobian matrix: A (n) i j = R(n) i. (7) q j The system is solved using GMRES with approximate- Schur preconditioning [24, 6, 25]. The solution scheme makes use of an approximate-newton start-up phase, which involves a first-order approximation of the flow Jacobian as well as a spatially-varying time step, to form a suitable initial iterate. After the residual has been reduced by 4 orders of magnitude, the solver switches over to an inexact-newton method, which reduces the residual norm to a relative tolerance of. Deep convergence of the flow solver is required for the convergence of the optimizer. 4 GRADIENT-BASED OPTIMIZATION We use the gradient-based sequential quadratic programming optimization algorithm SNOPT [26], which finds the stationary point of an augmented Lagrangian merit function that enforces linear constraints exactly and incorporates non-linear constraints into the merit function via sets of adjoint variables. The use of a gradient-based optimizer necessitates the efficient and accurate computation of the objective and constraint gradients. In this work, the gradients are evaluated using the discrete-adjoint approach [27, 7]. Since the time required for one computation of the gradient is virtually independent of the number of design variables, this method is an attractive one for large-scale optimizations with many design variables. SNOPT finds the stationary point of a Lagrangian merit function of the form L(v,b (m),q, λ (i) m i=, ψ)=j(v,b(m),q) + m i= λ (i)t M (i) (v,b (i ),b (i) ) + ψ T R(v,b (m),q), (8) where the mesh residual and flow residual equations, M and R, respectively, are incorporated as non-linear constraints via the adjoint variables λ and ψ. Additionally, J is the objective function, v is the vector of design variables, b (i) represents the set of B-spline control points at the i th increment of the mesh movement, and q is the vector of flow variables. Any other nonlinear constraints, such as lift, volume, or area, would be included in a similar manner. The gradient of (8) can be expressed as ( ) G = J m v + λ (i)t M (i) + ψ T R i= v v, (9) but, in practice, is broken down into a series of intermediate systems and solved sequentially. After (5) is solved for the updated set of flow variables, q, the flow adjoint system given by ( ) R T ( ) J T ψ= () q q is solved to a tolerance of using a flexible and simplified variant of GCROT [28] for the flow adjoint variables, ψ. Next, we obtain the mesh adjoint variables, λ (m), corresponding to the final increment of the mesh movement by using the conjugate gradient method preconditioned with ILU() to solve ( M (m) b (m) ) T ( ) λ (m) J T ( ) R T = b (m) b (m) ψ. () The mesh adjoint variables, λ (i), corresponding to mesh movement increments through m are obtained by using the preconditioned conjugate gradient method to solve ( M (i) b (i) ) T λ (i) = ( M (i+) b (i) ) T λ (i+), i {m,m 2,...,}. (2) In each of the mesh adjoint equations, the residual is reduced by 2 orders of magnitude.

4 5 RESULTS 5. Wing in Turbulent Transonic Flow with Section Design Variables We minimize the drag of a rectangular planar wing with a semi-span of 2., a root chord of., and, initially, RAE2822 sections in turbulent transonic flow. The Mach number is.8, the Reynolds number is 6.5 million, and the initial angle of attack is.5 degrees; at these flow conditions, shocks are present on the upper and lower surfaces of the wing. The lift coefficient, calculated using the surface area as a reference area, is constrained to its initial value of.2722, and the wing volume is constrained to be greater than or equal to its initial value of.58. The 24-block computational mesh is made up of 2.94 million nodes and the grid node redistribution technique discussed in Section 2 is used to obtain an offwall spacing of.23 6 root chord units. Each of the 24 control volumes is made up of control points; the z-coordinates of the control points corresponding to the wing surface are used as design variables, with the exception of the control points near the leading and trailing edges. The angle of attack is also free, resulting in a total of 54 design variables. The optimizer reduces the drag coefficient by 5.7% and virtually eliminates the surface shocks while maintaining the desired lift coefficient and minimum volume targets. The initial and final drag coefficients are.74 and.46, respectively. There is minimal change in the angle of attack. These results are obtained after 33 function evaluations, where one function evaluation is defined as one flow solve and one gradient evaluation. Approximately 5 hours of CPU time were required using 24 processors. Comparisons of the coefficient of pressure and section geometries of the initial and optimized wings are shown in Figures and 2, respectively. The convergence history is shown in Figure 3, where we see a decrease in the optimality, which is a measure of the gradient, of approximately one order of magnitude. 5.2 Wing in Turbulent Transonic Flow with Planform Design Variables A second lift-constrained drag minimization is performed for an initially rectangular planar wing with NACA2 cross sections. The wing dimensions and computational mesh are the same as those of the case discussed in the preceding section. The Mach number is.8, the Reynolds number is 6.5 million, and the initial angle of attack is 2.8 degrees. The lift coefficient is constrained to a value of.292 and the surface area is constrained to be no less than its starting value of The B-spline control points corresponding to the wing surface are coupled to a set of planform design variables: leading edge sweep, trailing edge sweep, span, and the vertical position (defined in terms of dihedral angles) of the leading- and trailing-edge control points at 8 span-wise stations along the wing (which can effectively create dihedral and twist). The angle of attack is an additional design variable, for a total of 2 design variables. All of the design variables are scaled based on their respective initial objective gradient values. The sweep and dihedral angle variables all have an upper limit of 3 degrees imposed on them in order to prevent excessively large shape changes that could keep the mesh movement algorithm from converging. The span has an upper limit of root chord units. Over the course of 26 function evaluations, which required approximately 48 hours on 24 processors, the drag coefficient was reduced from.27 to.29, a 4.8% improvement, while satisfying the lift and surface area constraints. The drag reduction can be seen in the convergence plots in Figure 4, along with a reduction in optimality of three orders of magnitude. Note that the merit function represents drag values that are unscaled by the reference area. The initial and optimized geometries are compared in Figure 5, where the initial geometry is shown above the optimized geometry. The locations of the B-spline control points are shown as red spheres on the initial wing and blue spheres on the optimized wing. The leading edge sweep reached its upper limit of 3. degrees, while the trailing edge sweep increased to 29.4 degrees. The maximum span-wise dihedral angles along the leading- and trailing-edges are reached at the wing tip, where the leading-edge dihedral is 2.7 degrees and the trailing-edge dihedral is 3. degrees. The angle of attack reaches a final value of 7.32 degrees. There is no change in the span. 6 CONCLUSIONS We have presented an efficient numerical tool for aerodynamic shape optimization in three-dimensional turbulent flow. A unique integrated geometry parameterization and mesh movement scheme approximates the computational mesh with B-spline volumes and subsequently moves these volumes based on the equations of linear elasticity. Flow analysis is performed using a parallel Newton-Krylov flow solver with approximate-

5 Schur preconditioning. Objective and constraint gradients are calculated using the discrete-adjoint approach and used by the gradient-based optimizer SNOPT to find an optimum in the design space. We have demonstrated the performance of the optimization algorithm through two lift-constrained drag minimization studies in turbulent transonic flow involving the use of section and planform design variables. In each case, a substantial reduction in drag is achieved while maintaining a target lift coefficient. Future work will include multipoint optimization, studies of alternative wing tip treatments, and an investigation into multi-modality in the design space. Ultimately, this work will be used within an aero-structural optimization framework. 7 ACKNOWLEDGEMENTS The authors gratefully acknowledge the financial assistance provided by the Natural Sciences and Engineering Research Council (NSERC), the Canada Research Chairs program, Bombardier Aerospace, MITACS, Zonta International, and the University of Toronto. REFERENCES [] O. Pironneau. On optimum design in fluid mechanics. Journal of Fluid Mechanics, 64():97, 974. [2] A. Jameson. Aerodynamic design via control theory. Journal of Scientific Computing, 3(3):233 26, 988. [3] A. Jameson and J. Reuther. Control theory based airfoil design using Euler equations. In AIAA/USAF/NASA/ISSMO Symposium on Multidisciplinary Analysis and Optimization. Panama City Beach, September 994. [4] J. Reuther, A. Jameson, J. Farmer, L. Martinelli, and D. Saunders. Aerodynamic shape optimization of complex aircraft configurations via an adjoint formulation. In The 34rd AIAA Aerospace Sciences Meeting and Exhibit, AIAA Reno, Nevada, 996. [5] J. J. Reuther, A. Jameson, J. J. Alonso, M. J. Rimlinger, and D. Saunders. Constrained multipoint aerodynamic shape optimization using an adjoint formulation and parallel computers, part. AIAA Journal, 36():5 6, January 999. [6] J. J. Reuther, A. Jameson, J. J. Alonso, M. J. Rimlinger, and D. Saunders. Constrained multipoint aerodynamic shape optimization using an adjoint formulation and parallel computers, part 2. AIAA Journal, 36():6 74, January 999. [7] A. Jameson, L. Martinelli, and N. A. Pierce. Optimum aerodynamic design using the Navier- Stokes equations. Theoretical and Computational Fluid Dynamics, :23 237, 998. [8] W. K. Anderson and D. L. Bonhaus. Airfoil design on unstructured grids for turbulent flows. AIAA Journal, 37(2):85 9, February 999. [9] M. Nemec. Optimal Shape Design of Aerodynamic Configurations: A Newton-Krylov Approach. Ph.D. thesis, University of Toronto, Toronto, Ontario, Canada, 23. [] M. Nemec, D. W. Zingg, and T. H. Pulliam. Multipoint and multi-objective aerodynamic shape optimization. AIAA Journal, 42(6):57 65, 24. [] J. Driver and D. W. Zingg. Numerical aerodynamic optimization incorporating laminarturbulent transition prediction. AIAA Journal, 45(8):8 88, August 27. [2] J. Hicken and D. Zingg. Induced drag minimization of nonplanar geometries based on the Euler equations. AIAA Journal, 48(): , 2. [3] A. H. Truong, C. A. Oldfield, and D. W. Zingg. Mesh movement for a discrete-adjoint Newton- Krylov algorithm for aerodynamic optimization. AIAA Journal, 46(7):695 74, July 28. [4] J. E. Hicken and D. W. Zingg. Aerodynamic optimization algorithm with integrated geometry parameterization and mesh movement. AIAA Journal, 48(2):4 43, February 2. [5] L. Osusky and D. W. Zingg. A Novel Aerodynamic Shape Optimization Approach for Three- Dimensional Turbulent Flows. In 5th AIAA Aerospace Sciences Meeting, AIAA Nashville, Tennessee, United States, January 22. [6] J. E. Hicken and D. W. Zingg. A parallel Newton- Krylov solver for the Euler equations discretized using simultaneous approximation terms. AIAA Journal, 46(): , November 28. [7] M. Osusky, J. E. Hicken, and D. W. Zingg. A parallel Newton-Krylov-Schur flow solver for the Navier-Stokes equations using the SBP-SAT approach. In 48th AIAA Aerospace Sciences Meeting and Aerospace Exposition, AIAA 2 6. Orlando, Florida, United States, January 2. [8] P. R. Spalart and S. R. Allmaras. A one-equation turbulence model for aerodynamic flows January 992. [9] M. Svärd, K. Mattsson, and J. Nordström. Steady-state computations using Summation-by-

6 Parts operators. Journal of Scientific Computing, 24():79 95, July 25. [2] A. Jameson, W. Schmidt, and E. Turkel. Numerical solution of the Euler equations by finite volume methods using Runge-Kutta time-stepping schemes. In 4th Fluid and Plasma Dynamics Conference. Palo Alto, CA, 98. AIAA Paper [2] T. H. Pulliam. Efficient solution methods for the Navier-Stokes equations. Technical report, Lecture Notes for the von Kármán Inst. for Fluid Dynamics Lecture Series: Numerical Techniques for Viscous Flow Computation in Turbomachinery Bladings, Rhode-Saint-Genèse, Belgium, January 986. [22] M. Osusky and D. W. Zingg. A parallel Newton- Krylov-Schur flow solver for the Navier-Stokes equations using the SBP-SAT approach. In 5th AIAA Aerospace Sciences Meeting, AIAA Nashville, Tennessee, United States, January 22. [23] J. Nordström, J. Gong, E. van der Weide, and M. Svärd. A stable and conservative high order multi-block method for the compressible Navier- Stokes equations. Journal of Computational Physics, 228(24):92 935, 29. [24] Y. Saad and M. Sosonkina. Solution of distributed sparse linear systems using psparslib. In Applied Parallel Computing: Large Scale Scientific and Industial Problems, fourth International Workshop, PARA98, pages Springer Verlag, 998. [25] J. E. Hicken, M. Osusky, and D. W. Zingg. Comparison of parallel preconditioners for a Newton- Krylov flow solver. In 6th International Conference on Computational Fluid Dynamics. St. Petersburg, Russia, 2. [26] P. E. Gill, W. Murray, and M. A. Saunders. SNOPT: an SQP algorithm for large-scale constrained optimization. SIAM Journal on Optimization, 2(4):979 6, 22. [27] O. Pironneau. Optimal shape design for elliptic systems. Springer-Verlag, 983. [28] J. E. Hicken and D. W. Zingg. A simplified and flexible variant of GCROT for solving nonsymmetric linear systems. SIAM Journal on Scientific Computing, 32(3): , June 2.

7 - Initial Optimized (a) 2% span (b) 44% span (c) 65% span (d) 8% span (e) 9% span (f) 95% span Figure : Coefficient of pressure for wing optimization based on section shape.6 Initial Optimized (a) 2% span (b) 44% span (c) 65% span (d) 8% span (e) 9% span (f) 95% span Figure 2: Section shape comparison for wing optimization based on section shape

8 .36 Merit Function.35 Optimality Function evaluations 2 3 Function evaluations Figure 3: Convergence history for wing optimization based on section shape.45 Optimality Merit Function Function evaluations 2 Function evaluations Figure 4: Convergence history for wing optimization based on planform variables Z Y Z X Y X Z Y Z X X (a) Leading-edge view (b) 3D view Figure 5: Geometry comparison for wing optimization based on planform variables Y

Application of Jetstream to a Suite of Aerodynamic Shape Optimization Problems. Karla Telidetzki

Application of Jetstream to a Suite of Aerodynamic Shape Optimization Problems. Karla Telidetzki Application of Jetstream to a Suite of Aerodynamic Shape Optimization Problems by Karla Telidetzki A thesis submitted in conformity with the requirements for the degree of Master of Applied Science Graduate

More information

Comparison of parallel preconditioners for a Newton-Krylov flow solver

Comparison of parallel preconditioners for a Newton-Krylov flow solver Comparison of parallel preconditioners for a Newton-Krylov flow solver Jason E. Hicken, Michal Osusky, and David W. Zingg 1Introduction Analysis of the results from the AIAA Drag Prediction workshops (Mavriplis

More information

Improvements to a Newton-Krylov Adjoint Algorithm for Aerodynamic Optimization

Improvements to a Newton-Krylov Adjoint Algorithm for Aerodynamic Optimization Improvements to a Newton-Krylov Adjoint Algorithm for Aerodynamic Optimization David W. Zingg, Timothy M. Leung, Laslo Diosady, Anh H. Truong, and Samy Elias Institute for Aerospace Studies, University

More information

Studies of the Continuous and Discrete Adjoint Approaches to Viscous Automatic Aerodynamic Shape Optimization

Studies of the Continuous and Discrete Adjoint Approaches to Viscous Automatic Aerodynamic Shape Optimization Studies of the Continuous and Discrete Adjoint Approaches to Viscous Automatic Aerodynamic Shape Optimization Siva Nadarajah Antony Jameson Stanford University 15th AIAA Computational Fluid Dynamics Conference

More information

Single- and Multi-Point Aerodynamic Shape Optimization Using A Parallel Newton-Krylov Approach

Single- and Multi-Point Aerodynamic Shape Optimization Using A Parallel Newton-Krylov Approach 9th AIAA Computational Fluid Dynamics 22-25 June 29, San Antonio, Texas AIAA 29-383 Single- and Multi-Point Aerodynamic Shape Optimization Using A Parallel Newton-Krylov Approach Timothy M. Leung and David

More information

A parallel Newton-Krylov-Schur flow solver for the Navier-Stokes equations using the SBP-SAT approach

A parallel Newton-Krylov-Schur flow solver for the Navier-Stokes equations using the SBP-SAT approach 48th AIAA Aerospace Sciences Meeting Including the New Horizons Forum and Aerospace Exposition 4-7 January, Orlando, Florida AIAA -6 A parallel Newton-Krylov-Schur flow solver for the Navier-Stokes equations

More information

A High-Order Accurate Unstructured GMRES Solver for Poisson s Equation

A High-Order Accurate Unstructured GMRES Solver for Poisson s Equation A High-Order Accurate Unstructured GMRES Solver for Poisson s Equation Amir Nejat * and Carl Ollivier-Gooch Department of Mechanical Engineering, The University of British Columbia, BC V6T 1Z4, Canada

More information

Airfoil shape optimization using adjoint method and automatic differentiation. Praveen. C

Airfoil shape optimization using adjoint method and automatic differentiation. Praveen. C 'th Annual AeSI CFD Symposium, -2 August 2009, Bangalore Airfoil shape optimization using adjoint method and automatic differentiation Praveen. C TIFR Center for Applicable Mathematics Post Bag No. 6503,

More information

An Investigation of Directional-Coarsening And Line-Implicit Smoothing Applied to Agglomeration Multigrid

An Investigation of Directional-Coarsening And Line-Implicit Smoothing Applied to Agglomeration Multigrid An Investigation of Directional-Coarsening And Line-Implicit Smoothing Applied to Agglomeration Multigrid J. V. Lassaline Ryerson University 35 Victoria St, Toronto, ON, M5B 2K3, Canada D. W. Zingg University

More information

Interface and Boundary Schemes for High-Order Methods

Interface and Boundary Schemes for High-Order Methods 19th AIAA Computational Fluid Dynamics 22-25 June 29, San Antonio, Texas AIAA 29-3658 Interface and Boundary Schemes for High-Order Methods Xun Huan, Jason E. Hicken, and David W. Zingg Institute for Aerospace

More information

Comparison of B-spline Surface and Free-form. Deformation Geometry Control for Aerodynamic. Optimization

Comparison of B-spline Surface and Free-form. Deformation Geometry Control for Aerodynamic. Optimization Comparison of B-spline Surface and Free-form Deformation Geometry Control for Aerodynamic Optimization Christopher Lee,DavidKoo and David W. Zingg Institute for Aerospace Studies, University of Toronto

More information

Multipoint and Multi-Objective Aerodynamic Shape Optimization

Multipoint and Multi-Objective Aerodynamic Shape Optimization AIAA JOURNAL Vol. 42, No. 6, June 2004 Multipoint and Multi-Objective Aerodynamic Shape Optimization Marian Nemec and David W. Zingg University of Toronto, Toronto, Ontario M3H 5T6, Canada and Thomas H.

More information

Automatic Differentiation Adjoint of the Reynolds-Averaged Navier Stokes Equations with a Turbulence Model

Automatic Differentiation Adjoint of the Reynolds-Averaged Navier Stokes Equations with a Turbulence Model Automatic Differentiation Adjoint of the Reynolds-Averaged Navier Stokes Equations with a Turbulence Model Zhoujie Lyu and Gaetan K.W. Kenway Department of Aerospace Engineering, University of Michigan,

More information

Constrained Aero-elastic Multi-Point Optimization Using the Coupled Adjoint Approach

Constrained Aero-elastic Multi-Point Optimization Using the Coupled Adjoint Approach www.dlr.de Chart 1 Aero-elastic Multi-point Optimization, M.Abu-Zurayk, MUSAF II, 20.09.2013 Constrained Aero-elastic Multi-Point Optimization Using the Coupled Adjoint Approach M. Abu-Zurayk MUSAF II

More information

An efficient method for predicting zero-lift or boundary-layer drag including aeroelastic effects for the design environment

An efficient method for predicting zero-lift or boundary-layer drag including aeroelastic effects for the design environment The Aeronautical Journal November 2015 Volume 119 No 1221 1451 An efficient method for predicting zero-lift or boundary-layer drag including aeroelastic effects for the design environment J. A. Camberos

More information

Efficient Implicit Time-Marching Methods Using a Newton-Krylov Algorithm

Efficient Implicit Time-Marching Methods Using a Newton-Krylov Algorithm 47th AIAA Aerospace Sciences Meeting Including The New Horizons Forum and Aerospace Exposition 5-8 January 29, Orlando, Florida AIAA 29-164 Efficient Implicit Time-Marching Methods Using a Newton-Krylov

More information

Case C3.1: Turbulent Flow over a Multi-Element MDA Airfoil

Case C3.1: Turbulent Flow over a Multi-Element MDA Airfoil Case C3.1: Turbulent Flow over a Multi-Element MDA Airfoil Masayuki Yano and David L. Darmofal Aerospace Computational Design Laboratory, Massachusetts Institute of Technology I. Code Description ProjectX

More information

Automatic design procedures that use Computational Fluid Dynamics(CFD) combined with gradientbased

Automatic design procedures that use Computational Fluid Dynamics(CFD) combined with gradientbased 43rd AIAA Aerospace Sciences Meeting and Exhibit, January 10-13, 2005, Reno, NV Enhancement of Adjoint Design Methods via Optimization of Adjoint Parameters Sangho Kim Kaveh Hosseini Kasidit Leoviriyakit

More information

THE use of computer algorithms for aerodynamic shape

THE use of computer algorithms for aerodynamic shape AIAA JOURNAL Vol. 51, No. 6, June 2013 Multimodality and Global Optimization in Aerodynamic Design Oleg Chernukhin and David W. ingg University of Toronto, Toronto, Ontario M3H 5T6, Canada DOI: 10.2514/1.J051835

More information

Case C2.2: Turbulent, Transonic Flow over an RAE 2822 Airfoil

Case C2.2: Turbulent, Transonic Flow over an RAE 2822 Airfoil Case C2.2: Turbulent, Transonic Flow over an RAE 2822 Airfoil Masayuki Yano and David L. Darmofal Aerospace Computational Design Laboratory, Massachusetts Institute of Technology I. Code Description ProjectX

More information

Solution of 2D Euler Equations and Application to Airfoil Design

Solution of 2D Euler Equations and Application to Airfoil Design WDS'6 Proceedings of Contributed Papers, Part I, 47 52, 26. ISBN 8-86732-84-3 MATFYZPRESS Solution of 2D Euler Equations and Application to Airfoil Design J. Šimák Charles University, Faculty of Mathematics

More information

Multi-Element High-Lift Configuration Design Optimization Using Viscous Continuous Adjoint Method

Multi-Element High-Lift Configuration Design Optimization Using Viscous Continuous Adjoint Method JOURNAL OF AIRCRAFT Vol. 41, No. 5, September October 2004 Multi-Element High-Lift Configuration Design Optimization Using Viscous Continuous Adjoint Method Sangho Kim, Juan J. Alonso, and Antony Jameson

More information

NUMERICAL 3D TRANSONIC FLOW SIMULATION OVER A WING

NUMERICAL 3D TRANSONIC FLOW SIMULATION OVER A WING Review of the Air Force Academy No.3 (35)/2017 NUMERICAL 3D TRANSONIC FLOW SIMULATION OVER A WING Cvetelina VELKOVA Department of Technical Mechanics, Naval Academy Nikola Vaptsarov,Varna, Bulgaria (cvetelina.velkova1985@gmail.com)

More information

High-order solutions of transitional flow over the SD7003 airfoil using compact finite-differencing and filtering

High-order solutions of transitional flow over the SD7003 airfoil using compact finite-differencing and filtering High-order solutions of transitional flow over the SD7003 airfoil using compact finite-differencing and filtering Daniel J. Garmann and Miguel R. Visbal Air Force Research Laboratory, Wright-Patterson

More information

OPTIMIZATIONS OF AIRFOIL AND WING USING GENETIC ALGORITHM

OPTIMIZATIONS OF AIRFOIL AND WING USING GENETIC ALGORITHM ICAS22 CONGRESS OPTIMIZATIONS OF AIRFOIL AND WING USING GENETIC ALGORITHM F. Zhang, S. Chen and M. Khalid Institute for Aerospace Research (IAR) National Research Council (NRC) Ottawa, K1A R6, Ontario,

More information

Multi-point Aero-Structural Optimization of Wings Including Planform Variations

Multi-point Aero-Structural Optimization of Wings Including Planform Variations 45 th Aerospace Sciences Meeting and Exhibit, January 8, 007, Reno, Nevada Multi-point Aero-Structural Optimization of Wings Including Planform Variations Antony Jameson, Kasidit Leoviriyakit and Sriram

More information

Mesh Movement for a Discrete-Adjoint Newton-Krylov Algorithm for Aerodynamic Optimization

Mesh Movement for a Discrete-Adjoint Newton-Krylov Algorithm for Aerodynamic Optimization Mesh Movement for a Discrete-Adjoint Newton-Krylov Algorithm for Aerodynamic Optimization Anh H. Truong, Chad A. Oldfield and David W. Zingg Institute for Aerospace Studies, University of Toronto 4925

More information

State of the art at DLR in solving aerodynamic shape optimization problems using the discrete viscous adjoint method

State of the art at DLR in solving aerodynamic shape optimization problems using the discrete viscous adjoint method DLR - German Aerospace Center State of the art at DLR in solving aerodynamic shape optimization problems using the discrete viscous adjoint method J. Brezillon, C. Ilic, M. Abu-Zurayk, F. Ma, M. Widhalm

More information

Limiters for Unstructured Higher-Order Accurate Solutions of the Euler Equations

Limiters for Unstructured Higher-Order Accurate Solutions of the Euler Equations Limiters for Unstructured Higher-Order Accurate Solutions of the Euler Equations Krzysztof Michalak and Carl Ollivier-Gooch Advanced Numerical Simulation Laboratory University of British Columbia Higher-order

More information

Debojyoti Ghosh. Adviser: Dr. James Baeder Alfred Gessow Rotorcraft Center Department of Aerospace Engineering

Debojyoti Ghosh. Adviser: Dr. James Baeder Alfred Gessow Rotorcraft Center Department of Aerospace Engineering Debojyoti Ghosh Adviser: Dr. James Baeder Alfred Gessow Rotorcraft Center Department of Aerospace Engineering To study the Dynamic Stalling of rotor blade cross-sections Unsteady Aerodynamics: Time varying

More information

THE EFFECTS OF THE PLANFORM SHAPE ON DRAG POLAR CURVES OF WINGS: FLUID-STRUCTURE INTERACTION ANALYSES RESULTS

THE EFFECTS OF THE PLANFORM SHAPE ON DRAG POLAR CURVES OF WINGS: FLUID-STRUCTURE INTERACTION ANALYSES RESULTS March 18-20, 2013 THE EFFECTS OF THE PLANFORM SHAPE ON DRAG POLAR CURVES OF WINGS: FLUID-STRUCTURE INTERACTION ANALYSES RESULTS Authors: M.R. Chiarelli, M. Ciabattari, M. Cagnoni, G. Lombardi Speaker:

More information

A DRAG PREDICTION VALIDATION STUDY FOR AIRCRAFT AERODYNAMIC ANALYSIS

A DRAG PREDICTION VALIDATION STUDY FOR AIRCRAFT AERODYNAMIC ANALYSIS A DRAG PREDICTION VALIDATION STUDY FOR AIRCRAFT AERODYNAMIC ANALYSIS Akio OCHI, Eiji SHIMA Kawasaki Heavy Industries, ltd Keywords: CFD, Drag prediction, Validation Abstract A CFD drag prediction validation

More information

Application of Wray-Agarwal Turbulence Model for Accurate Numerical Simulation of Flow Past a Three-Dimensional Wing-body

Application of Wray-Agarwal Turbulence Model for Accurate Numerical Simulation of Flow Past a Three-Dimensional Wing-body Washington University in St. Louis Washington University Open Scholarship Mechanical Engineering and Materials Science Independent Study Mechanical Engineering & Materials Science 4-28-2016 Application

More information

39th AIAA Aerospace Sciences Meeting and Exhibit January 8 11, 2001/Reno, NV

39th AIAA Aerospace Sciences Meeting and Exhibit January 8 11, 2001/Reno, NV AIAA 1 717 Static Aero-elastic Computation with a Coupled CFD and CSD Method J. Cai, F. Liu Department of Mechanical and Aerospace Engineering University of California, Irvine, CA 92697-3975 H.M. Tsai,

More information

An Optimization Method Based On B-spline Shape Functions & the Knot Insertion Algorithm

An Optimization Method Based On B-spline Shape Functions & the Knot Insertion Algorithm An Optimization Method Based On B-spline Shape Functions & the Knot Insertion Algorithm P.A. Sherar, C.P. Thompson, B. Xu, B. Zhong Abstract A new method is presented to deal with shape optimization problems.

More information

NIA CFD Seminar, October 4, 2011 Hyperbolic Seminar, NASA Langley, October 17, 2011

NIA CFD Seminar, October 4, 2011 Hyperbolic Seminar, NASA Langley, October 17, 2011 NIA CFD Seminar, October 4, 2011 Hyperbolic Seminar, NASA Langley, October 17, 2011 First-Order Hyperbolic System Method If you have a CFD book for hyperbolic problems, you have a CFD book for all problems.

More information

PROGRESS IN NEWTON-KRYLOV METHODS FOR AERODYNAMIC CALCULATIONS. University of Toronto Institute for Aerospace Studies

PROGRESS IN NEWTON-KRYLOV METHODS FOR AERODYNAMIC CALCULATIONS. University of Toronto Institute for Aerospace Studies PROGRESS IN NEWTON-KRYLOV METHODS FOR AERODYNAMIC CALCULATIONS Alberto Pueyo David W. Zingg y University of Toronto Institute for Aerospace Studies 4925 Duerin Street, Downsview, Ontario M3H 5T6 Canada

More information

The Spalart Allmaras turbulence model

The Spalart Allmaras turbulence model The Spalart Allmaras turbulence model The main equation The Spallart Allmaras turbulence model is a one equation model designed especially for aerospace applications; it solves a modelled transport equation

More information

Development of a Consistent Discrete Adjoint Solver for the SU 2 Framework

Development of a Consistent Discrete Adjoint Solver for the SU 2 Framework Development of a Consistent Discrete Adjoint Solver for the SU 2 Framework Tim Albring, Max Sagebaum, Nicolas Gauger Chair for Scientific Computing TU Kaiserslautern 16th Euro-AD Workshop, Jena December

More information

A linear solver based on algebraic multigrid and defect correction for the solution of adjoint RANS equations

A linear solver based on algebraic multigrid and defect correction for the solution of adjoint RANS equations INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2014; 74:846 855 Published online 24 January 2014 in Wiley Online Library (wileyonlinelibrary.com)..3878 A linear solver

More information

Computational Fluid Dynamics for Engineers

Computational Fluid Dynamics for Engineers Tuncer Cebeci Jian P. Shao Fassi Kafyeke Eric Laurendeau Computational Fluid Dynamics for Engineers From Panel to Navier-Stokes Methods with Computer Programs With 152 Figures, 19 Tables, 84 Problems and

More information

Aerofoil Optimisation Using CST Parameterisation in SU2

Aerofoil Optimisation Using CST Parameterisation in SU2 Aerofoil Optimisation Using CST Parameterisation in SU2 Marques, S., & Hewitt, P. (2014). Aerofoil Optimisation Using CST Parameterisation in SU2. Paper presented at Royal Aeronautical Society Applied

More information

Case C1.3: Flow Over the NACA 0012 Airfoil: Subsonic Inviscid, Transonic Inviscid, and Subsonic Laminar Flows

Case C1.3: Flow Over the NACA 0012 Airfoil: Subsonic Inviscid, Transonic Inviscid, and Subsonic Laminar Flows Case C1.3: Flow Over the NACA 0012 Airfoil: Subsonic Inviscid, Transonic Inviscid, and Subsonic Laminar Flows Masayuki Yano and David L. Darmofal Aerospace Computational Design Laboratory, Massachusetts

More information

High-Order Navier-Stokes Simulations using a Sparse Line-Based Discontinuous Galerkin Method

High-Order Navier-Stokes Simulations using a Sparse Line-Based Discontinuous Galerkin Method High-Order Navier-Stokes Simulations using a Sparse Line-Based Discontinuous Galerkin Method Per-Olof Persson University of California, Berkeley, Berkeley, CA 9472-384, U.S.A. We study some of the properties

More information

PROTECTION AGAINST MODELING AND SIMULATION UNCERTAINTIES IN DESIGN OPTIMIZATION NSF GRANT DMI

PROTECTION AGAINST MODELING AND SIMULATION UNCERTAINTIES IN DESIGN OPTIMIZATION NSF GRANT DMI PROTECTION AGAINST MODELING AND SIMULATION UNCERTAINTIES IN DESIGN OPTIMIZATION NSF GRANT DMI-9979711 Bernard Grossman, William H. Mason, Layne T. Watson, Serhat Hosder, and Hongman Kim Virginia Polytechnic

More information

Analysis of the Adjoint Euler Equations as used for Gradient-based Aerodynamic Shape Optimization

Analysis of the Adjoint Euler Equations as used for Gradient-based Aerodynamic Shape Optimization Analysis of the Adjoint Euler Equations as used for Gradient-based Aerodynamic Shape Optimization Final Presentation Dylan Jude Graduate Research Assistant University of Maryland AMSC 663/664 May 4, 2017

More information

EFFICIENT SOLUTION ALGORITHMS FOR HIGH-ACCURACY CENTRAL DIFFERENCE CFD SCHEMES

EFFICIENT SOLUTION ALGORITHMS FOR HIGH-ACCURACY CENTRAL DIFFERENCE CFD SCHEMES EFFICIENT SOLUTION ALGORITHMS FOR HIGH-ACCURACY CENTRAL DIFFERENCE CFD SCHEMES B. Treidler, J.A. Ekaterineris and R.E. Childs Nielsen Engineering & Research, Inc. Mountain View, CA, 94043 Abstract Preliminary

More information

Optimization of Laminar Wings for Pro-Green Aircrafts

Optimization of Laminar Wings for Pro-Green Aircrafts Optimization of Laminar Wings for Pro-Green Aircrafts André Rafael Ferreira Matos Abstract This work falls within the scope of aerodynamic design of pro-green aircraft, where the use of wings with higher

More information

Geometry Parameterization Using Control Grids

Geometry Parameterization Using Control Grids Geometry Parameterization Using Control Grids A Technical Report by Kyle Anderson Chad Burdyshaw and Steve Karman UTC-CECS-SimCenter-2008-02 May 2008 GRADUATE SCHOOL OF COMPUTATIONAL ENGINEERING 7 0 1

More information

(c)2002 American Institute of Aeronautics & Astronautics or Published with Permission of Author(s) and/or Author(s)' Sponsoring Organization.

(c)2002 American Institute of Aeronautics & Astronautics or Published with Permission of Author(s) and/or Author(s)' Sponsoring Organization. VIIA Adaptive Aerodynamic Optimization of Regional Introduction The starting point of any detailed aircraft design is (c)2002 American Institute For example, some variations of the wing planform may become

More information

Introduction to ANSYS CFX

Introduction to ANSYS CFX Workshop 03 Fluid flow around the NACA0012 Airfoil 16.0 Release Introduction to ANSYS CFX 2015 ANSYS, Inc. March 13, 2015 1 Release 16.0 Workshop Description: The flow simulated is an external aerodynamics

More information

A Parallel Newton-Krylov-Schur Algorithm for the Reynolds-Averaged Navier-Stokes Equations. Michal Osusky

A Parallel Newton-Krylov-Schur Algorithm for the Reynolds-Averaged Navier-Stokes Equations. Michal Osusky A Parallel Newton-Krylov-Schur Algorithm for the Reynolds-Averaged Navier-Stokes Equations by Michal Osusky A thesis submitted in conformity with the requirements for the degree of Doctor of Philosophy

More information

Fuel consumption and emissions are two major issues when designing aircraft today. Rising fuel costs have

Fuel consumption and emissions are two major issues when designing aircraft today. Rising fuel costs have 9th AIAA Computational Fluid Dynamics - 5 June 9, San Antonio, Texas AIAA 9-3657 A High-Order Parallel Newton-Krylov flow solver for the Euler Equations Sydney C. Dias and David W. Zingg Institute for

More information

Aerodynamic Design Optimization of UAV Rotor Blades using a Genetic Algorithm

Aerodynamic Design Optimization of UAV Rotor Blades using a Genetic Algorithm Aerodynamic Design Optimization of UAV Rotor Blades using a Genetic Algorithm Hak-Min Lee 1), Nahm-Keon Hur 2) and *Oh-Joon Kwon 3) 1), 3) Department of Aerospace Engineering, KAIST, Daejeon 305-600, Korea

More information

Estimating Vertical Drag on Helicopter Fuselage during Hovering

Estimating Vertical Drag on Helicopter Fuselage during Hovering Estimating Vertical Drag on Helicopter Fuselage during Hovering A. A. Wahab * and M.Hafiz Ismail ** Aeronautical & Automotive Dept., Faculty of Mechanical Engineering, Universiti Teknologi Malaysia, 81310

More information

Algorithmic Developments in TAU

Algorithmic Developments in TAU Algorithmic Developments in TAU Ralf Heinrich, Richard Dwight, Markus Widhalm, and Axel Raichle DLR Institute of Aerodynamics and Flow Technology, Lilienthalplatz 7, 38108, Germany ralf.heinrich@dlr.de,

More information

Numerical Simulations of Fluid-Structure Interaction Problems using MpCCI

Numerical Simulations of Fluid-Structure Interaction Problems using MpCCI Numerical Simulations of Fluid-Structure Interaction Problems using MpCCI François Thirifay and Philippe Geuzaine CENAERO, Avenue Jean Mermoz 30, B-6041 Gosselies, Belgium Abstract. This paper reports

More information

A Two-Level Free-Form Deformation Approach for High-Fidelity Aerodynamic Shape Optimization

A Two-Level Free-Form Deformation Approach for High-Fidelity Aerodynamic Shape Optimization A Two-Level Free-Form Deformation Approach for High-Fidelity Aerodynamic Shape Optimization Hugo Gagnon and David W. Zingg Institute for Aerospace Studies, University of Toronto, 4925 Dufferin Street,

More information

Airfoil Design Optimization Using Reduced Order Models Based on Proper Orthogonal Decomposition

Airfoil Design Optimization Using Reduced Order Models Based on Proper Orthogonal Decomposition Airfoil Design Optimization Using Reduced Order Models Based on Proper Orthogonal Decomposition.5.5.5.5.5.5.5..5.95.9.85.8.75.7 Patrick A. LeGresley and Juan J. Alonso Dept. of Aeronautics & Astronautics

More information

Unstructured Mesh Solution Techniques using the NSU3D Solver

Unstructured Mesh Solution Techniques using the NSU3D Solver Unstructured Mesh Solution echniques using the NSU3D Solver Dimitri J. Mavriplis Karthik Mani Department of Mechanical Engineering, University of Wyoming, Laramie, WY 82071 NSU3D is an unstructured mesh

More information

Usage of CFX for Aeronautical Simulations

Usage of CFX for Aeronautical Simulations Usage of CFX for Aeronautical Simulations Florian Menter Development Manager Scientific Coordination ANSYS Germany GmbH Overview Elements of CFD Technology for aeronautical simulations: Grid generation

More information

Modeling External Compressible Flow

Modeling External Compressible Flow Tutorial 3. Modeling External Compressible Flow Introduction The purpose of this tutorial is to compute the turbulent flow past a transonic airfoil at a nonzero angle of attack. You will use the Spalart-Allmaras

More information

Digital-X. Towards Virtual Aircraft Design and Testing based on High-Fidelity Methods - Recent Developments at DLR -

Digital-X. Towards Virtual Aircraft Design and Testing based on High-Fidelity Methods - Recent Developments at DLR - Digital-X Towards Virtual Aircraft Design and Testing based on High-Fidelity Methods - Recent Developments at DLR - O. Brodersen, C.-C. Rossow, N. Kroll DLR Institute of Aerodynamics and Flow Technology

More information

The Development of a Navier-Stokes Flow Solver with Preconditioning Method on Unstructured Grids

The Development of a Navier-Stokes Flow Solver with Preconditioning Method on Unstructured Grids Proceedings of the International MultiConference of Engineers and Computer Scientists 213 Vol II, IMECS 213, March 13-15, 213, Hong Kong The Development of a Navier-Stokes Flow Solver with Preconditioning

More information

Multigrid Algorithms for Three-Dimensional RANS Calculations - The SUmb Solver

Multigrid Algorithms for Three-Dimensional RANS Calculations - The SUmb Solver Multigrid Algorithms for Three-Dimensional RANS Calculations - The SUmb Solver Juan J. Alonso Department of Aeronautics & Astronautics Stanford University CME342 Lecture 14 May 26, 2014 Outline Non-linear

More information

Abstract. Introduction

Abstract. Introduction EULER SOLUTIONS AS LIMIT OF INFINITE REYNOLDS NUMBER FOR SEPARATION FLOWS AND FLOWS WITH VORTICES Wolfgang Schmidt and Antony Jameson Dornier GmbH, D-7990 Friedrichshafen, FRG and Princeton University,

More information

Aerodynamic Inverse Design Framework using Discrete Adjoint Method

Aerodynamic Inverse Design Framework using Discrete Adjoint Method Aerodynamic Inverse Design Framework using Discrete Adjoint Method Joël Brezillon, Mohammad Abu-Zurayk DLR, Institute of Aerodynamics and Flow Technology Lilienthalplatz 7, D-38108 Braunschweig Joel.Brezillon@dlr.de,

More information

Computation of Sensitivity Derivatives of Navier-Stokes Equations using Complex Variables

Computation of Sensitivity Derivatives of Navier-Stokes Equations using Complex Variables Computation of Sensitivity Derivatives of Navier-Stokes Equations using Complex Variables By Veer N. Vatsa NASA Langley Research Center, Hampton, VA 23681 Mail Stop 128, email: v.n.vatsa@larc.nasa.gov

More information

Numerical and theoretical analysis of shock waves interaction and reflection

Numerical and theoretical analysis of shock waves interaction and reflection Fluid Structure Interaction and Moving Boundary Problems IV 299 Numerical and theoretical analysis of shock waves interaction and reflection K. Alhussan Space Research Institute, King Abdulaziz City for

More information

Ail implicit finite volume nodal point scheme for the solution of two-dimensional compressible Navier-Stokes equations

Ail implicit finite volume nodal point scheme for the solution of two-dimensional compressible Navier-Stokes equations Ail implicit finite volume nodal point scheme for the solution of two-dimensional compressible Navier-Stokes equations Vimala Dutta Computational and Theoretical Fluid Dynamics Division National Aerospace

More information

Discontinuous Galerkin Spectral Element Approximations for CFD

Discontinuous Galerkin Spectral Element Approximations for CFD Discontinuous Galerkin Spectral Element Approimations for CFD D.A. Kopriva Florida State Universit Tallahassee, FL 3236 G.B. Jacobs San Diego State Universit San Diego, CA 92182 September 3, 211 1 Code

More information

41st AIAA Aerospace Sciences Meeting and Exhibit Jan 6 9, 2003/Reno, Nevada

41st AIAA Aerospace Sciences Meeting and Exhibit Jan 6 9, 2003/Reno, Nevada AIAA 23 68 Aerodynamic Design of Cascades by Using an Adjoint Equation Method Shuchi Yang, Hsiao-Yuan Wu, and Feng Liu Department of Mechanical and Aerospace Engineering University of California, Irvine,

More information

A Higher-Order Accurate Unstructured Finite Volume Newton-Krylov Algorithm for Inviscid Compressible Flows

A Higher-Order Accurate Unstructured Finite Volume Newton-Krylov Algorithm for Inviscid Compressible Flows A Higher-Order Accurate Unstructured Finite Volume Newton-Krylov Algorithm for Inviscid Compressible Flows by AMIR NEJAT B.Sc. (Aerospace Engineering), AmirKabir University of Technology, 1996 M.Sc. (Aerospace

More information

A Scalable GPU-Based Compressible Fluid Flow Solver for Unstructured Grids

A Scalable GPU-Based Compressible Fluid Flow Solver for Unstructured Grids A Scalable GPU-Based Compressible Fluid Flow Solver for Unstructured Grids Patrice Castonguay and Antony Jameson Aerospace Computing Lab, Stanford University GTC Asia, Beijing, China December 15 th, 2011

More information

Optimization with Gradient and Hessian Information Calculated Using Hyper-Dual Numbers

Optimization with Gradient and Hessian Information Calculated Using Hyper-Dual Numbers Optimization with Gradient and Hessian Information Calculated Using Hyper-Dual Numbers Jeffrey A. Fike and Juan J. Alonso Department of Aeronautics and Astronautics, Stanford University, Stanford, CA 94305,

More information

AIRFOIL SHAPE OPTIMIZATION USING EVOLUTIONARY ALGORITHMS

AIRFOIL SHAPE OPTIMIZATION USING EVOLUTIONARY ALGORITHMS AIRFOIL SHAPE OPTIMIZATION USING EVOLUTIONARY ALGORITHMS Emre Alpman Graduate Research Assistant Aerospace Engineering Department Pennstate University University Park, PA, 6802 Abstract A new methodology

More information

High-fidelity Multidisciplinary Design Optimization for Next-generation Aircraft

High-fidelity Multidisciplinary Design Optimization for Next-generation Aircraft High-fidelity Multidisciplinary Design Optimization for Next-generation Aircraft Joaquim R. R. A. Martins with contributions from John T. Hwang, Gaetan K. W. Kenway, Graeme J. Kennedy, Zhoujie Lyu CFD

More information

Comparisons of Compressible and Incompressible Solvers: Flat Plate Boundary Layer and NACA airfoils

Comparisons of Compressible and Incompressible Solvers: Flat Plate Boundary Layer and NACA airfoils Comparisons of Compressible and Incompressible Solvers: Flat Plate Boundary Layer and NACA airfoils Moritz Kompenhans 1, Esteban Ferrer 2, Gonzalo Rubio, Eusebio Valero E.T.S.I.A. (School of Aeronautics)

More information

Validation of an Unstructured Overset Mesh Method for CFD Analysis of Store Separation D. Snyder presented by R. Fitzsimmons

Validation of an Unstructured Overset Mesh Method for CFD Analysis of Store Separation D. Snyder presented by R. Fitzsimmons Validation of an Unstructured Overset Mesh Method for CFD Analysis of Store Separation D. Snyder presented by R. Fitzsimmons Stores Separation Introduction Flight Test Expensive, high-risk, sometimes catastrophic

More information

Implicit/Multigrid Algorithms for Incompressible Turbulent Flows on Unstructured Grids

Implicit/Multigrid Algorithms for Incompressible Turbulent Flows on Unstructured Grids AIAA 95-1740 Implicit/Multigrid Algorithms for Incompressible Turbulent Flows on Unstructured Grids W. Kyle Anderson,* Russ D. Rausch, Daryl L. Bonhaus NASA Langley Research Center, Hampton, Virginia 23681

More information

Airfoil Shape Optimization Using Output-Based Adapted Meshes

Airfoil Shape Optimization Using Output-Based Adapted Meshes AIAA AVIATION Forum 5-9 June 2017, Denver, Colorado 23rd AIAA Computational Fluid Dynamics Conference AIAA 2017-3102 Airfoil Shape Optimization Using Output-Based Adapted Meshes Guodong Chen and Krzysztof

More information

Aerodynamic Design on Unstructured Grids for Turbulent Flows

Aerodynamic Design on Unstructured Grids for Turbulent Flows NASA Technical Memorandum 112867 Aerodynamic Design on Unstructured Grids for Turbulent Flows W. Kyle Anderson and Daryl L. Bonhaus Langley Research Center, Hampton, Virginia June 1997 National Aeronautics

More information

Application of STAR-CCM+ to Helicopter Rotors in Hover

Application of STAR-CCM+ to Helicopter Rotors in Hover Application of STAR-CCM+ to Helicopter Rotors in Hover Lakshmi N. Sankar and Chong Zhou School of Aerospace Engineering, Georgia Institute of Technology, Atlanta, GA Ritu Marpu Eschol CD-Adapco, Inc.,

More information

High-Lift Aerodynamics: STAR-CCM+ Applied to AIAA HiLiftWS1 D. Snyder

High-Lift Aerodynamics: STAR-CCM+ Applied to AIAA HiLiftWS1 D. Snyder High-Lift Aerodynamics: STAR-CCM+ Applied to AIAA HiLiftWS1 D. Snyder Aerospace Application Areas Aerodynamics Subsonic through Hypersonic Aeroacoustics Store release & weapons bay analysis High lift devices

More information

Sensitivity Analysis for the Compressible Navier-Stokes Equations Using a Discontinuous Galerkin Method

Sensitivity Analysis for the Compressible Navier-Stokes Equations Using a Discontinuous Galerkin Method 2th AIAA Computational Fluid Dynamics Conference 27-3 June 2, Honolulu, Hawaii AIAA 2-348 Sensitivity Analysis for the Compressible Navier-Stokes Equations Using a Discontinuous Galerkin Method Li Wang

More information

Accurate and Efficient Turbomachinery Simulation. Chad Custer, PhD Turbomachinery Technical Specialist

Accurate and Efficient Turbomachinery Simulation. Chad Custer, PhD Turbomachinery Technical Specialist Accurate and Efficient Turbomachinery Simulation Chad Custer, PhD Turbomachinery Technical Specialist Outline Turbomachinery simulation advantages Axial fan optimization Description of design objectives

More information

ADJOINT methods for sensitivity analysis involving partial

ADJOINT methods for sensitivity analysis involving partial AIAA JOURNAL Vol. 46, No. 4, April 2008 ADjoint: An Approach for the Rapid Development of Discrete Adjoint Solvers Charles A. Mader and Joaquim R. R. A. Martins University of Toronto, Toronto, Ontario

More information

Immersed Boundary Method and Chimera Method applied to Fluid-

Immersed Boundary Method and Chimera Method applied to Fluid- The numericsacademy Fixed Colloquium IBM on Moving Immersed IBM Boundary Applications Methods : Conclusion Current Status and Future Research Directions 15-17 June 2009, Academy Building, Amsterdam, the

More information

AERODYNAMIC DESIGN OF FLYING WING WITH EMPHASIS ON HIGH WING LOADING

AERODYNAMIC DESIGN OF FLYING WING WITH EMPHASIS ON HIGH WING LOADING AERODYNAMIC DESIGN OF FLYING WING WITH EMPHASIS ON HIGH WING LOADING M. Figat Warsaw University of Technology Keywords: Aerodynamic design, CFD Abstract This paper presents an aerodynamic design process

More information

SELECTIVE ALGEBRAIC MULTIGRID IN FOAM-EXTEND

SELECTIVE ALGEBRAIC MULTIGRID IN FOAM-EXTEND Student Submission for the 5 th OpenFOAM User Conference 2017, Wiesbaden - Germany: SELECTIVE ALGEBRAIC MULTIGRID IN FOAM-EXTEND TESSA UROIĆ Faculty of Mechanical Engineering and Naval Architecture, Ivana

More information

DESIGN OPTIMIZATION OF HIGH-LIFT CONFIGURATIONS USING A VISCOUS ADJOINT-BASED METHOD

DESIGN OPTIMIZATION OF HIGH-LIFT CONFIGURATIONS USING A VISCOUS ADJOINT-BASED METHOD DESIGN OPTIMIZATION OF HIGH-LIFT CONFIGURATIONS USING A VISCOUS ADJOINT-BASED METHOD a dissertation submitted to the department of aeronautics and astronautics and the committee on graduate studies of

More information

Aerodynamic Data Reconstruction and Inverse Design Using Proper Orthogonal Decomposition

Aerodynamic Data Reconstruction and Inverse Design Using Proper Orthogonal Decomposition AIAA JOURNAL Vol. 42, No. 8, August 2004 Aerodynamic Data Reconstruction and Inverse Design Using Proper Orthogonal Decomposition T. Bui-Thanh and M. Damodaran Nanyang Technological University, Singapore

More information

High-fidelity Structural Optimization of a Tow-Steered Composite Wing

High-fidelity Structural Optimization of a Tow-Steered Composite Wing 11 th World Congress on Structural and Multidisciplinary Optimization 7 th - 12 th, June 2015, Sydney Australia High-fidelity Structural Optimization of a Tow-Steered Composite Wing Timothy R. Brooks 1,

More information

Adjoint Solver Workshop

Adjoint Solver Workshop Adjoint Solver Workshop Why is an Adjoint Solver useful? Design and manufacture for better performance: e.g. airfoil, combustor, rotor blade, ducts, body shape, etc. by optimising a certain characteristic

More information

A High Order Discontinuous Galerkin Method for Fluid-Structure Interaction

A High Order Discontinuous Galerkin Method for Fluid-Structure Interaction A High Order Discontinuous Galerkin Method for Fluid-Structure Interaction Per-Olof Persson and Jaime Peraire Massachusetts Institute of Technology, Cambridge, MA 02139, U.S.A. Javier Bonet University

More information

RESPONSE SURFACE BASED OPTIMIZATION WITH A CARTESIAN CFD METHOD

RESPONSE SURFACE BASED OPTIMIZATION WITH A CARTESIAN CFD METHOD AIAA-23-465 RESPONSE SURFACE BASED OPTIMIZATION WITH A CARTESIAN CFD METHOD David L. Rodriguez * Stanford University Stanford, CA Abstract Cartesian-based CFD methods are quite powerful in preliminary

More information

Second Symposium on Hybrid RANS-LES Methods, 17/18 June 2007

Second Symposium on Hybrid RANS-LES Methods, 17/18 June 2007 1 Zonal-Detached Eddy Simulation of Transonic Buffet on a Civil Aircraft Type Configuration V.BRUNET and S.DECK Applied Aerodynamics Department The Buffet Phenomenon Aircraft in transonic conditions Self-sustained

More information

Estimation of Flow Field & Drag for Aerofoil Wing

Estimation of Flow Field & Drag for Aerofoil Wing Estimation of Flow Field & Drag for Aerofoil Wing Mahantesh. HM 1, Prof. Anand. SN 2 P.G. Student, Dept. of Mechanical Engineering, East Point College of Engineering, Bangalore, Karnataka, India 1 Associate

More information

Adjoint-Based Sensitivity Analysis for Computational Fluid Dynamics

Adjoint-Based Sensitivity Analysis for Computational Fluid Dynamics Adjoint-Based Sensitivity Analysis for Computational Fluid Dynamics Dimitri J. Mavriplis Max Castagne Professor Department of Mechanical Engineering University of Wyoming Laramie, WY USA Motivation Computational

More information

I. Introduction. Optimization Algorithm Components. Abstract for the 5 th OpenFOAM User Conference 2017, Wiesbaden - Germany

I. Introduction. Optimization Algorithm Components. Abstract for the 5 th OpenFOAM User Conference 2017, Wiesbaden - Germany An Aerodynamic Optimization Framework for the Automotive Industry, based on Continuous Adjoint and OpenFOAM E. Papoutsis-Kiachagias 1, V. Asouti 1, K. Giannakoglou 1, K. Gkagkas 2 1) National Technical

More information