MCG 4345 Aerodynamics Computational Assignment I. Report Presented to Dr. Stavros Tavoularis. Prepared By

Size: px
Start display at page:

Download "MCG 4345 Aerodynamics Computational Assignment I. Report Presented to Dr. Stavros Tavoularis. Prepared By"

Transcription

1 MCG 4345 Aerodynamics Computational Assignment I Report Presented to Dr. Stavros Tavoularis Prepared By University of Ottawa November 21 st 2014

2 Table of Contents Table of Contents... ii List of Figures... iii List of Tables... iii Introduction... 1 Airfoil Geometry... 2 Vortex Panel Method Calculations and Discussion... 4 Pressure Coefficient Distribution... 4 Non-Dimensional Velocity Distribution... 6 Lift Coefficient Calculation... 6 Pitching Moment Calculation... 8 Conclusion References APPENDIX A: MATLAB CODE ii

3 List of Figures Figure 1 - NACA 4418 geometry, camber line and maximum camber and thickness locations... 2 Figure 2 - Angle of Trailing Edge... 2 Figure 3 NACA 4418 Thickness Distribution... 3 Figure 4 NACA 4418 Geometry discretized into panels... 3 Figure 5 NACA 4418 Surface Pressure Coefficient Distribution Using Vortex Panel Method with N=100 Panels... 4 Figure 6 NACA 4418 Surface Non-Dimensional Velocity Distribution Using Vortex Panel Method with N=100 Panels... 6 Figure 6 NACA 4418 CL-alpha Curve Using Different Methodologies and Comparison with Experimental Data for Re = 3e Figure 6 NACA 4418 CM-alpha Curve Using Different Methodologies and Comparison with Experimental Data for Re = 3e List of Tables Table 1 Maximum Camber and Thickness for NACA 4418 airfoil... 2 Table 2 Leading Edge Radius of Curvature... 2 Table 1 Angle of Zero-Lift for NACA 4418 Airfoil Calculated Using Different Methods... 7 iii

4 Introduction Numerical methods are now essential in the aerospace industry. Simple methods such as the vortex panel method are even used in large companies like Bombardier Aerospace, as they offer a rapid and reliable alternative to more time-consuming Navier-Stokes solvers. This assignment shows us the basic application of the vortex panel method to a 2D, NACA airfoil. This assignment will concentrate on 4-digit NACA airfoils, more specifically the NACA Firstly, it is important to know that NACA airfoil geometries can be calculated using a simple polynomial function. For an arbitrary chordnormalized x position, the chord-normalized y-position can be found by equations 6.2 and 6.4 of the family of Wing Sections document [1]. The half-thickness for a given x-position is presented in equation 6.2, whereas the camber line position is presented in equation 6.4. Using these two equations, the y-position of the airfoil boundary is given by equation A. y top = y c + y t y bot = y c y t A The radius of curvature at the leading edge is determined by equation 6.3 of the family of Wing Sections document [1]. 1

5 z/c Airfoil Geometry Using the points provided in the NACA technical report [2], the geometry has been plotted and is shown in Figure x/c Maximum Camber NACA 4418 Airfoil Camber Line Maximum Thickness Figure 1 - NACA 4418 geometry, camber line and maximum camber and thickness locations Finding the maximum of equations 6.2 and 6.4 gives the maximum thickness and maximum camber line values. In the case of maximum thickness, it is twice the value given by equation 6.2. The x- position of the maximum camber line and thickness is simply the x-position corresponding to this maximum value in the equation. These values are presented in Table 1. Table 1 Maximum Camber and Thickness for NACA 4418 airfoil Parameter Chord-Normalized x-position Chord-Normalized Value Maximum Camber Maximum Thickness The chord-normalized radius of curvature of the leading edge is obtained using equation 6.3. It is presented in Table 2. Table 2 Leading Edge Radius of Curvature Radius of Curvature The angle of the trailing edge is obtained by calculating the angle between the trailing edge point on the airfoil and the second-last points on the top and bottom surfaces. It is shown in Figure 2. γ γ = 22.9 Figure 2 - Angle of Trailing Edge 2

6 z/c t/c The chord-normalized thickness distribution of the Airfoil, calculated using twice the value provided by equation 6.2 is plotted in Figure x/c Airfoil Thickness Figure 3 NACA 4418 Thickness Distribution The airfoil must now be discretized into panels. Figure 4 shows the NACA 4418 geometry with 100 panels shown with dashed lines. As we can see, using 100 panels approximates the airfoil geometry quite well x/c Airfoil Contour Panels Figure 4 NACA 4418 Geometry discretized into panels 3

7 Vortex Panel Method Calculations and Discussion Flow about the NACA 4418 airfoil was calculated using a vortex panel method potential flow solver. Results are shown in the following section. Calculations have been performed for angles of attack ranging from -10 to 20 degrees inclusively, in increments of 5 degrees. Pressure Coefficient Distribution The results for the pressure coefficient distribution are shown in Figure 5 and Figure 6. Figure 5 NACA 4418 Surface Pressure Coefficient Distribution for Angles of Attack of -5 to 20 Degrees Using Vortex Panel Method with N=100 Panels 4

8 Figure 6 NACA 4418 Surface Pressure Coefficient Distribution for Angles of Attack of -5 to 0 Degrees Using Vortex Panel Method with N=100 Panels The pressure coefficient distribution with respect to the angle of attack (AOA) is expected. As the AOA is increased, one would expect the stagnation point to move in the direction of the lower surface. As we can see in Figure 5, the stagnation point, represented by C p = 1, moves further down the lower surface of the airfoil as the AOA approaches 20. With an increase in AOA, it can also be seen that the point of maximum suction (also called suction point: represented by highest point on the curve) becomes larger with an increase in AOA. 5

