3 Coding Assignment 1 Aero 2
3 Coding Assignment 1 Aero 2
3 Coding Assignment 1 Aero 2
0010-34 Airfoil
Muhammad Arviano Yuono Jonwin Fidelis Fam Hafizh Renanto Akhmad
Aerospace Engineering Aerospace Engineering Aerospace Engineering
Institut Teknologi Bandung Institut Teknologi Bandung Institut Teknologi Bandung
Bandung, Indonesia Bandung, Indonesia Bandung, Indonesia
[email protected] [email protected] [email protected]
Abstract—This report is a coding assignment of small section of the vortex sheet induces a infinitesimally
Aerodynamics II Course (AE 3210) about Numerical Thin small velocity 𝑑𝑉 at point 𝑃. [2]
Airfoil Theory. Under this report, a calculation of lift and Cl at
0° angle of attack and compare between numerical thin airfoil Γ 𝛾𝑑𝑠
theory, analytical thin airfoil theory, and experiment results. 𝑉𝑃 = − ⇒ 𝑑𝑉 = − ()
2𝜋𝑟 2𝜋𝑟
The airfoil that is analyzed is a modified NACA 0010-34 airfoil.
Hence, the incremental velocities induced at P by different
Keywords—Aerodynamics II, Numerical Thin Airfoil Theory, sections of the vortex sheet must be added vectorially.
NACA 0010-34 Because of this, it is sometimes more convenient to deal with
the velocity potential, which can be determined as (2)
I. BASIC THEORY
An airfoil is the section of a wing cut by a plane parallel 𝑑𝜙 = −
𝛾𝑑𝑠
𝜃 ⇒ 𝜙(𝑥, 𝑧) = −
1 𝑏
∫ 𝜃𝛾𝑑𝑠 ()
to the xz-plane [1]. Within the assumed inviscid flow, the lift 2𝜋 2𝜋 𝑎
and moments on the airfoil are due from pressure distribution
below the stall region. Under these conditions, a theoretical
estimation of airfoil lift and moments can be predicted. In
order to do so, further conceptual understanding regarding the
vortex sheets must be done.
A. Source Sheet
A source sheet is an infinite number of line sources side
by side, with the strength of each line source being
infinitesimally small. For vortex flow, consider an analogous
situation. Imagine an infinite number of straight vortex
filaments side by side, where the strength of each filament is
infinitesimally small. These side-by-side vortex filaments Fig. 2. Tangential velocity jump across a vortex sheet
form a vortex sheet, as shown in perspective in the upper left
of Fig. 1. If we look along the series of vortex filaments For vortex sheet, there is a change in the directional of
tangential vector across the vortex sheet due to the strength of
the sheet. [2] The dashed path enclosing a section can be
illustrated as Fig. 2. From the definition of circulation, the
circulation around the dashed path is:
Γ = ∫ 𝛾 𝑑𝑠 ()
𝛾 = 𝑢1 − 𝑢2 ()
Fig. 1. Vortex Sheet
B. Airfoil Theory
(looking along the y axis in Fig. 1), the vortex sheet will
appear as sketched at the lower right of Fig. 1. Any airfoil with arbitrary shape can be estimated using the
vortex sheet approach. The variation of variable strength 𝛾(𝑠)
Let 𝑠 be the distance measures along the vortex sheet in from replacing the airfoil surface with vortex sheet will make
the edge view. Define 𝛾 = 𝛾(𝑠) as the strength of the vortex the vortex sheet (hence the surface of airfoil) as a streamline
sheet, per unit length along 𝑠 . Thus, the strength of an of the flow. The resulting circulation is estimated by (3),
infinitesimal potion ds of the sheet is 𝛾 𝑑𝑠. This small section which the lift will be given by Kutta-Joukowski Theorem.
of the vortex sheet can be treated as a distinct vortex of However, as there is no general solution of 𝛾(𝑠), the solution
strength γ ds; the cartesian coordinates of P are (x,z). The is done numerically with digital computer. Airfoil must adhere
to the Kutta Condition, which states that:
1) For a given airfoil at a given angle of attack, the value C. Classical Thin Airfoil Theory
of Γ around the airfoil is such that the flow leaves the trailing Besides numerical methods, further assumption can be
edge smoothly. done to create an analytical equation for the thin airfoil. The
2) If the trailing-edge angle is finite, then the trailing fundamentals of the vortex sheet can be applied to this airfoil.
edge is a stagnation point. For the camber line to be the streamline, the velocity normal
3) If the trailing edge is cusped, then the velocities to the camber line should be zero at all points along the camber
leaving the top and bottom line. The velocity at any point in the flow is the sum of the
Consider that from (5), a finite trailing edge satisfies both uniform freestream velocity and the velocity induced by the
2nd and 3rd Kutta Condition, therefore the relation (6) can be vortex sheet. [3]
determined. 𝑉∞,𝑛 + 𝑤 ′ (𝑠) = 0 (11)
Four coefficients (a0, a1, a2, a3) are determined from the
following conditions: [4]
1) Maximum thickness, t
2) Position of maximum thickness, m Fig. 4. NACA 0010-34 Experimental Lift Coefficient Slope [5]
3) Leading-edge radius, rt=a02/2, rt=1.1019(tI/6)2, where
I is the first integer following the dash in the designation and experimental results shown in Fig. 6, also shows the values to
value of I does not exceed 8. be also 0. Note that because of the circulation strength is
4) Radius of curvature R at-the point of maximum already zero, the lift and lift coefficient values in all Reynolds
thickness Number, is zero as long as in 0° angle of attack.
B. Further Exploration
Since these MATLAB codes might be inaccurate with one
experiment, this report explore the case of numerical airfoil
theory with several angle of attack, that being at -5°, 3° and
10°. This experiment is done on Reynolds Number 9 × 106.
The results is shown in Table 2. Results are further illustrated
in Fig. 7, 8 and 9.
𝜶 𝚪 𝑳 (𝐍) 𝒄𝒍
APPENDIX
See next page.
%% Coding Assignment 1 by Group 3
clear, clc
Xv = camberline(1, :);
Zv = camberline(2, :);
xlim([0 1])
ylim([-0.5 0.5])
grid on
plot(airfoil(1,:),airfoil(2,:))
plot(camberline(1,:),camberline(2,:))
scatter(Xv, Zv)
scatter(Xvl, Zvl)
scatter(Xcp, Zcp)
xlim([0 1])
ylim([-0.5 0.5])
grid on
%% Compute the panel length
dS = zeros(1, Np);
for i = 1:Np
dS(i) = sqrt((Xv(i+1)-Xv(i))^2 + (Zv(i+1)-Zv(i))^2);
end
for i=1:Np
for j=1:Np
A(i, j) = dS(j) / (Xvl(j) - Xcp(i));
end
end
for i=1:Np
b(i) = 2*pi*(Vinf(1) * dZdX(i) - Vinf(2));
end
gamma = A\b';
w = zeros(Np, Np);
for i=1:Np
for j=1:Np
w(i,j) = A(i,j)*gamma(j);
end
end
% Plot gamma distribution
figure(3)
plot(Xv(1:Np), gamma)
yscale log
xlim([0 1])
grid on
for i=1:Np
L = L + rho * magVinf * gamma(i) * dS(i);
end
fprintf('The Lift Force in %d angle of attack is %5f N \n',AoA,L)
for i=1:Np
b(i) = 2*pi*(Vinf(1) * dZdX(i) - Vinf(2));
end
gamma = A\b';
w = zeros(Np, Np);
for i=1:Np
for j=1:Np
w(i,j) = A(i,j)*gamma(j);
end
end
%% Plot CL and CD
figure(4)
figure(5)
p = polyfit(CLplot(:,1), CLplot(:,2),1);
title({append("NACA ", nacaSeries), "Lift Coefficient v \alpha", "Reynolds
Number: "+num2str(RE)})
hold on
plot(CLplot(:,1), CLplot(:,2))
caption = sprintf('C_L = %10f * α + %10f', p(1), p(2));
text(0, -0.1, caption, 'Color', 'k');
grid on
%% Functions
function Vinf = V(magVinf, AoA)
Vinf = magVinf * [cosd(AoA); sind(AoA)];
end
series = char(series);
len = length(series);
if (spacing)
beta = linspace(0, pi, num+1);
x = (1 - cos(beta)) / 2;
else
x = linspace(0, 1, num+1);
end
if (len == 4)
% Normal NACA 4-digit series
m = str2double(series(1))/100;
p = str2double(series(2))/10;
t = str2double(series(3:4))/100;
yc = zeros(1, length(x));
dycdx = zeros(1, length(x));
yt = zeros(1, length(x));
xU = zeros(1, length(x));
yU = zeros(1, length(x));
xL = zeros(1, length(x));
yL = zeros(1, length(x));
for i=1:length(x)
if (x(i) < p)
yc(i) = m/p^2 * (2*p*x(i) - x(i)^2);
dycdx(i) = 2*m/p^2 * (p - x(i));
else
yc(i) = m/(1-p)^2 * ((1-2*p)+2*p*x(i)-x(i)^2);
dycdx(i) = 2*m/(1-p)^2 * (p - x(i));
end
theta = atan(dycdx(i));
yt = zeros(1, length(x));
d0 = 0.01*t;
d1 = dydxx1(mset==m);
d2 = D(1);
d3 = D(2);
a0 = sqrt(2*1.1019*(t*I/6)^2);
a1 = A(1);
a2 = A(2);
a3 = A(3);
for i=1:length(x)
if (x(i) < m)
yt(i) = a0*sqrt(x(i))+a1*x(i)+a2*x(i)^2+a3*x(i)^3;
else
yt(i) = d0+d1*(1-x(i))+d2*(1-x(i))^2+d3*(1-x(i))^3;
end
end