Rapid Calculation of Unsteady Aircraft Loads
Rapid Calculation of Unsteady Aircraft Loads
Rapid Calculation of Unsteady Aircraft Loads
Key words: Multi–fidelity aerodynamic flow solver, Rapid CFD methods, Unsteady flow
problems.
1 INTRODUCTION
At the early stages of the aircraft design process, a large parameter space is explored,
where the designers are typically relying on empirical and linear correlations [1]. Sev-
eral low–fidelity methods based on potential–flow theory exists for rapid estimation of
unsteady aerodynamic loads, e.g. doublet lattice method (DLM). Main advantages of
these techniques are, a) their high computational speed; b) straightforward set–up of
the problem, using simplified descriptions of lifting surfaces; and c) their applicability,
as the methods have been calibrated on a number of existing aircraft configurations to
account for un–modeled nonlinear flow phenomena. Their main drawback is that they
heavily rely on the existence and availability of previous data, and this hinders their ap-
plicability to the design of radically new configurations. On the contrary, high–fidelity
methods based on the three–dimensional (3D) unsteady Reynolds-averaged Navier-Stokes
(URANS) solvers provide a good alternative to existing practice, however, they are yet
too expensive for routine use from the industrial viewpoint. Due to these reasons, there
is the need for a medium–fidelity approach, which combines: a) consistency, the approach
adheres to a sound physical and theoretical model, combining favorable elements of the
low and of the high–fidelity approaches; b) conformity, the approach is able to predict
effectively within the bounds of the high–fidelity approach, making every possible effort to
keep the CPU costs limited; c) convenience, the approach introduces as little as possible
modifications to the existing design process. Medium–fidelity approach offers the possi-
bility to limit the risk of setting the target design loads already at early design phase. If
target loads are underestimated, an expensive re-design is typically required. Equally, if
the target loads are overestimated, the aircraft will be heavier than needed, with degraded
performances [2].
For steady aerodynamics, several attempts have been made in the past to couple linear
methods with nonlinear viscous lift slope of sectional airfoils. The algorithms were based
either on correction of the circulation, Γ, [3, 4] or on the α–based correction method, [5, 6].
Most recently, Gallay and Laurendeau extended the α–based coupling algorithm [6] to
general wings in steady subsonic and transonic flight regimes, and improved the aero-
dynamic load predictions at high angle–of–attacks [7, 8]. On the contrary, for unsteady
aerodynamics, there is a lack of studies which couple unsteady linear methods with the
nonlinear counterpart. Parenteau et al. [9] recently demonstrated two unsteady α–based
coupling algorithms. The first one uses two–dimensional (2D) sectional viscous lift curve
data in combination with quasi–unsteady corrections. Such algorithm is, however, lim-
ited to motions with small reduced frequencies and low angle–of–attacks. The second one
uses an unsteady 2D URANS sectional lift curve database in combination with UVLM.
Unfortunately, this approach has its limitations, since the flow unsteadiness resolved by
the 2D URANS approach is pre–computed, i.e. unsteady and dynamic flow effects are
treated in the usual way commonly adopted for flight mechanics aerodynamic tables, by
employing dynamic derivatives [10, 11].
With the above paragraphs as background, the present work aims at making progress in
rapid unsteady load calculations, with the development, implementation, and demonstra-
2
J. Drofelnik, A. Da Ronch, D. Kharlamov and Y. Sun
2 METHODOLOGY
The proposed multi–fidelity solver builds upon the UVLM solver, to model 3D effects,
and the 2.5D+ URANS solver, to capture the sectional viscous effects. These two solvers
are coupled by a time–accurate scheme for unsteady analyses.
3
J. Drofelnik, A. Da Ronch, D. Kharlamov and Y. Sun
m
X
aKL ΓL = RHSK (1)
L=1
where aKL is the KL-th component of the aerodynamic influence matrix and RHSK is
the right-hand side vector of each collocation point K. If the shape of the wing does not
change, the matrix inversion occurs only during the first time step.
Once the vortex distribution is obtained the pressures and loads are calculated. A non–
planar formulation is used to estimate the loads using Kutta–Joukowski theorem [14].
4
J. Drofelnik, A. Da Ronch, D. Kharlamov and Y. Sun
where α∞ denotes the freestream angle–of–attack; ii) run a limited number of URANS
inner iterations at αef f to obtain the URANS lift coefficient CLUVLM , which is required for
the estimation of the angle–of–attack correction:
C URANS − CLUVLM
∆α = ν L (3)
2π
where ν represents the relaxation factor, to make the iterative procedure more stable. It
is worth noting that CLURANS and CLUVLM are function of the time step, the instantaneous
5
J. Drofelnik, A. Da Ronch, D. Kharlamov and Y. Sun
angle–of–attack and its derivative. For brevity, these dependencies are omitted from the
notation. Once ∆α has been estimated, α∞ is adjusted at every panel; if the user selects
more than one URANS section, linear interpolations of ∆α are performed across the
span. This completes one cycle of the nested inner loop. The iterative loop continues
until convergence of the lift coefficient is achieved. Advancing of the solution includes
shedding of the wake carpet behind the wing, and the increment of the physical time of
both UVLM and URANS solvers. Once the solution becomes periodic, the time dependent
loop is completed. Lastly, the computation is finalized, and memory is deallocated.
The coupling algorithm, which synchronizes the execution of the UVLM and URANS
solvers, is written in Python. By using the Python C-API, data is continuously exchanged
between Python and C subroutines of the UVLM code. A Python wrapper of the DLR-
Tau code is also employed, which allows to call subroutines of the URANS solver directly
from the main framework and exchange data over shared memory. This avoids more time
consuming exchange procedures of data between the codes using the file system.
3 VERIFICATION OF UVLM
3.1 Steady planar wings
At first the validation of the inviscid steady solution of VLM against experimental
data from [13] is performed. Figure 3 depicts the lift coefficient slope, computed for the
planar wings of various sweep angles, Λ, and aspect ratios, AR. To assure convergence
of all cases, 8 panels have been used in chordwise (Nx = 8), and 26 panels in spanwise
(Ny = 26) directions. The experimental and numerical data are in excellent agreement.
Figure 3: Steady lift coefficient slope for a flat plate with different aspect ratios and sweep angles
(Nx = 8, Ny = 26).
6
J. Drofelnik, A. Da Ronch, D. Kharlamov and Y. Sun
Figure 4: Lift coefficient of an infinite wing undergoing harmonic pitch oscillations at three different
reduced frequencies (Nx = 56 × k, Ny = 12, ∆τ = N1x ).
Figure 4 represents the harmonic pitch oscillations of a thin airfoil. For all cases
three oscillation cycles are computed, to assure periodic solution, and the initial transient
was removed from the comparison. The UVLM results are in excellent agreement with
Theodorsen’s analytical solution for all reduced frequencies, which confirms the correct-
ness of implementation.
7
J. Drofelnik, A. Da Ronch, D. Kharlamov and Y. Sun
4 TEST CASE
4.1 Forced Sinusoidal Motion of wing
The test case to demonstrate multi–fidelity solver concerns transonic flow predictions
around a wing undergoing a forced sinusoidal motion in pitch, given by the Eq. 4. The
flow conditions are for M∞ = 0.755 and Re∞ = 5.5 · 106 . The motion is characterized
by a reduced frequency k = 0.0814, mean angle of attack α0 = 0.016 deg and amplitude
αA = 2.51 deg. Since there is a lack of experimental data for a 3D wings undergoing
forced motion in transonic flow, we have adapted the well-known 2D AGARD CT 5
configuration, pitching at one–quarter of the chord. The flow field presents the formation
of a strong and highly dynamic shock wave, the steady solution includes a virtually
symmetric shock wave which periodically appears and disappears on the upper and lower
surfaces as consequence of the harmonic motion. A fairly large AR = 20 wings, using the
NACA 0012 aerofoil, have been constructed for three different sweep angles.
(a) Unstructured 2D grid (b) The wing planform of the Λ = 20 deg wing.
Four sets of grids were used for the analyses. The unstructured 2D grid, depicted in
Fig. 5, was employed to solve the 2D and 2.5D+ URANS equations. The grid consists
of about 15.3 thousand mesh elements with the first layer on the wall at 5 · 10−6 (for a
chord of one), ensuring y + < 1. Furthermore, for the dependence of the wing sweep angle
(Λ = 0, 10, 20 deg) on the aerodynamic loads, three finite–span AR = 20 wings were
built by stacking the 2D unstructured grid in the spanwise direction from the midspan
symmetry plane to the lateral farfield boundary. Fig. 5(b) depicts the 3D grid with
the sweep angle of Λ = 20 deg. For all cases 128 points have been used in spanwise
direction, featuring about 2 million mesh elements, and a symmetry boundary condition
was enforced at midspan, to halve the computational cost. The Spalart–Allmaras (SA)
turbulence model and an implicit dual–time stepping scheme were employed, with a target
8
J. Drofelnik, A. Da Ronch, D. Kharlamov and Y. Sun
residual drop of three orders at each physical time step. For the multi–fidelity solver a
target residual drop of three orders at each time step is also enforced.
5 RESULTS
5.1 Forced sinusoidal motion of NACA0012 wing
For all cases, the UVLM and URANS solvers started from the freestream initial condi-
tions. All solvers used 100 physical time steps per oscillating cycle. In the figures below,
URANS is referring to the solvers of DLR-Tau code, and URANS + UVLM is referring
to multi–fidelity solver, described in section 2.3. Pure UVLM solution is not included,
because it is invalid at this transonic flow regime, or it would need compressibility cor-
rection based on the semi-empirical approach of Prandtl-Glauert. We chose, instead, to
show how the multi–fidelity solver can overcome these two problems implicitly.
Figure 6: Lift coefficient dependence on forced sinusoidal motion for sweep angle Λ = 0 deg (M∞ =
0.755, Re∞ = 5.5 · 106 , k = 0.0814, α0 = 0.016 deg, αA = 2.51 deg).
Figure 6 shows the comparison of the lift coefficient for sweep angle Λ = 0 deg for
the increased fidelity levels. For the multi fidelity solver, Nx = 1, Ny = 50 and only one
section at midspan was corrected with the URANS calculation. One may notice there
is an excellent agreement between the multi–fidelity and 3D URANS solutions. The 3D
effects are well captured with the UVLM solver, and the solution is well corrected with
the 2D URANS. The 2D URANS solution can clearly not capture the 3D effects, although
of limited extent for this wing, and is visibly different from other two solutions.
Figure 7(a) shows the comparison of the lift coefficient for sweep angle Λ = 10 deg,
for the increased fidelity levels. For the multi fidelity solver, Nx = 1, Ny = 50 and only
one section at 20% semi–span was corrected with the 2D or 2.5D+ URANS calculations.
Again, there is an excellent agreement between the multi–fidelity solver based on 2.5D+
URANS correction and 3D URANS solution. The solution of the UVLM solver is well
9
J. Drofelnik, A. Da Ronch, D. Kharlamov and Y. Sun
Figure 7: Lift coefficient dependence on forced sinusoidal motion for two sweep angles (M∞ = 0.755,
Re∞ = 5.5 · 106 , k = 0.0814, α0 = 0.016 deg, αA = 2.51 deg).
corrected with the 2.5D+ URANS solution. The multi–fidelity solver based on 2D URANS
correction does not agree well with other two solutions, since the 2D URANS can not
capture the cross–flow effects.
Finally, Fig. 7(b) shows the comparison of the lift coefficient for sweep angle Λ = 20
deg, for the increased fidelity levels. For the multi fidelity solver, Nx = 1, Ny = 50
and only one section at 20% semi–span was corrected with the 2D or 2.5D+ URANS
calculations. Also for Λ = 20 deg, there is an excellent agreement between the multi–
fidelity solver based on 2.5D+ URANS correction and 3D URANS solution. Here it is
evident the necessity of the 2.5D+ solver since the solution of the multi–fidelity solver
based on 2D URANS correction is incorrect, as the cross–flow effects are not accounted
in the solution.
The multi–fidelity solver provides a physically consistent solution of aerodynamic loads,
in comparison to that obtained from a 3D solution but at a fraction of the computational
time. Specifically, 146 CPU hours per oscillatory cycle were needed for the calculation
around the 3D wing. The CPU time per cycle was reduced to about 30 minutes when
employing the multi–fidelity approach, which corresponds to a speed–up of about 290
compared to the 3D URANS analysis.
6 CONCLUSIONS
An efficient multi–fidelity solver was discussed, which combines the unsteady vortex
lattice method solver, capturing 3D effects, with the infinite–swept wing unsteady Navier–
Stokes solver, reproducing the sectional viscous effects. The solver is based on the α–based
coupling algorithm, which corrects the freestream angle–of–attack at every panel using
the nonlinear sectional data of the unsteady Navier–Stokes solver. The strong point of
the new solver is the coupling algorithm, which allows calculations in the time domain
10
J. Drofelnik, A. Da Ronch, D. Kharlamov and Y. Sun
ACKNOWLEDGMENTS
Da Ronch and Drofelnik gratefully acknowledge the financial support from the Engi-
neering and Physical Sciences Research Council (grant number: EP/P006795/1). Mr M.
Cross and Mr T. Engelbrecht of Airbus Operation Limited are acknowledged for their
assistance and comments on industrial practice.
REFERENCES
[1] Rizzi, A. Modeling and simulating aircraft stability and control – The SimSAC
project, Progress in Aerospace Sciences (2011) 47(8):573–588.
[3] Tani, I. A simple method of calculating the induced velocity of a monoplane wing.
Aeronautical Research Institute, Tokyo Imperial University, 1934.
[5] Tseng, J.B. and Lan, C.E. Calculation of aerodynamic characteristics of airplane
configurations at high angles of attack, NASA-CR-4182, 1988.
[6] Van Dam, C.P. and Vander Kam, J.C. and Paris, J.K. Design-oriented high-lift
methodology for general aviation and civil transport aircraft, Journal of aircraft
(2001) 38(6):1076–1084.
[9] Parenteau, M. and Plante, F. and Laurendeau, E. and Costes, M. Unsteady Coupling
Algorithm for Lifting-Line Methods, 55th AIAA Aerospace Sciences Meeting (2017)
AIAA 2017–0951.
11
J. Drofelnik, A. Da Ronch, D. Kharlamov and Y. Sun
[10] Da Ronch, A. and Ghoreyshi, M. and Badcock, K. On the generation of flight dy-
namics aerodynamic tables by computational fluid dynamics, Progress in Aerospace
Sciences (2011) 47(8):597–620.
[12] Franciolini, M. and Da Ronch, A. and Drofelnik, J. and Raveh, D. and Crivellini, A.
Efficient Infinite-swept Wing Solver for Steady and Unsteady Compressible Flows,
Aerospace Science and Technology (2018) 72:217–229.
[13] Katz, J. and Plotkin, A. Low-speed aerodynamics. Cambridge University Press, 2001.
[14] Simpson, R. and Palacios, R. and Murua, J. Induced-Drag Calculations in the Un-
steady Vortex Lattice Method, AIAA Journal (2013) 51(7): 101–144.
[15] Droflenik, J. and Da Ronch, A. 2.5D+ User Guide. Documentation for DLR-Tau flow
solver, 2017.
[16] Schwamborn, D. and Gerhold, T. and Heinrich, R. The DLR TAU–code: recent
applications in research and industry, Proceedings of the European Conference on
Computational Fluid Dynamics (ECCOMAS), 2006.
[17] Theodorsen, T. and Mutchler, W.H. General theory of aerodynamic instability and
the mechanism of flutter. National Advisory Committee for Aeronautics Washington,
DC, USA, 1935.
12