9 Non-Dimensional Velocity Distribution The non-dimensional velocity coefficient is shown in Figure 7. Figure 7 NACA 4418 Surface Non-Dimensional Velocity Distribution for Angles of Attack of -5 to 20 Degrees Using Vortex Panel Method with N=100 Panels The vortex panel method results for non-dimensional velocity also concord with expectations. It can be observed that the highest point of the non-dimensional velocity is located at the same area on the wing surface as the suction point. Lift Coefficient Calculation The lift coefficient was calculated by numerically integrating the surface pressure, and circulation intensity over each panel. It has also been calculated using thin airfoil theory. Numerical methods were also used to calculate the lift coefficient using thin airfoil theory. The code used for the calculations of the lift coefficient using all three methods is presented in Appix A. The equations solved numerically for these three methods are equations B, C and D for pressure coefficient, circulation and thin airfoil methods respectively. 6

10 C L = 2π(α α 0 ), TE C L = C p dx LE TE C L = Γds LE 0 π α 0 = dz (1 cosθ)dθ dx The angle of zero lift for numerical and experimental results have been obtained using linear interpolation to find a zero lift coefficient within the data calculated or provided. The angles of zero lift predicted by each method are shown in Table 3. (B) (C) (D) Table 3 Angle of Zero-Lift for NACA 4418 Airfoil Calculated Using Different Methods Method Angle of Zero-Lift Error [ ] [%] Vortex Panel Method (C p distribution) Vortex Panel Method (Circulation distribution) Thin Airfoil Theory Experimental (Re = 10 6 ) The results obtained numerically for the angle of zero-lift are in excellent accordance with the experimental value, with a maximum error of only 3.3%. To verify the validity of these methods for angles of attack near the angle of zero-lift, we must refer to the results for the lift coefficient for these different methods, shown in Figure 8. As it can be observed, the values of lift coefficient can be assumed valid for angles of attack approaching the angle of zero-lift 7

11 Figure 8 NACA 4418 CL-alpha Curve Using Different Methodologies and Comparison with Experimental Data for Re = 3e6 The results shown in Figure 8 show that the initial slope and order of magnitude coincide quite well for low angles of attack. However, as the angle of attack increases and goes further away from the angle of zero-lift, the results for the numerical methods used become invalid. The vortex panel method and thin airfoil theory are incapable of predicting the stall angle obtained experimentally, as they can only predict linear increases in Lift with respect to the angle of attack. This is why these methods are valid for only small angles of attack. When comparing the three theoretical methods used to compute the lift coefficient, it can be observed that they are in accordance. Since these three methods consider the flow to be inviscid, it is expected that they cannot perfectly match the experimental curve or predict the stall angle. Pitching Moment Calculation The pitching moment about the leading edge has been calculated using the vortex panel method pressure distribution along the surface of the airfoil as well as thin airfoil theory. Equations E and F are used to compute this coefficient for the vortex panel and thin airfoil methods respectively. TE C M = C p x dx LE (E) C M = π 2 (A 0 + A 1 A 2 2 ) (F) 8

12 A 0 = α 1 π π dz dx dθ 0 A n = 2 π dz dx cos(nθ)dθ 0 π The results obtained for the pitching moment about the leading edge are shown in Figure 9 and compared to experimental results for Re = 3e6. Figure 9 NACA 4418 CM-alpha Curve Using Different Methodologies and Comparison with Experimental Data for Re = 3e6 The pitching moment predictions using thin airfoil theory and the vortex panel method are very far off from the experimental values for Re = Even though these methods are in accordance with each other, and predict values in the same order of magnitude as experimental results, the variation of pitching moment is very far from experimental results. Once again, the fact that these methods do not consider viscous effects can relate the different values obtain numerically and experimentally. 9

13 Conclusion In summary, this work has helped to understand the validity of thin airfoil theory and vortex panel methods when it comes to computing the lift coefficient, pitching moment coefficient about the leading edge, and angle of zero-lift. These methods are quite valid to solve for the lift at angles of attack approaching the angle of zero-lift, but fail to predict the stall angle as they can only approximate the lift to vary linearly with the angle of attack. For the pitching moment, the predictions had the same order of magnitude and increasing slope with respect to the angle of attack, but failed to efficiently predict the values. To predict the lift and pitching moment at higher angles of attack, other methods, such as Navier-Stokes solver using finite element methods should be used, as they can adequately simulate the effects of skin and pressure drag. 10

14 References 1. IRA H. ABBOTT, ALBERT E. VON DOENHOFF, Theory of Wing Sections, DOVER PUBLICATIONS, INC., NEW YORK, IRA H. ABBOTT, ALBERT E. VON DOENHOFF, NATIONAL ADVISORY COMITEE FOR AERONATICS, REPORT #824, Langley Field 11

15 APPENDIX A: MATLAB CODE The following appix show the MATLAB code used to compute and plot the lift coefficient for each of the methods. % computational assignment 1 clear all close all %% Thin Airfoil Theory % Using the equation for the camber line for a NACA 4412 Airfoil n = 10000; m = 0.04; % For NACA 4418 p = 0.4; % For NACA 4418 x = linspace(0,1,n); z = zeros(1,n); thetamid = zeros(1,n-1); for i = 1:n if x(i) < p z(i) = m/p^2*(2*p*x(i) - x(i)^2); else z(i) = m/(1-p)^2*(1-2*p + 2*p*x(i) - x(i)^2); % Find value of theta for change in camber line equation for i = 1:n-1 thetamid(i) = acos(1-(2*(mean([x(i) x(i+1)])))); dzdx = diff(z)./diff(x); func = dzdx.*(1-cos(thetamid)); % Angle of zero lift alpha0 = 1/pi*trapz(thetamid,func); % Pitching Moment j = 1; for aoa = -10:5:20 A0(j) = aoa*pi/180-1/pi*trapz(thetamid,dzdx); A1(j) = 2/pi * trapz(thetamid,dzdx.*cos(thetamid)); A2(j) = 2/pi * trapz(thetamid,dzdx.*cos(2*thetamid)); j = j + 1; CMta = 0.5*pi*(A0 + A1 - A2/2); clearvars thetamid theta z x func %% Experimental CL-alpha & CM-alpha curve for Re = 3*10^6 expdat = load('naca4418_cl_alpha.txt'); CMexpdat = load('naca4418_cm_alpha.txt'); alphaexp = expdat(:,1); CLexp = expdat(:,2); CMalphaexp = CMexpdat(:,1); CMexp = CMexpdat(:,2); j = 1; %% Compute data from program for aoa = -10:5:20 alpha(j) = aoa; filename = sprintf('aoa%i.csv',aoa); data = csvread(filename); xp = data(:,2); yp = data(:,3); 12

16 xc = data(1:-1,4); yc = data(1:-1,5); t = data(1:-1,6); L = data(1:-1,7); g = data(:,8); cv = data(1:-1,9); cp = data(1:-1,10); cl = data(,10); clearvars data CP(:,j) = cp; CV(:,j) = cv; % Number of control points N = numel(xp); % Get top and bottom Cp and V distribution k = 0; l = 0; for i = 1:N-1 if yc(i) >= 0 k = k + 1; xu(k,j) = xc(i); cpu(k,j) = cp(i); cvu(k,j) = cv(i); else l = l + 1; xl(l,j) = xc(i); cpl(l,j) = cp(i); cvl(l,j) = cv(i); xl = fliplr(xl); cpl = fliplr(cpl); %% Get lift coefficient from Cp distribution CLcp(j) = sum(-cp.*l.*cos(t-aoa*pi/180)); %% Get Pitching Moment Coefficient from Cp distribution CM(j) = -trapz(xc,cp.*xc); % Get lift coefficient from gamma distribtution % First, we must find the average circulation on each panel gamma = g(1:-1) + diff(g)/2; GAMMA = sum(l.*gamma); CLg(j) = 4*pi*GAMMA; %% Lift Coefficient calculated by program CL(j) = cl; %% Thin airfoil theory lift CLta(j) = 2*pi*(alpha(j)*pi/180-alpha0); j = j+1; figure hold on plot(alpha,clcp,'kx','markersize',10) plot(alpha,clta,'kd','markersize',10) plot(alpha,clg,'ko','markersize',10) plot(alphaexp,clexp,'k--','linewidth',1) title('cl-alpha curve for NACA 4418 Airfoil Using Different Methods'); leg('cp','circulation','thin Airfoil','Re 3*10^6') xlabel('alpha'); 13

17 ylabel('cl'); figure hold on plot(alpha,cm,'kx','markersize',10) plot(alpha,cmta,'ko','markersize',10) plot(cmalphaexp,cmexp,'k--','linewidth',1) title('cm-alpha curve for NACA 4418 Airfoil Using Vortex Panel Method'); leg('cp','thin Airfoil','Re 3*10^6') xlabel('alpha'); ylabel('cm'); alpha0cp = interp1(clcp,alpha,0); alpha0g = interp1(clg,alpha,0); alpha0ta = alpha0*180/pi; fprintf('\nusing thin airfoil theory, alpha0 is %.2f',alpha0ta); fprintf('\nusing pressure distribution, alpha0 is %.2f',alpha0cp); fprintf('\nusing circulation, alpha0 is %.2f\n',alpha0g); figure hold on color{1} = 'k-';color{2} = 'b-';color{3} = 'g-';color{4} = 'r-'; color{5} = 'k--';color{6} = 'b--';color{7} = 'g--'; for i = 1:j-1 plot(xc,cv(:,i),color{i}); leg{i} = cat(2,'aoa ',num2str(alpha(i))); leg(leg) title('non-dimensional Velocity on Surface of NACA 4418 Airfoil'); xlabel('x/c'); ylabel('cv'); figure hold on for i = 1:j-1 plot(xc,-cp(:,i),color{i}); leg(leg) title('pressure Coefficient on Surface of NACA 4418 Airfoil'); xlabel('x/c'); ylabel('-cp'); 14

Subsonic Airfoils. W.H. Mason Configuration Aerodynamics Class

Subsonic Airfoils. W.H. Mason Configuration Aerodynamics Class Subsonic Airfoils W.H. Mason Configuration Aerodynamics Class Typical Subsonic Methods: Panel Methods For subsonic inviscid flow, the flowfield can be found by solving an integral equation for the potential

More information

Subsonic Airfoils. W.H. Mason Configuration Aerodynamics Class

Subsonic Airfoils. W.H. Mason Configuration Aerodynamics Class Subsonic Airfoils W.H. Mason Configuration Aerodynamics Class Most people don t realize that mankind can be divided into two great classes: those who take airfoil selection seriously, and those who don

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

Determination of Angle of Attack (AOA) for Rotating Blades

Determination of Angle of Attack (AOA) for Rotating Blades Downloaded from orbit.dtu.dk on: Sep 1, 218 Determination of Angle of Attack (AOA) for Rotating Blades Shen, Wen Zhong; Hansen, Martin Otto Laver; Sørensen, Jens Nørkær Published in: Wind Energy Publication

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

THE EFFECT OF REPLACING THE JOUKOWSKI MAP WITH THE GENERALIZED KARMAN-TREFFTZ MAP IN THE METHOD OF ZEDAN

THE EFFECT OF REPLACING THE JOUKOWSKI MAP WITH THE GENERALIZED KARMAN-TREFFTZ MAP IN THE METHOD OF ZEDAN GSJ: VOLUME 6, ISSUE 2, FEBRUARY 2018 1 GSJ: Volume 6, Issue 2, February 2018, Online: ISSN 2320-9186 THE EFFECT OF REPLACING THE JOUKOWSKI MAP WITH THE GENERALIZED KARMAN-TREFFTZ MAP IN THE METHOD OF

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

Analysis of an airfoil

Analysis of an airfoil UNDERGRADUATE RESEARCH FALL 2010 Analysis of an airfoil using Computational Fluid Dynamics Tanveer Chandok 12/17/2010 Independent research thesis at the Georgia Institute of Technology under the supervision

More information

Aerodynamic Design of a Tailless Aeroplan J. Friedl

Aerodynamic Design of a Tailless Aeroplan J. Friedl Acta Polytechnica Vol. 4 No. 4 5/2 Aerodynamic Design of a Tailless Aeroplan J. Friedl The paper presents an aerodynamic analysis of a one-seat ultralight (UL) tailless aeroplane named L2k, with a very

More information

Physics of an Flow Over a Wing

Physics of an Flow Over a Wing Wings in Ideal Flow Physics of an Flow Over a Wing Werle, 1974, NACA 0012, 12.5 o, AR=4, Re=10000 Bippes, Clark Y, Rectangular Wing 9 o, AR=2.4, Re=100000 Head, 1982, Rectangular Wing, 24 o, Re=100000

More information

How to Enter and Analyze a Wing

How to Enter and Analyze a Wing How to Enter and Analyze a Wing Entering the Wing The Stallion 3-D built-in geometry creation tool can be used to model wings and bodies of revolution. In this example, a simple rectangular wing is modeled

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

DETERMINATION OF FLIGHT STABILITY COEFFICIENTS USING A FINITE ELEMENT CFD

DETERMINATION OF FLIGHT STABILITY COEFFICIENTS USING A FINITE ELEMENT CFD DETERMINATION OF FLIGHT STABILITY OEFFIIENTS USING A FINITE ELEMENT FD harles R. O Neill Mechanical and Aerospace Engineering Oklahoma State University Stillwater, OK 7477 Abstract A 3D finite element

More information

Profile Catalogue for Airfoil Sections Based on 3D Computations

Profile Catalogue for Airfoil Sections Based on 3D Computations Risø-R-58(EN) Profile Catalogue for Airfoil Sections Based on 3D Computations Franck Bertagnolio, Niels N. Sørensen and Jeppe Johansen Risø National Laboratory Roskilde Denmark December 26 Author: Franck

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 simple method for potential flow simulation of cascades

A simple method for potential flow simulation of cascades Sādhanā Vol. 35, Part 6, December 2010, pp. 649 657. Indian Academy of Sciences A simple method for potential flow simulation of cascades ARAVIND BHIMARASETTY and RAGHURAMAN N GOVARDHAN Department of Mechanical

More information

Post Stall Behavior of a Lifting Line Algorithm

Post Stall Behavior of a Lifting Line Algorithm Post Stall Behavior of a Lifting Line Algorithm Douglas Hunsaker Brigham Young University Abstract A modified lifting line algorithm is considered as a low-cost approach for calculating lift characteristics

More information

Grid Dependence Study of Transonic/Supersonic Flow Past NACA Air-foil using CFD Hemanth Kotaru, B.Tech (Civil Engineering)

Grid Dependence Study of Transonic/Supersonic Flow Past NACA Air-foil using CFD Hemanth Kotaru, B.Tech (Civil Engineering) Grid Dependence Study of Transonic/Supersonic Flow Past NACA Air-foil using CFD Hemanth Kotaru, B.Tech (Civil Engineering) Abstract Computational fluid dynamics is a relatively young field in engineering.

More information

SPC 307 Aerodynamics. Lecture 1. February 10, 2018

SPC 307 Aerodynamics. Lecture 1. February 10, 2018 SPC 307 Aerodynamics Lecture 1 February 10, 2018 Sep. 18, 2016 1 Course Materials drahmednagib.com 2 COURSE OUTLINE Introduction to Aerodynamics Review on the Fundamentals of Fluid Mechanics Euler and

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

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

Introduction to CFX. Workshop 2. Transonic Flow Over a NACA 0012 Airfoil. WS2-1. ANSYS, Inc. Proprietary 2009 ANSYS, Inc. All rights reserved.

Introduction to CFX. Workshop 2. Transonic Flow Over a NACA 0012 Airfoil. WS2-1. ANSYS, Inc. Proprietary 2009 ANSYS, Inc. All rights reserved. Workshop 2 Transonic Flow Over a NACA 0012 Airfoil. Introduction to CFX WS2-1 Goals The purpose of this tutorial is to introduce the user to modelling flow in high speed external aerodynamic applications.

More information

Daedalus - A Software Package for the Design and Analysis of Airfoils

Daedalus - A Software Package for the Design and Analysis of Airfoils First South-East European Conference on Computational Mechanics, SEECCM-06, (M. Kojic, M. Papadrakakis (Eds.)) June 28-30, 2006, Kragujevac, Serbia and Montenegro University of Kragujevac Daedalus - A

More information

INTERACTIVE AERODYNAMICS ANALYSIS AND DESIGN PROGRAMS FOR USE IN THE UNDERGRADUATE ENGINEERING CURRICULUM

INTERACTIVE AERODYNAMICS ANALYSIS AND DESIGN PROGRAMS FOR USE IN THE UNDERGRADUATE ENGINEERING CURRICULUM INTERACTIVE AERODYNAMICS ANALYSIS AND DESIGN PROGRAMS FOR USE IN THE UNDERGRADUATE ENGINEERING CURRICULUM Ralph Latham, Kurt Gramoll and L. N. Sankar School of Aerospace Engineering Georgia Institute of

More information

Modelling the Unsteady Loads of Plunging Airfoils in Attached, Light and Deep Stall Conditions

Modelling the Unsteady Loads of Plunging Airfoils in Attached, Light and Deep Stall Conditions Modelling the Unsteady Loads of Plunging Airfoils in Attached, Light and Deep Stall Conditions N. Chiereghin, D.J.Cleaver, I. Gursul, S.Bull DiPart 2017 Partnership with Contents Introduction Aims and

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

Multi-point Optimization of Airfoils

Multi-point Optimization of Airfoils GEORGIA INSTITUTE OF TECHNOLOGY Multi-point Optimization of Airfoils Undergraduate Research Thesis Bhanu Chiguluri Research Advisor: Dr. Lakshmi Sankar Daniel Guggenheim School of Aerospace Engineering

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

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

Research Article A Computational Investigation of Unsteady Aerodynamics of Insect-Inspired Fixed Wing Micro Aerial Vehicle s 2D Airfoil

Research Article A Computational Investigation of Unsteady Aerodynamics of Insect-Inspired Fixed Wing Micro Aerial Vehicle s 2D Airfoil Advances in Aerospace Engineering, Article ID 5449, 7 pages http://dx.doi.org/1.1155/214/5449 Research Article A Computational Investigation of Unsteady Aerodynamics of Insect-Inspired Fixed Wing Micro

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

report typos and errors to W.H. Mason Appendix E: Utility Programs E-5

report typos and errors to W.H. Mason Appendix E: Utility Programs E-5 report typos and errors to W.H. Mason Appendix E: Utility Programs E-5 E.2 LADSON This is the NASA program that provides a reasonable approximation to the NACA 6 and 6A series airfoils. It was written

More information

Computational Fluid Dynamics Analysis of an Idealized Modern Wingsuit

Computational Fluid Dynamics Analysis of an Idealized Modern Wingsuit Washington University in St. Louis Washington University Open Scholarship Mechanical Engineering and Materials Science Independent Study Mechanical Engineering & Materials Science 12-21-2016 Computational

More information

Introduction to Aerodynamic Shape Optimization

Introduction to Aerodynamic Shape Optimization Introduction to Aerodynamic Shape Optimization 1. Aircraft Process 2. Aircraft Methods a. Inverse Surface Methods b. Inverse Field Methods c. Numerical Optimization Methods Aircraft Process Conceptual

More information

Geometric Analysis of Wing Sections

Geometric Analysis of Wing Sections NASA Technical Memorandum 110346 Geometric Analysis of Wing Sections I-Chung Chang, Francisco J. Torres, and Chee Tung April 1995 National Aeronautics and Space Administration Ames Research Center Moffett

More information

Keywords: CFD, aerofoil, URANS modeling, flapping, reciprocating movement

Keywords: CFD, aerofoil, URANS modeling, flapping, reciprocating movement L.I. Garipova *, A.N. Kusyumov *, G. Barakos ** * Kazan National Research Technical University n.a. A.N.Tupolev, ** School of Engineering - The University of Liverpool Keywords: CFD, aerofoil, URANS modeling,

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

Study of Swept Angle Effects on Grid Fins Aerodynamics Performance

Study of Swept Angle Effects on Grid Fins Aerodynamics Performance Journal of Physics: Conference Series PAPER OPEN ACCESS Study of Swept Angle Effects on Grid Fins Aerodynamics Performance To cite this article: G A Faza et al 2018 J. Phys.: Conf. Ser. 1005 012013 View

More information

SUPERSONIC INVERSE DESIGN METHOD FOR WING-FUSELAGE DESIGN

SUPERSONIC INVERSE DESIGN METHOD FOR WING-FUSELAGE DESIGN SUPERSONIC INVERSE METHOD FOR WING-FUSELAGE Shinkyu Jeong, Shigeru Obayashi and Kazuhiro Nakahashi Tohoku University, 98-77, Sendai, Japan Toshiyuki Iwamiya National Aerospace Laboratory, Chofu, Tokyo

More information

AeroPy Documentation. Release Pedro Leal

AeroPy Documentation. Release Pedro Leal AeroPy Documentation Release 0.0.3 Pedro Leal Nov 09, 2018 Contents 1 Aerodynamic tools 3 2 Geometric tools 5 2.1 Xfoil Module Documentation...................................... 5 2.2 Aerodynamic Module

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

Express Introductory Training in ANSYS Fluent Workshop 04 Fluid Flow Around the NACA0012 Airfoil

Express Introductory Training in ANSYS Fluent Workshop 04 Fluid Flow Around the NACA0012 Airfoil Express Introductory Training in ANSYS Fluent Workshop 04 Fluid Flow Around the NACA0012 Airfoil Dimitrios Sofialidis Technical Manager, SimTec Ltd. Mechanical Engineer, PhD PRACE Autumn School 2013 -

More information

Why Airplanes Can t Fly

Why Airplanes Can t Fly body Z z body Y y body X x b dz dy dx k j i F U S V ds V s n d.. Why Airplanes an t Fly Physics of an Flow Over a Wing Werle, 974, NAA 00,.5 o, AR=4, Re=0000 Wake descends roughly on an extension of the

More information

Computational Study of Unsteady Flows around Dragonfly and Smooth Airfoils at Low Reynolds Numbers

Computational Study of Unsteady Flows around Dragonfly and Smooth Airfoils at Low Reynolds Numbers 46th AIAA Aerospace Sciences Meeting and Exhibit 7 - January 8, Reno, Nevada AIAA 8-85 Computational Study of Unsteady Flows around Dragonfly and Smooth Airfoils at Low Reynolds Numbers H. Gao, Hui Hu,

More information

AERODYNAMIC DESIGN FOR WING-BODY BLENDED AND INLET

AERODYNAMIC DESIGN FOR WING-BODY BLENDED AND INLET 25 TH INTERNATIONAL CONGRESS OF THE AERONAUTICAL SCIENCES AERODYNAMIC DESIGN FOR WING-BODY BLENDED AND INLET Qingzhen YANG*,Yong ZHENG* & Thomas Streit** *Northwestern Polytechincal University, 772,Xi

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

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

MATH 573 Advanced Scientific Computing

MATH 573 Advanced Scientific Computing MATH 573 Advanced Scientific Computing Analysis of an Airfoil using Cubic Splines Ashley Wood Brian Song Ravindra Asitha What is Airfoil? - The cross-section of the wing, blade, or sail. 1. Thrust 2. Weight

More information

AIRFOIL PROFILE DESIGN BY REVERSE ENGINEERING BEZIER CURVE

AIRFOIL PROFILE DESIGN BY REVERSE ENGINEERING BEZIER CURVE Int. J. Mech. Eng. & Rob. Res. 2012 Rama Krishna N Parasaram and T N Charyulu, 2012 Research Paper ISSN 2278 0149 www.ijmerr.com Vol. 1, No. 3, October 2012 2012 IJMERR. All Rights Reserved AIRFOIL PROFILE

More information

AIR LOAD CALCULATION FOR ISTANBUL TECHNICAL UNIVERSITY (ITU), LIGHT COMMERCIAL HELICOPTER (LCH) DESIGN ABSTRACT

AIR LOAD CALCULATION FOR ISTANBUL TECHNICAL UNIVERSITY (ITU), LIGHT COMMERCIAL HELICOPTER (LCH) DESIGN ABSTRACT AIR LOAD CALCULATION FOR ISTANBUL TECHNICAL UNIVERSITY (ITU), LIGHT COMMERCIAL HELICOPTER (LCH) DESIGN Adeel Khalid *, Daniel P. Schrage + School of Aerospace Engineering, Georgia Institute of Technology

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

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

Design and Computational Fluid Dynamics Analysis of an Idealized Modern Wingsuit

Design and Computational Fluid Dynamics Analysis of an Idealized Modern Wingsuit Design and Computational Fluid Dynamics Analysis of an Idealized Modern Wingsuit Maria E. Ferguson Washington University in St. Louis Advisor: Dr. Ramesh K. Agarwal Abstract The modern wingsuit has been

More information

Minimum Pressure Envelope Cavitation Analysis Using Two-Dimensional Panel Method

Minimum Pressure Envelope Cavitation Analysis Using Two-Dimensional Panel Method Minimum Pressure Envelope Cavitation Analysis Using Two-Dimensional Panel Method by Christopher J. Peterson B.S. Mechanical Engineering University of Illinois (1998) Master of Engineering Management Old

More information

A Systematic Study on the Impact of Dimensionality for a Two-Dimensional Aerodynamic Optimization Model Problem

A Systematic Study on the Impact of Dimensionality for a Two-Dimensional Aerodynamic Optimization Model Problem 29th AIAA Applied Aerodynamics Conference 27-30 June 2011, Honolulu, Hawaii AIAA 2011-3176 A Systematic Study on the Impact of Dimensionality for a Two-Dimensional Aerodynamic Optimization Model Problem

More information

Progress and Future Prospect of CFD in Aerospace

Progress and Future Prospect of CFD in Aerospace Progress and Future Prospect of CFD in Aerospace - Observation from 30 years research - Kozo Fujii Institute of Space and Astronautical Science (ISAS) Japan Aerospace Exploration Agency (JAXA) Japan JAXA:

More information

Modeling the Fluid Flow around Airfoils Using. Conformal Mapping

Modeling the Fluid Flow around Airfoils Using. Conformal Mapping Modeling the Fluid Flow around Airfoils Using Conformal Mapping Nitin R. Kapania, Katherine Terracciano, Shannon Taylor August 29, 2008 Abstract The modeling of fluid interactions around airfoils is difficult

More information

Transition Flow and Aeroacoustic Analysis of NACA0018 Satish Kumar B, Fred Mendonç a, Ghuiyeon Kim, Hogeon Kim

Transition Flow and Aeroacoustic Analysis of NACA0018 Satish Kumar B, Fred Mendonç a, Ghuiyeon Kim, Hogeon Kim Transition Flow and Aeroacoustic Analysis of NACA0018 Satish Kumar B, Fred Mendonç a, Ghuiyeon Kim, Hogeon Kim Transition Flow and Aeroacoustic Analysis of NACA0018 Satish Kumar B, Fred Mendonç a, Ghuiyeon

More information

Computational Analysis of a Wing Oscillator

Computational Analysis of a Wing Oscillator Western Michigan University ScholarWorks at WMU Master's Theses Graduate College 8-2012 Computational Analysis of a Wing Oscillator Ryne Derrick Radermacher Western Michigan University, rhyno466@gmail.com

More information

Theoretical and Computational Modeling of Dynamic Stall for Rotorcraft Applications

Theoretical and Computational Modeling of Dynamic Stall for Rotorcraft Applications Theoretical and Computational Modeling of Dynamic Stall for Rotorcraft Applications Ashok Gopalarathnam and Jack Edwards Department of Mechanical and Aerospace Engineering North Carolina State University

More information

CONFORMAL MAPPING POTENTIAL FLOW AROUND A WINGSECTION USED AS A TEST CASE FOR THE INVISCID PART OF RANS SOLVERS

CONFORMAL MAPPING POTENTIAL FLOW AROUND A WINGSECTION USED AS A TEST CASE FOR THE INVISCID PART OF RANS SOLVERS European Conference on Computational Fluid Dynamics ECCOMAS CFD 2006 P. Wesseling, E. Oñate and J. Périaux (Eds) c TU Delft, The Netherlands, 2006 CONFORMAL MAPPING POTENTIAL FLOW AROUND A WINGSECTION

More information

ABSTRACT. HOSANGADI, PRANAV. Improved Stall Prediction for Swept Wings Using Low-Order Aerodynamics. (Under the direction of Dr. Ashok Gopalarathnam.

ABSTRACT. HOSANGADI, PRANAV. Improved Stall Prediction for Swept Wings Using Low-Order Aerodynamics. (Under the direction of Dr. Ashok Gopalarathnam. ABSTRACT HOSANGADI, PRANAV. Improved Stall Prediction for Swept Wings Using Low-Order Aerodynamics. (Under the direction of Dr. Ashok Gopalarathnam.) Low-order aerodynamic prediction methods are well-established

More information

ANSYS FLUENT. Airfoil Analysis and Tutorial

ANSYS FLUENT. Airfoil Analysis and Tutorial ANSYS FLUENT Airfoil Analysis and Tutorial ENGR083: Fluid Mechanics II Terry Yu 5/11/2017 Abstract The NACA 0012 airfoil was one of the earliest airfoils created. Its mathematically simple shape and age

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

CFD Analysis of conceptual Aircraft body

CFD Analysis of conceptual Aircraft body CFD Analysis of conceptual Aircraft body Manikantissar 1, Dr.Ankur geete 2 1 M. Tech scholar in Mechanical Engineering, SD Bansal college of technology, Indore, M.P, India 2 Associate professor in Mechanical

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

Comparison of Results from Turbulence Models for the Nomad Flaperon-Configured Aerofoil

Comparison of Results from Turbulence Models for the Nomad Flaperon-Configured Aerofoil Comparison of Results from Turbulence Models for the Nomad Flaperon-Configured Aerofoil D. Norrison E. Ly March 2007 Abstract Incidents involving low-speed flutter of the wing-flaperon configured Government

More information

Influence of Shape Parameterization on Aerodynamic Shape Optimization

Influence of Shape Parameterization on Aerodynamic Shape Optimization Influence of Shape Parameterization on Aerodynamic Shape Optimization John C. Vassberg Boeing Technical Fellow Advanced Concepts Design Center Boeing Commercial Airplanes Long Beach, CA 90846, USA Antony

More information

Grid. Apr 09, 1998 FLUENT 5.0 (2d, segregated, lam) Grid. Jul 31, 1998 FLUENT 5.0 (2d, segregated, lam)

Grid. Apr 09, 1998 FLUENT 5.0 (2d, segregated, lam) Grid. Jul 31, 1998 FLUENT 5.0 (2d, segregated, lam) Tutorial 2. Around an Airfoil Transonic Turbulent Flow Introduction: The purpose of this tutorial is to compute the turbulent flow past a transonic airfoil at a non-zero angle of attack. You will use the

More information

AIAA A Computational Study of Subsonic Flows over A Medium Range Cargo Aircraft

AIAA A Computational Study of Subsonic Flows over A Medium Range Cargo Aircraft S AIAA 23-366 A Computational Study of Subsonic Flows over A Medium Range Cargo Aircraft 2st Applied Aerodynamic Conference 23-26 June 23 Orlando, Florida For permission to copy or to republish, contact

More information

A higher-order finite volume method with collocated grid arrangement for incompressible flows

A higher-order finite volume method with collocated grid arrangement for incompressible flows Computational Methods and Experimental Measurements XVII 109 A higher-order finite volume method with collocated grid arrangement for incompressible flows L. Ramirez 1, X. Nogueira 1, S. Khelladi 2, J.

More information

Computation of Velocity, Pressure and Temperature Distributions near a Stagnation Point in Planar Laminar Viscous Incompressible Flow

Computation of Velocity, Pressure and Temperature Distributions near a Stagnation Point in Planar Laminar Viscous Incompressible Flow Excerpt from the Proceedings of the COMSOL Conference 8 Boston Computation of Velocity, Pressure and Temperature Distributions near a Stagnation Point in Planar Laminar Viscous Incompressible Flow E. Kaufman

More information

Enhancement of wind turbine aerodynamic performance by a numerical optimization technique

Enhancement of wind turbine aerodynamic performance by a numerical optimization technique Journal of Mechanical Science and Technology 26 (2) (202) 455~462 www.springerlink.com/content/738-494x DOI 0.007/s2206-0-035-2 Enhancement of wind turbine aerodynamic performance by a numerical optimization

More information

Accelerated flow acoustic boundary element solver and the noise generation of fish

Accelerated flow acoustic boundary element solver and the noise generation of fish Accelerated flow acoustic boundary element solver and the noise generation of fish JUSTIN W. JAWORSKI, NATHAN WAGENHOFFER, KEITH W. MOORED LEHIGH UNIVERSITY, BETHLEHEM, USA FLINOVIA PENN STATE 27 APRIL

More information

Shock Wave Reduction via Wing-Strut Geometry Design

Shock Wave Reduction via Wing-Strut Geometry Design Shock Wave Reduction via Wing-Strut Geometry Design Runze LI, Wei NIU, Haixin CHEN School of Aerospace Engineering Beijing 84, China PADRI, Barcelona (Spain) 27..29 SHORT VERSION Shock Wave Reduction via

More information

Airfoil Boundary Layer Separation Prediction

Airfoil Boundary Layer Separation Prediction Airfoil Boundary Layer Separation Prediction A project present to The Faculty of the Department of Aerospace Engineering San Jose State University in partial fulfillment of the requirements for the degree

More information

In Pursuit of Grid Convergence for Two-Dimensional Euler Solutions

In Pursuit of Grid Convergence for Two-Dimensional Euler Solutions JOURNAL OF AIRCRAFT Vol. 47, No. 4, July August 2010 In Pursuit of Grid Convergence for Two-Dimensional Euler Solutions John C. Vassberg The Boeing Company, Huntington Beach, California 927 and Antony

More information

Simulation of Turbulent Flow around an Airfoil

Simulation of Turbulent Flow around an Airfoil 1. Purpose Simulation of Turbulent Flow around an Airfoil ENGR:2510 Mechanics of Fluids and Transfer Processes CFD Lab 2 (ANSYS 17.1; Last Updated: Nov. 7, 2016) By Timur Dogan, Michael Conger, Andrew

More information

Modeling three-dimensional dynamic stall

Modeling three-dimensional dynamic stall Appl. Math. Mech. -Engl. Ed., 32(4), 393 400 (2011) DOI 10.1007/s10483-011-1424-6 c Shanghai University and Springer-Verlag Berlin Heidelberg 2011 Applied Mathematics and Mechanics (English Edition) Modeling

More information

ME 4943 Course Project - Part I

ME 4943 Course Project - Part I ME 4943 Course Project - Part I Numerical Implementation of the Source Panel Method by Jeffrey A. Kornuta Mechanical Engineering Louisiana State University October 9, 27 1 Contents 1 Verification of Algorithm

More information

INVERSE METHODS FOR AERODYNAMIC DESIGN USING THE NAVIER-STOKES EQUATIONS

INVERSE METHODS FOR AERODYNAMIC DESIGN USING THE NAVIER-STOKES EQUATIONS INVERSE METHODS FOR AERODYNAMIC DESIGN USING THE NAVIER-STOKES EQUATIONS I.A. Gubanova, M.A. Gubanova Central Aerohydrodynamic Institute (TsAGI) Keywords: inverse method, Navier Stokes equations, ANSYS

More information

Effect of Slot Span on Wing Performance

Effect of Slot Span on Wing Performance Dissertations and Theses 12-2016 Effect of Slot Span on Wing Performance Juan F. Granizo Follow this and additional works at: https://commons.erau.edu/edt Part of the Aerodynamics and Fluid Mechanics Commons

More information

Parallelized Coupled Solver (PCS) Model Refinements & Extensions

Parallelized Coupled Solver (PCS) Model Refinements & Extensions Parallelized Coupled Solver (PCS) Model Refinements & Extensions Sven Schmitz GE Wind November 29 th, 2007 Greenville, SC University of California, Davis Schmitz GE Wind - PCS 1 Outline 2007 Parallelized

More information

Simulation of the Dynamics of Micro Air Vehicles. Ravi Ramamurti and William Sandberg

Simulation of the Dynamics of Micro Air Vehicles. Ravi Ramamurti and William Sandberg AIAA 2000-0896 Simulation of the Dynamics of Micro Air Vehicles Ravi Ramamurti and William Sandberg Laboratory for Computational Physics and Fluid Dynamics Naval Research Laboratory Washington, D.C. 20375

More information

Axisymmetric Viscous Flow Modeling for Meridional Flow Calculation in Aerodynamic Design of Half-Ducted Blade Rows

Axisymmetric Viscous Flow Modeling for Meridional Flow Calculation in Aerodynamic Design of Half-Ducted Blade Rows Memoirs of the Faculty of Engineering, Kyushu University, Vol.67, No.4, December 2007 Axisymmetric Viscous Flow Modeling for Meridional Flow alculation in Aerodynamic Design of Half-Ducted Blade Rows by

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

CFD analysis of 2D and 3D airfoils using open source solver SU2

CFD analysis of 2D and 3D airfoils using open source solver SU2 CFD analysis of 2D and 3D airfoils using open source solver SU2 Internship Report Rajesh Vaithiyanathasamy Sustainable Energy Technology December 11, 2016 Supervisors: Prof. Dr. Ir. C. H. Venner (Universiteit

More information

METHODOLOGY OF 3D HYDRAULIC DESIGN OF A IMPELLER OF AXIAL TURBO MACHINE

METHODOLOGY OF 3D HYDRAULIC DESIGN OF A IMPELLER OF AXIAL TURBO MACHINE Engineering MECHANICS, Vol. 20, 2013, No. 2, p. 107 118 107 METHODOLOGY OF 3D HYDRAULIC DESIGN OF A IMPELLER OF AXIAL TURBO MACHINE Michal Varchola*, Tomaš Bielik*, Peter Hlbočan* The paper deals with

More information

Verification and Validation of Turbulent Flow around a Clark-Y Airfoil

Verification and Validation of Turbulent Flow around a Clark-Y Airfoil Verification and Validation of Turbulent Flow around a Clark-Y Airfoil 1. Purpose 58:160 Intermediate Mechanics of Fluids CFD LAB 2 By Tao Xing and Fred Stern IIHR-Hydroscience & Engineering The University

More information

Supersonic Wing Design Method Using an Inverse Problem for Practical Application

Supersonic Wing Design Method Using an Inverse Problem for Practical Application 47th AIAA Aerospace Sciences Meeting Including The New Horizons Forum and Aerospace Exposition 5-8 January 29, Orlando, Florida AIAA 29-1465 Supersonic Wing Design Method Using an Inverse Problem for Practical

More information

AeroPack User s Manual

AeroPack User s Manual AeroPack User s Manual Design Analysis Research AeroPack User s Manual for Shark & Shark FX The software described in this document is furnished under a license agreement. The software may be used or

More information

Transonic Airfoil Shape Optimization in Preliminary Design Environment

Transonic Airfoil Shape Optimization in Preliminary Design Environment 10th AIAA/ISSO ultidisciplinary Analysis and Optimization Conference 30 August - 1 September 2004, Albany, New York AIAA 2004-4629 Transonic Airfoil Shape Optimization in Preliminary Design Environment

More information

DYNAMICS OF A VORTEX RING AROUND A MAIN ROTOR HELICOPTER

DYNAMICS OF A VORTEX RING AROUND A MAIN ROTOR HELICOPTER DYNAMICS OF A VORTEX RING AROUND A MAIN ROTOR HELICOPTER Katarzyna Surmacz Instytut Lotnictwa Keywords: VORTEX RING STATE, HELICOPTER DESCENT, NUMERICAL ANALYSIS, FLOW VISUALIZATION Abstract The main goal

More information

COMPARISON OF SHOCK WAVE INTERACTION FOR THE THREE-DIMENSIONAL SUPERSONIC BIPLANE WITH DIFFERENT PLANAR SHAPES

COMPARISON OF SHOCK WAVE INTERACTION FOR THE THREE-DIMENSIONAL SUPERSONIC BIPLANE WITH DIFFERENT PLANAR SHAPES 26 TH INTERNATIONAL CONGRESS OF THE AERONAUTICAL SCIENCES COMPARISON OF SHOCK WAVE INTERACTION FOR THE THREE-DIMENSIONAL SUPERSONIC BIPLANE WITH DIFFERENT PLANAR SHAPES M. Yonezawa*, H. Yamashita* *Institute

More information

CFD SIMULATIONS OF HORIZONTAL AXIS WIND TURBINE (HAWT) BLADES FOR VARIATION WITH WIND SPEED

CFD SIMULATIONS OF HORIZONTAL AXIS WIND TURBINE (HAWT) BLADES FOR VARIATION WITH WIND SPEED 2 nd National Conference on CFD Applications in Power and Industry Sectors January 28-29, 2009, Hydrabad, India CFD SIMULATIONS OF HORIZONTAL AXIS WIND TURBINE (HAWT) BLADES FOR VARIATION WITH WIND SPEED

More information

CFD Study of a Darreous Vertical Axis Wind Turbine

CFD Study of a Darreous Vertical Axis Wind Turbine CFD Study of a Darreous Vertical Axis Wind Turbine Md Nahid Pervez a and Wael Mokhtar b a Graduate Assistant b PhD. Assistant Professor Grand Valley State University, Grand Rapids, MI 49504 E-mail:, mokhtarw@gvsu.edu

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

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

Inviscid Flows. Introduction. T. J. Craft George Begg Building, C41. The Euler Equations. 3rd Year Fluid Mechanics

Inviscid Flows. Introduction. T. J. Craft George Begg Building, C41. The Euler Equations. 3rd Year Fluid Mechanics Contents: Navier-Stokes equations Inviscid flows Boundary layers Transition, Reynolds averaging Mixing-length models of turbulence Turbulent kinetic energy equation One- and Two-equation models Flow management

More information

Experimental study of UTM-LST generic half model transport aircraft

Experimental study of UTM-LST generic half model transport aircraft IOP Conference Series: Materials Science and Engineering PAPER OPEN ACCESS Experimental study of UTM-LST generic half model transport aircraft To cite this article: M I Ujang et al 2016 IOP Conf. Ser.:

More information