Importante

Download as pdf or txt
Download as pdf or txt
You are on page 1of 21

AIAA Guidance, Navigation and Control Conference, Toronto, Canada

Wind Field Estimation for Small Unmanned Aerial


Vehicles
Jack W. Langelaan∗
The Pennsylvania State University, University Park, PA 16802, USA
Nicholas Alley†
Area-I Inc., Canton, GA 30115 USA
James Neidhoefer‡
Aerotonomy, Inc., Lithia Springs, GA 30122 USA

This paper describes a method for estimating wind field (wind velocity, rate of change
of wind velocity and wind gradient) for small and mini unmanned aerial vehicles. The
approach utilizes sensors which are already part of a standard autopilot sensor suite (GPS,
inertial measurement unit, airspeed, magnetometer). The primary motivation is enabling
energy harvesting; a secondary motivation is development of a low-cost atmospheric mea-
surement and sampling system. The paper presents an error analysis and discusses the
primary contributions to error in the estimated wind field. Results of Monte Carlo simu-
lations compare predicted errors in wind estimates with actual errors and show the effect
of using estimated winds for energy harvesting from gusts.

I. Introduction
in the problem of autonomous atmospheric energy harvesting (i.e. autonomous soaring) has
I1889nterest
been growing over the past few years. Observations of bird flight published by Lord Rayleigh in 1883 and
1, 2
provided the early indications of energy harvesting using appropriate flight techniques. More recent
work by Pennycuick3 and Sachs4 quantified the conditions under which birds such as albatrosses are able to
harvest energy.
Knowledge of wind field is generally implicitly assumed in autonomous energy harvesting research. Dy-
namic soaring typically assumes full a priori knowledge of the wind field and casts energy harvesting as a
trajectory optimization problem,5, 6 and even gust soaring assumes knowledge of current wind conditions.7, 8
This paper is concerned with estimating wind conditions to enable gust soaring. Since the motivation is
small, low cost uavs (here small is assumed to mean hand-launchable vehicles ranging from 1 kg mass/1m
span to 10 kg mass/4m span), minimizing sensing requirements is a priority. For example, while accurate
measurements of wind field (including spatial gradients) can be obtained using arrays of multi-hole pitot
probes,9 the intent here is to obtain estimates of wind field using only sensing that is already available on
the aircraft. This sensing suite (included in typical autopilot modules) includes Global Positioning System
(gps), inertial measurement unit (imu), magnetometer, static pressure and dynamic pressure. Here we
further assume that the autopilot module computes an estimate of aircraft state (position, orientation and
velocity with respect to the airmass). This estimate of state is not assumed to be perfect: in addition to
estimation of the wind field, this paper discusses the effect of noise and errors in the state estimate on the
computed wind field.
Dynamic soaring and efficient gust soaring can under certain conditions make significant use of gradients
and rates of change of the wind field. Hence the wind estimation system must be able to obtain estimates
of gradients and rates of change of wind velocity as well as the components of wind velocity.
∗ Assistant Professor, Department of Aerospace Engineering, Senior Member AIAA.
† Member AIAA.
‡ Associate Fellow AIAA.

Copyright c 2010 by Jack W. Langelaan, Nicholas Alley and James Neidhoefer. Published by the American Institute of
Aeronautics and Astronautics, Inc. with permission.

1 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


A significant amount of research has been conducted for wind estimation. Pachter et al. use gps inertial
and air data measurements to estimate horizontal components of wind speed and vehicle heading angle, but
do not address wind gradients or acceleration.10 Rodriguez et al. use gps, air data and optical flow to
compute wind speed for planar flight.11 Myschik discusses an integrated wind estimation/navigation system
for use on general aviation aircraft.12, 13 de Divitiis describes a variational technique for wind estimation for
a small ducted fan vehicle.14

II. Wind Estimation


A. Wind field
Wind is assumed to be a spatially and temporally varying vector field:
 
wix (x, y, z, t)
w(x, y, z, t) =  wiy (x, y, z, t)  (1)
 

wiz (x, y, z, t)

where the subscript i denotes components expressed in the inertial frame. A vehicle flying through this
field is influenced by the components of the wind field, local temporal variations of the wind field and by
gradients of the wind field. The rate of change of wind velocity as seen by the vehicle is a function of the
rate of change of wind speed at a point, the field gradient and the vehicle velocity:
     
l
ẇix ẇix ẋ
d   l 
w(x, y, z) =  ẇiy  =  ẇiy  + ∇w  ẏ  (2)
  
dt l
ẇiz ẇiz ż

where ẋ, ẏ, ż are the components of the velocity of the vehicle with respect to the inertial frame and ∇w is
the spatial gradient of the wind field. The superscript l denotes the time rate of change of wind velocity at
the point (x, y, z). For a frozen wind field this is zero, however the approximation of a frozen wind field is
only applicable when vehicle velocity is large compared with the “point” rates of change of wind velocity.
Unless arrays of air data probes are used, separating the effect of gradients from the point rates of change
is extremely difficult without making several approximations and simplifications. MIL-F-8785C suggests
treating wind gradients as equivalent to aircraft angular velocities, with
δwbz
pw = − (3)
δy
δwbz
qw = (4)
δx
δwby
rw = (5)
δx
where the subscript b denotes components of wind expressed in the body frame.15
This definition assumes that the effects of some components of gradient are negligible because of typical
aircraft configuration: for example, wing span is significantly larger than tail height, so vertical gradient of
the lateral airmass velocity has negligible effect on roll rate.
Depending on the ultimate application of the wind field estimates it may be unnecessary to separate the
effect of point changes in wind speed from the effect of gradients. This paper will focus on the problem of
estimating the velocity vector and the net rate of change of wind velocity.

B. Vehicle Dynamics and Kinematics


Equations of motion of a flight vehicle in turbulent conditions are briefly derived. Consider an aircraft
located at r in an inertial frame I, where x̂i , ŷ i and ẑ i define unit vectors (see Figure 1).
Using a standard body-fixed coordinate frame with airmass-relative velocity va having components u, v,
w in the body x̂b , ŷb , ẑb directions, respectively, the velocity of the aircraft in the inertial frame is

ṙ = va + w (6)

2 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


L
x^b
T β
α va
B
^y
D b

mg x^b
^z
b
B
^y
b

r
^z
b
O ^x
i

y^i w
z^i

Figure 1. Reference frames. The upper left portion shows forces acting on the vehicle.

Hence
d d
r̈ = va + w (7)
dt dt
where  

d
va =  v̇  + ω × va (8)
 
dt

Note that coordinate frames in Equation 6 have not yet been specified: for convenience the inertial frame
O is used for w while the body-fixed frame is used for va .
Substituting ω = [p q r]T (the angular velocity expressed in the body frame),
 
d
X + Y + Z + mg = m (u̇ + qw − rv)x̂b + (v̇ + ru − pw)ŷb + (ẇ + pv − qu)ẑb + w (9)
dt

where X, Y, and Z, are aerodynamic forces in the body x, y, z directions, respectively (these are functions
of thrust T, drag D and lift L) and mg is the force due to gravity.
d
The vector of wind accelerations dt w is expressed in the inertial frame. Using a direction cosine matrix
T which transforms a vector expressed in the inertial frame to a vector expressed in the body frame,
 
cos θ cos ψ cos θ sin ψ − sin θ
T =  sin φ sin θ cos ψ − cos φ sin ψ sin φ sin θ sin ψ + cos φ cos ψ sin φ cos θ  (10)
 

cos φ sin θ cos ψ + sin φ sin ψ cos φ sin θ sin ψ − sin φ cos ψ cos φ cos θ

the body axis accelerations with respect to the surrounding air are
X
u̇ = − g sin θ − qw + rv − ẇix cos θ cos ψ − ẇiy cos θ sin ψ + ẇiz sin θ (11)
m
Y
v̇ = + g sin φ cos θ + pw − ru − ẇix (sin φ sin θ cos ψ − cos φ sin ψ)
m
−ẇiy (sin φ sin θ sin ψ + cos φ cos ψ) − ẇiz sin φ cos θ (12)
Z
ẇ = + g cos φ cos θ + qu − pv − ẇix (cos φ sin θ cos ψ + sin φ sin ψ)
m
−ẇiy (cos φ sin θ sin ψ − sin φ cos ψ) − ẇiz cos φ cos θ (13)

3 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


Here ẇi(·) denotes the rate of change of a component of the wind velocity expressed in the inertial frame.
Given the vehicle dynamics in Equations 11–13, expressions for aerodynamic forces are required. Here
linearized expressions for forces and moments are used, so that16

X = X0 + Xu ∆u + Xw ∆w + Xc (14)
Y = Y0 + Yv v + Yp (p − pw ) + Yr (r − rw ) + Yc (15)
Z = Z0 + Zu ∆u + Zw ∆w + Zẇ ẇ + Zq (q − qw ) + Zc (16)

Stability and control derivatives are vehicle dependent.


Finally, aircraft kinematics with respect to the Earth are
     
ẋ u wix
−1 
 ẏ  = T  v  +  wiy  (17)
    

ż w wiz

where ẋ, ẏ, ż are the components of aircraft velocity with respect to the Earth in the Earth-fixed (i.e. inertial)
reference frame, T is the direction cosine matrix (Equation 10), u, v, w are components of the aircraft velocity
with respect to the airmass expressed in the body frame and wix , wiy , wiz are the components of the wind
speed with respect to the Earth, expressed in the inertial reference frame.

C. Computing Wind from Vehicle Response


Rather than use a Kalman Filter framework to estimate wind field in conjunction with aircraft states, one
can compare measurements of aircraft motion with respect to the Earth with predictions of aircraft motion
obtained from the dynamic model. The aircraft equations of motion can be separated into two parts: motion
induced by the state and control inputs and motion induced by the wind field. Beginning with the equations
for vehicle dynamics (Equations 11–13), and kinematics (Equation 17),
     
ẋ u wix
−1 
 ẏ  = T  v  +  wiy  (18)
    

ż w wiz
     
X
u̇ m − g sin θ − qw + rv ẇix
 Y
 v̇  =  m + g sin φ cos θ + pw − ru  − T  ẇiy  (19)
    
Z
ẇ m + g cos φ cos θ + qu − pv ẇiz

Writing this compactly in discrete form using a Forward Euler integration,


" #" #
I 0 wk−1
xk = xk−1 + ∆tfu (xk−1 , uk−1 ) + ∆t (20)
0 −T ẇk−1

where x = [x y z u v w]T and fu is the aircraft kinematic/dynamic model (i.e. the first terms on the right
hand side of Equations 18 and 19). Rearranging gives the wind field:
" # " #
wk−1 1 I 0
= [xk − xk−1 − ∆tfu (xk−1 , uk−1 )] (21)
ẇk−1 ∆t 0 −T−1

This will compute the average value of wind velocity and wind acceleration over the time interval from
k − 1 to k. The quantity ∆tfu (xk−1 , uk−1 ) is the prediction of the change in aircraft state over the time
interval from k − 1 to k while ignoring the effects of wind.
In principle this approach is straightforward, since the state x can be measured directly (using gps for
position and air data sensors for airspeedss). In practice, however, it is not likely to give good results. Its main
fault is reliance on numerical differentiation of gps position measurements: even with WAAS augmentation
gps uncertainty is of order 3m. While carrier phase differential gps improves position accuracy to order
centimeters, this is still significantly noisier than gps velocity estimates. Further, this approach relies on an
accurate dynamic model (this can be problematic for a small, low-cost uav) and accurate state estimates
for computing a prediction of vehicle state.

4 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


D. Direct Computation of Wind Field
A better approach is to use gps velocity (which is not obtained by numerically differentiating position
measurements, but by using the rates of change of pseudoranges) and measurements of vehicle acceleration.
Combined with vehicle state information this can be used to directly compute the wind field.

1. Wind Velocity
gps provides a direct measurement of velocity with respect to the Earth accurate to approximately 0.1
m/s (unaided: incorporating carrier phase differential gps allows velocity measurements accurate to order
mm/s).17 Thus local airmass velocity components can be obtained directly from vehicle kinematics and the
gps velocity:      
wix ẋ u
 wiy  =  ẏ  − T−1  v  (22)
     

wiz ż GP S w
This assumes that the autopilot module provides estimates of the components of airspeed and Euler
angles (φ, θ, ψ). The effect of noise in gps velocity measurements and in estimates of orientation and
airspeed on the computed wind will be discussed later.

2. Rate of change of wind velocity (wind acceleration)


The inertial measurement unit (imu) provides measurements of body-axis acceleration with respect to the
inertial frame and the gravity vector projected into the body frame.
d
zimu = vi − Tg + bimu + nimu (23)
dt
where vi is the velocity of the imu with respect to the Earth expressed in the body frame, bimu is the imu
bias (assumed known) and nimu is zero-mean Gaussian random noise. Assuming the imu is located at the
aircraft center of gravity, substituting vehicle dynamics gives
   
ax,b u̇ + ẇx,b + qw − rv + g sin θ
zimu =  ay,b  =  v̇ + ẇy,b + ru − pw − g cos θ sin φ  + bimu + nimu (24)
   

az,b ẇ + ẇz,b + pv − qu − g cos θ cos φ

Here the wind acceleration is expressed in the body frame. Rearranging gives
   
ẇx,b ax,b − qw + rv − g sin θ − bimu,x − u̇
 ẇy,b  =  ay,b − ru + pw + g cos θ sin φ − bimu,y − v̇  + nimu (25)
   

ẇz,b az,b − pv + qu + g cos θ cos φ − bimu,z − ẇ

where bimu,(·) denotes the components of the accelerometer bias.


There is no direct measurement of the rate of change of airspeed (u̇, v̇, ẇ) and no means of predicting the
rate of change of airspeed. Hence it must be computed by numerically differentiating measurements. This
will be noisy, leading to potentially significant uncertainty in the computed values of rate of change of wind
speed. It will also introduce a delay in the computation of wind acceleration. Here a second order numerical
differentiation is used, so that    
u̇ uk − uk−2
1 
 v̇  =  vk − vk−2  (26)
  
2∆t
ẇ k−1 wk − wk−2
where k denotes the current time step. Substituting into Equation 25 allows computation of the wind
acceleration at the previous time step:
       
ẇx,b ax,b − bimu,x − g sin θ qw − rv uk − uk−2
1 
 ẇy,b  =  ay,b − bimu,y + g cos θ sin φ  − pw − ru  −  vk − vk−2  (27)
      
2∆t
ẇz,b k−1 az,b − bimu,z + g cos θ cos φ k−1 qu − pv k−1 wk − wk−2

5 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


The difference between this approach and that defined by Equation 21 is in the use of inertial mea-
surements rather than a vehicle dynamic model. Both approaches rely on numerically differentiating mea-
surements of airspeed, but it is likely that measurements of acceleration will be more accurate than the
predictions provided by a dynamic model.
Equations 22 and 27 together allow computation of the wind velocity (expressed in the inertial frame) and
the wind acceleration as seen by the vehicle (expressed in the body frame). These can be used to compute
velocity or trajectory commands for energy maximization or other tasks such as disturbance minimization.
It is useful, however, to determine the expected error in wind field estimates.

III. Error Analysis


The wind field computation is subject to errors resulting from several sources, with two main sources
being measurement error and errors in vehicle state estimates. This section discusses and quantifies the
magnitudes of the wind field estimate errors as functions of the magnitude of the measurement and state
errors.

A. Wind velocity estimation


While the computation above was done in terms of airspeed body components u, v, w, the results of the
error analysis give intuitively more useful results when the wind computation is considered in terms of va , α
and β. Assuming wings-level flight,

wx = ẋ − va cos γ cos β cos ψ + va cos γ sin β sin ψ (28)


wy = ẏ − va cos γ cos β sin ψ − va cos γ sin β cos ψ (29)
wz = ż − va sin γ (30)

where γ = θ − α, the flight path angle with respect to the surrounding airmass.
Assuming that the errors in the measurements have a zero-mean Gaussian probability density, the error
in the computed wind field can be determined by linearizing the equations above.

w = h(x)
≈ h(x̄) + H(x − x̄) (31)

where H = ∇h, the Jacobian of the wind computation equations with respect to the measurements. As-
suming that the linearization of h is a good approximation over the range of uncertainty in x, the error in
estimated wind will have a zero-mean Gaussian probability density with covariance

Σw = HΣx HT (32)

where Σx is the covariance of the measurement noise. If the measurement noise is uncorrelated then

Σx = diag(σẋ2 σẏ2 σż2 σv2a σγ2 σβ2 σψ2 ) (33)

where σγ2 = σθ2 + σα2 .


The components of the wind error covariance are

Σw (1, 1) = σẋ2 + σv2a cos2 γ cos2 (β + ψ) + σγ2 va2 sin2 γ cos2 (β + ψ)


+(σβ2 + σψ2 )va2 cos2 γ sin2 (β + ψ) (34)
2
Σw (1, 2) = σv2a 2
cos γ sin (β + ψ) cos (β + ψ) + σγ2 va2 sin γ sin (β + ψ) cos (β + ψ)
−(σβ2 + σψ2 )va2 cos2 γ sin (β + ψ) cos (β + ψ) (35)
Σw (1, 3) = −σv2a sin γ cos γ cos (β + ψ) + σγ2 va2 sin γ cos γ cos (β + ψ) (36)
Σw (2, 2) = σẏ2 + σv2a cos2 γ sin2 (β + ψ) + σγ2 va2 sin2 γ sin2 (β + ψ)
+(σβ2 + σψ2 )va2 cos2 γ cos2 (β + ψ) (37)
Σw (2, 3) = −σv2a sin γ cos γ sin (β + ψ) + σγ2 va2 sin γ cos γ sin (β + ψ) (38)
Σw (3, 3) = σż2 + σv2a sin2 γ + σγ2 va2 cos2 γ (39)

6 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


The error covariance is symmetric, and off-diagonal terms represent correlation in the estimate error
between components of the estimated wind. Correlation between the vertical and horizontal components
(the 1,3 and 2,3 terms) can be removed by flying at γ = 0 (i.e. horizontal with respect to the surrounding
airmass). Note that this is only possible during powered flight or during an unsteady glide: a steady, trimmed
glide will always result in the aircraft descending in relation to the surrounding air mass. Correlation between
horizontal components is removed by flying at β + ψ = 0◦ , 90◦ , 180◦ , 270◦ .
A measure of total error in the wind estimate is the trace of the covariance matrix:
e2 = TrΣw
= σẋ2 + σẏ2 + σż2 + σv2a + σγ2 va2 + (σβ2 + σψ2 )va2 cos2 γ (40)
Assuming that the flight path angle γ is small, minimizing the total error implies flying at low airspeed.
Indeed, minimum error will result from flying at zero airspeed, i.e. using a neutrally buoyant balloon!
In practice the noise in the gps velocity measurements will be correlated, but this will not affect the
trace of the wind error covariance: it will add the gps error correlation terms to the off-diagonal elements
of Σw .
When the flight path angle is small, cos2 γ ≈ 1 and
e2 = σẋ2 + σẏ2 + σż2 + σv2a + va2 (σγ2 + σβ2 + σψ2 )
= σẋ2 + σẏ2 + σż2 + σv2a + va2 (σθ2 + σα2 + σβ2 + σψ2 ) (41)
Since γ = θ − α, σγ2
= + σθ2 σα2 .
For unaided gps the standard deviation of the velocity error is approximately 0.1 m/s. This can be
reduced with carrier phase differential gps to order mm/s. Assuming that airspeed can be measured to
an accuracy of 0.2 m/s (0.4 knot) and angles can be measured to an accuracy of 1◦ the unaided value of
estimation error is approximately e2 = 0.07 + 0.0012va2 . Under these conditions the angle-related errors equal
the speed-measurement errors when airspeed is 7.58 m/s, and the total expected error at this speed is 0.37
m/s. When airspeed is 16 m/s the expected error in computed wind speed is e = 0.61m/s. If carrier phase
differential gps is used (assuming velocity error is 5 mm/s) the expected error is e2 = 0.0401 + 0.0012va2 ,
leading to a predicted error of 0.59 m/s. This improvement is not significant: critical parameters in reducing
wind speed estimate errors are the noise in measurements of airspeed and angles and flying at low airspeed.

B. Rate of change of wind velocity estimation


The Jacobian of ẇ with respect to measurements and states is obtained from Equation 27:
 
1
1 0 0 0 −g cos θ − ∆t r −q 0 −w v
Hẇ =  0 1 0 g cos θ cos φ −g sin θ sin φ 1 (42)
r − ∆t −p −w 0 u 
 
1
0 0 1 −g cos θ sin φ −g sin θ cos φ −q p − ∆t v −u 0
The covariance of the expected error in the wind acceleration estimate is
Σẇ = Hẇ Σx HTẇ (43)
where (for uncorrelated measurement noise),
Σx = diag(σa2x σa2y σa2z σphi
2 2
σtheta σu2 σv2 σw
2
σp2 σq2 σr2 ) (44)
The square of the magnitude of the expected error is the trace of the covariance matrix:
e2ẇ = TrΣẇ
= σa2x + σa2y + σa2z + g 2 cos2 θσφ2 + g 2 σθ2
     
1 2 2 2 1 2 2 2 1 2 2 2
+ + r + q σu + + r + p σv + + p + q σw
∆t2 ∆t2 ∆t2
+ w2 + v 2 σp2 + w2 + u2 σq2 + u2 + v 2 σr2
  
(45)
A major contributor to error is the numerical differentiation of the airspeed measurements (reflected in
σ2
the (u,v,w)
∆t2 terms). The contribution of noise in angular rate measurements can be reduced by flying at low
airspeed. Noise in the pitch and bank angles result in uncertainty of the projection of gravity into the body
frame.

7 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


C. Smoothing/filtering the estimates
It is clear that estimates of wind speed and wind acceleration can be quite noisy. One approach to reducing
noise is a smoothing filter such as a moving average. Clearly filter length must be chosen carefully to reduce
noise without causing too much lag in the estimates. Hand tuning found that a ten step moving average
significantly reduced noise in the wind estimates without greatly affecting lag.

IV. Simulation and Discussion


To assess the effectiveness of the proposed approach both three and six degree of freedom simulations
were conducted. The aircraft model is a small autonomous glider flying at approximately 16 m/s. A state
feedback controller regulates states to maintain trimmed flight at best L/D. Note that the only control input
is elevator deflection. An on-board autopilot module is assumed to provide measurements of position and
Earth-relative velocity via gps and estimates of airspeed and orientation. Measurements of body angular
rates are provided by the autopilot module via its rate gyros. Assumed measurement noise and estimate
uncertainties are given in Table 1. The autopilot is assumed to provide this data at a rate of 50 Hz. Under
the conditions defined in Table 1 the expected error in wind velocity estimation at 16 m/s airspeed is 0.37
m/s for three degree of freedom simulations and 0.46 m/s for six degree of freedom simulations (Equation 41).

Table 1. Measurement noise and estimate uncertainties for simulations.

parameter source variable 1σ noise/uncertainty


position gps measurement via autopilot x, y, z 3m
orientation state estimate from autopilot φ, θ, ψ σφ = σψ = 0, σθ = 1◦
airspeed state estimate from autopilot u, v, w σu = 0.2 m/s, σv = σw = 0.05 m/s
ground speed gps measurement via autopilot ẋ, ẏ, ż 0.1 m/s
acceleration imu measurement via autopilot ax,b , ay,b , az,b 0.1 m/s2
angular rate imu measurement via autopilot p, q, r 0.1 rad/s

A. Gust field definition


Gust fields are modeled using a frozen Dryden turbulence model. Airmass motion is thus represented as a
sum of sinusoids:
N
X 
w(·) = w(·),0 + a(·),n sin Ω(·),n s + φ(·),n (46)
n=1

where (·) denotes a component (either u or w for longitudinal or vertical gusts, respectively) and s is motion
along the flight path. Random values of φ(·),n simulate the random process and the choice of coefficients
a(·),n defines the power spectral density. For a Dryden gust field the power spectral density is defined as

2Lu 1
Φu (Ω) = σu2 (47)
π 1 + (Lu Ω)2
2
2 Lw 1 + 3(Lw Ω)
Φw (Ω) = σw (48)
π (1 + (Lw Ω)2 )2

For low altitudes (below 1000 feet), the length scale of the vertical gust is Lw = h and the turbulence
intensity is σw = 0.1w20 , where w20 is the wind speed at 20 feet altitude. Horizontal gust length scale and
intensity are related to the vertical gust scale and intensity by
Lu 1
= (49)
Lw (0.177 + 0.000823h)1.2
σu 1
= (50)
σw (0.177 + 0.000823h)0.4

where h is in feet.

8 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


The amplitude of a sinusoid in Equation 46 is computed as18
p
an = ∆Ωn Φ(Ωn ) (51)

Note that a sinusoidal gust field is represented by setting N = 1 and defining the amplitude at the desired
frequency.

B. Dryden gust fields


Three degree of freedom simulations of flight through Dryden gust fields at an altitude of 50 meters and
w20 = 10 m/s were conducted to assess overall performance. A 500 run Monte Carlo simulation compares
the predicted error with the actual error. Each run consists of a sixty second flight through a Dryden gust
field, a new gust field was generated for each run.
Results of wind velocity estimation are shown in Figure 2. Detailed results of a single run (zoomed in
to show a single wavelength of the x-component of wind) are shown in subplot (a). The upper two plots
of Figure 2(a) show x and z components of wind field, estimated wind field, and smoothed estimated wind
field. The lower plot shows the 2-norm of the error along with the expected error. For this run the airspeed
varies by about 1.5m/s, not enough to have a significant influence on the estimation error. The green line
shows the effect of smoothing on the estimated wind speed.
Figure 2(b) shows overall results of the Monte Carlo simulation. Maximum error did not exceed 1.5 m/s,
with the mean error of 0.33 m/s closely matching the predicted mean error of 0.37 m/s. Smoothing using a
10 step moving average reduced the mean error to 0.22 m/s.
Results of wind acceleration estimation are shown in Figure 3. Detailed results of a single run (zoomed in
to show a single wavelength of the x-component of wind) are shown in subplot (a). The error in x-component
of wind acceleration is significantly larger than the z component. Expanding Equation 43, and assuming
longitudinal motion, the variance of the error in x and z components of wind acceleration are
1 2
Σẇ,xx = σa2x + g 2 σθ2 cos2 θ + σ + q 2 σw2
+ w2 σq2 (52)
∆t2 u
1 2
Σẇ,zz = σa2z + g 2 σθ2 sin2 θ + σ + q 2 σu2 + u2 σq2 (53)
∆t2 w
These simulations have defined σu four times larger that σw , hence the standard deviation of the error in x
acceleration estimates will be roughly four times larger than the w acceleration estimates.
Figure 3(b) shows the envelope of the 2-norm of the acceleration estimate error, the mean acceleration
error and the predicted acceleration error. The mean true error was 8.6 m/s2 , predicted error was 10.0 m/s2 .
Smoothing reduced error to 4.33 m/s2 at a cost of reducing the ability to follow changes in acceleration. An
improved model for airspeed measurements would greatly improve estimation of wind acceleration.

C. Sinusoidal gust fields


Six degree of freedom simulated flights through noisy sinusoidal gust fields were conducted for ease of
visualization of results and to assess the error in wind estimation.
Results of wind velocity estimation are shown in Figure 4. Detailed results of a single run are shown
in subplot (a). The upper three plots of Figure 4(a) show x, y, and z components of wind field, estimated
wind field, and smoothed estimated wind field. The lower plot shows the 2-norm of the error along with the
expected error. For this run the airspeed varies from 13.5 m/s to 19.5 m/s roughly in phase with increasing
headwind (negative values of wx ) and this is enough that the effect of airspeed on estimation error can be
seen. Increasing airspeed corresponds to increasing error in the estimated wind field, as predicted. The green
line shows the effect of smoothing on the estimated wind speed.
Figure 4(b) shows overall results of the Monte Carlo simulation. Maximum error did not exceed 1.5 m/s,
with the mean error of 0.45 m/s closely matching the predicted mean error of 0.46 m/s.
Results of wind acceleration estimation are shown in Figure 5. Detailed results of a single run are shown
in subplot (a). The upper three plots of Figure 5(a) show x, y, and z components of wind acceleration,
estimated wind acceleration, and smoothed estimated wind acceleration. The lower plot shows the 2-norm
of the error along with the expected error. Not surprisingly estimates of wind acceleration are very noisy
(due to the numerical differentiation of the airspeed measurement). Since the largest contributor to error is
the numerical differentiation, the expected error is essentially constant at 13.8 m/s2 .

9 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


2
estimate
1 smoothed
wx (m/s)

truth
0

ï1

ï2
2
estimate
1 smoothed
wz (m/s)

truth
0

ï1

ï2
1
0.8 estimate
norm2(error)

smoothed
0.6 expected
0.4
0.2
0
18
17
airspeed (m/s)

16
15
14
13
12
0 40 80 120 160 200
x (m)

(a) Detail of one run

2
max/min error
1.5
average error
error (m/s)

predicted error
1 smoothed estimate error

0.5

0
0 12 24 36 48 60
time (s)

(b) Monte Carlo simulation results

Figure 2. Wind velocity estimation for 3DOF Dryden wind field. Subplot (a): The top two plots show
components of the wind field (estimated in red, smoothed estimated in green, and truth in blue), the third
plot shows the 2-norm of the estimate error for a single run, and the bottom plot shows airspeed. Subplot
(b): Monte Carlo simulation of wind field estimation: 2-norm of error in velocity estimate. Maximum and
minimum errors shown by grey envelope, average error at each time step shown in blue, predicted error shown
in red, average smoothed error shown in green.

10 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


20
estimate
d(wx)/dt (m/s2)

10 smoothed
truth
0

ï10

ï20
20
estimate
d(wz)/dt (m/s2)

10 smoothed
truth
0

ï10

ï20
20
16 estimate
norm2(error)

smoothed
12 expected
8
4
0
0 40 80 120 160 200
x (m)

(a) Detail of one run

40
max/min error
30
error (m/s )

average error
2

predicted error
20 smoothed estimate error

10

0
0 12 24 36 48 60
time (s)

(b) Monte Carlo simulation results

Figure 3. Wind acceleration estimation for 3DOF Dryden wind field. Subplot (a): The top two plots show
components of the wind acceleration (estimated in red, smoothed estimated in green, and truth in blue), the
bottom plot shows the 2-norm of the estimate error for a single run. Subplot (b): Monte Carlo simulation of
wind acceleration estimation: 2-norm of error in velocity estimate. Maximum and minimum errors shown by
grey envelope, average error at each time step shown in blue, predicted error shown in red, average smoothed
error shown in green.

11 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


5
estimate
2.5 smoothed
wx (m/s)

truth
0

ï2.5

ï5
5
estimate
2.5 smoothed
wy (m/s)

truth
0

ï2.5

ï5
5
estimate
2.5 smoothed
wz (m/s)

truth
0

ï2.5

ï5
1.5 20
estimate

airspeed (m/s)
18
norm2(error)

1 smoothed
expected 16
airspeed 14
0.5
12
0 10
0 200 400 600 800 1000 1200
x (m)

(a) detail

2
max/min error
1.5
error (m/s)

average error
predicted error
1

0.5

0
0 15 30 45 60 75
time (s)

(b) Monte Carlo simulations

Figure 4. 6DOF wind velocity estimation for noisy sinusoidal wind field. Plot (a): The top three plots show
components of the wind field, the bottom plot shows the 2-norm of the estimate error. Plot (b): Monte Carlo
simulation of wind field estimation: 2-norm of error in velocity estimate. Maximum and minimum errors
shown by grey envelope, average error at each time step shown in blue, predicted error shown in green.

12 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


50
estimate
25 smoothed
d(wx)/dt

truth
0

ï25

ï50
20
estimate
10 smoothed
d(wy)/dt

truth
0

ï10

ï20
20
estimate
10 smoothed
d(wz)/dt

truth
0

ï10

ï20
50 20
estimate

airspeed (m/s)
40 18
norm2(error)

smoothed
30 expected 16
20 airspeed 14
10 12
0 10
0 200 400 600 800 1000 1200
x (m)

(a) detail

40
max/min error
30
error (m/s2)

average error
predicted error
20

10

0
0 15 30 45 60 75
time (s)

(b) Monte Carlo simulations

Figure 5. 6DOF wind acceleration estimation for noisy sinusoidal wind field. Plot (a): The top three plots
show components of the wind field, the bottom plot shows the 2-norm of the estimate error. Plot (b): Monte
Carlo simulation of wind field estimation: 2-norm of error in acceleration estimate. Maximum and minimum
errors shown by grey envelope, average error at each time step shown in blue, predicted error shown in green.

13 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


Figure 5(b) shows overall results of a Monte Carlo simulation. For the Monte Carlo simulation the time
step was set to 0.02s, double the value for the detailed plot. The mean error is therefor half the value of the
error in the detailed plot. The predicted mean error and the true mean error match very closely.

V. Wind estimation and energy harvesting


Since earlier research has shown that energy harvesting from gusts is feasible when wind is known,
an important question is the feasibility of of energy harvesting when wind is not known. Simulations of
longitudinal energy harvesting using a slight modification of a previously developed gust soaring control
architecture along with the wind estimation algorithm presented here are discussed.
This architecture is shown in Figure 6. In brief, measurements of airspeed, GPS velocity, orientation,
acceleration and angular rate are used to estimate the wind field. The components of wind speed are used
to compute a state which maximizes the change in energy per unit of distance travelled, and a closed-loop
controller attempts to follow these state commands. Here the closed-loop control law is computed using
LQR synthesis, with vehicle dynamics linearized about steady trimmed flight at best L/D.19

autopilot
module
surrounding
air mass
orientation
air data
GPS

__
w , dw
dt

^
w x
wind energy harvesting aircraft
^
__ xopt K u
estimation dw state computation
dt

Figure 6. Atmospheric energy harvesting system using estimates of wind.

There is an important difference in the speed computation used here and that described earlier: wind
gradients are not included in the computation of speed to fly. A brief investigation (not discussed here)
showed that including wind gradients in the energy harvesting state computation for gust fields involving
longitudinal as well as vertical gusts did not provide as large a performance gain as it did in fields involving
only vertical gusts (even when winds were assumed known). This may be due to an incorrect choice of weight
matrices Q and R in the LQR synthesis (matrices computed in earlier work for vertical-only gusts were used
here, rather than computing new values including the effects of longitudinal gusts19 ). However, this requires
further investigation.
The vehicle considered is the RnR Products SB-XC, a 4.3m wingspan aircraft. Parameters are given in
Table 3 and control saturation and state limits are given in Table 4. The controller gain used for all cases
was19 h i
K = 1.0106 −0.0277 5.8082 0.5847 (54)

Simulation results flights through four turbulence conditions are presented: low altitude, light turbulence;
low altitude, moderate turbulence; medium altitude, light turbulence; finally medium altitude, moderate
turbulence. Properties of the gust fields are defined by MIL-F-8785C and are summarized in Table 2. Note
that medium altitude gust fields are isotropic, while at low altitude (below 1000 feet) both gust intensity
and the fundamental length depends on direction. For each case a Monte Carlo simulation of 50 runs was
performed to assess flight performance using four controllers: (1) constant airspeed flight controller; (2) the

14 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


gust energy harvesting controller assuming known wind conditions; (3) the gust energy harvesting controller
using estimated wind conditions; (4) finally the gust energy harvesting controller using smoothed estimates.
The constant speed flight controller uses the same gain matrix computed for gust energy harvesting, however
rather than attempting to follow state commands for optimal energy harvesting it tracks the state which
defines a trimmed glide at best L/D in still air (va = 15.8 m/s, θ = 0.7◦ , α = 2.8◦ ).
Each run consisted of 8 minutes simulated flight through the gust field, resulting in approximately 7600m
distance flown for each run. A new random gust field was generated for each of the 50 runs.

Table 2. Gust field properties.

description altitude Lu Lw σu σw
(m) (m) (m) (m/s) (m/s)
low altitude, light turbulence 50 200 50 1.06 0.7
low altitude, moderate turbulence 50 200 50 2.12 1.4
medium altitude, light turbulence 600 533 533 1.5 1.5
medium altitude, moderate turbulence 600 533 533 3.0 3.0

Results of all cases are summarized in Figure 7. Subfigure (a) shows maximum, minimum, mean, and
1σ values of ∆e∆x (i.e. change in total energy over distance flown) for each control case over the 50 runs in
tot

each turbulence case. The lower plot of Subfigure 7(a) shows the average (over all runs) of the root mean
square elevator deflection for each controller (a measure of the amount of control required).
The difference in energy harvesting using known versus estimated wind is slight (the plots lie essentially
on top of each other). Steadily increasing improvement over the baseline (constant speed) case is visible. In
fact the medium altitude cases show that many of the gust fields actually result in net energy gain.
However, a clear difference is visible in the root mean square elevator deflection, with the use of wind
estimates greatly increasing required control (Figure 7(a), lower plot). Using smoothed wind estimates
reduces root mean square elevator deflection to the level observed for energy harvesting using known wind;
however it does not significantly reduce the energy harvested.

0.15 0.12
base
known wind
0.1 known wind estimated wind
estimated wind 0.1 smoothed estimates medium/moderate
0.05
smoothed estimates
6 e/6 x

0
0.08

ï0.05
6(6 e/6 x)

low/light
low/moderate 0.06
ï0.1 medium/light
medium/moderate
ï0.15
0.04 medium/light
10
rms be (deg)

8
6 0.02 low/moderate
4
low/light
2
0 0
altitude/turbulence conditions altitude/turbulence conditions

(a) energy change and control effort (b) improvement in energy change over baseline

Figure 7. Summary of energy harvesting using estimated winds for all turbulence conditions. Subplot (a)
shows energy change per distance flown for each case and control effort; subplot (b) shows the improvement
in flight performance over the baseline (constant speed) controller. The bars show minimum, maximum and
1σ, the dots show mean values (over the 50 runs in each Monte Carlo simulation). The dotted black line in
de
the upper plot of subfigure (a) shows dx for a steady glide at best L/D in still air.

15 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


The difference in energy change between the energy harvesting controller and a constant airspeed con-
troller is showing in Figure 7(b). The gust energy harvesting controller shows better performance for all
runs, with the level of improvement increasing as the turbulence intensity increases.
Detailed results for each turbulence condition are shown in Figures 8 through 11.
A general conclusion is that the constant speed controller flies too slowly in regions of unfavorable
wind (downwards or headwind) and too fast in regions of favorable wind (upwards or tailwind). Thus too
much time is spent in unfavorable conditions and not enough time is spent in favorable conditions. This is
magnified in the medium altitude cases, where the length scale of turbulence is larger. Second, significantly
more elevator deflection is required at lower altitudes for all controllers. This is most likely due to the shorter
scales of turbulence.

VI. Conclusion
A method for estimating dynamic three dimensional wind fields using a sensor suite typical of small
unmanned aerial vehicles has been presented. Analysis of the predicted error shows that the error in wind
velocity estimates is dependent on vehicle airspeed and the error in wind acceleration is due in large part to
noise in measurements of airspeed. Results of Monte Carlo simulations agree very closely with the predicted
errors.
Simulations using realistic levels of noise and uncertainty show that wind velocity can be estimated
to an accuracy of better than 0.5 m/s. Since the earth-relative velocity of the vehicle can be measured
quite accurately using gps, the key to reducing this error further is increasing the accuracy of airspeed
measurements and increasing the accuracy of vehicle orientation measurements.
Simulations combining this wind field estimation algorithm with a gust energy harvesting controller
showed that efficient energy harvesting is still possible. The cost of using wind estimates lies in significantly
increased control actuation, but this can be greatly reduced by smoothing the estimates using a moving
average filter. This smoothing filter reduced control actuation to the level observed for flight through a
priori known wind fields without significant effect on energy harvesting.

Acknowledgments
This research was funded by the Office of Naval Research under Contract Number N00014-09-M-0307.
The authors also thank Dan Kuehme for assistance in running simulations.

References
1 Rayleigh, J. W. S., “The Soaring of Birds,” Nature, Vol. 27, 1883, pp. 534–535.
2 Rayleigh, J. W. S., “The Sailing Flight of the Albatross,” Nature, Vol. 40, 1889, pp. 34.
3 Pennycuick, C. J., “Gust Soaring as a Basis for the Flight of Petrels and Albatrosses (Procellariiformes),” Avian Science,

Vol. 2, No. 1, 2002, pp. 1–12.


4 Sachs, G., “Minimum Shear Wind Strength Required for Dynamic Soaring of Albatrosses,” Ibis, Vol. 147, 2005, pp. 1–10.
5 Lissaman, P. B. S. and Patel, C. K., “Neutral Energy Cycles for a Vehicle in Sinusoidal and Turbulent Vertical Gusts,” 45th

AIAA Aerospace Sciences Meeting and Exhibit, AIAA Paper 2007-863, American Institute of Aeronautics and Astronautics,
Reno, Nevada, January 2007.
6 Qi, Y. C. and Zhao, Y. J., “Energy-Efficient Trajectories of Unmanned Aerial Vehicles Flying Through Thermals,”

Journal of Aerospace Engineering, Vol. 18, No. 2, April 2005, pp. 84–92.
7 Langelaan, J. W. and Bramesfeld, G., “Gust Energy Extraction for Mini- and Micro- Uninhabited Aerial Vehicles,” 46th

AIAA Aerospace Sciences Meeting and Exhibit, AIAA Paper 2008-0223, American Institute of Aeronautics and Astronautics,
Reston, Virginia, January 2008.
8 Patel, C. K., Energy Extraction from Atmospheric Turbulence to Improve Aircraft Performance, VDM Verlag Dr. Müller,

Saarbrüken, 2008.
9 Watkins, S., Milbank, J., and Loxton, B. J., “Atmospheric Winds and the Implications for Microair Vehicles,” AIAA

Journal, Vol. 44, No. 11, November 2006, pp. 2591–2600.


10 Pachter, M., Ceccarelli, N., and Chandler, P. R., “Estimating MAV’s Heading and the Wind Speed and Direction using

GPS, Inertial and Air Speed Measurements,” AIAA Guidance, Navigation and Control Conference, AIAA Paper 2008-6311,
American Institute of Aeronautics and Astronautics, Reston, Virginia, August 2008.
11 Rodriguez, A. F., Andersen, E., Bradley, J. F., and Taylor, C. N., “Wind Estimation using an Optical Flow Sensor on a

Miniature Air Vehicle,” AIAA Guidance, Navigation and Control Conference, AIAA Paper 2007-6614, American Institute of
Aeronautics and Astronautics, Reston, Virginia, August 2007.
12 Myschik, S., Heller, M., Holzapfel, F., and Sachs, G., “Low-cost Wind Measurement System for Small Aircraft,” AIAA

16 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


Guidance, Navigation and Control Conference, AIAA Paper 2004-5240, American Institute of Aeronautics and Astronautics,
Reston, Virginia, August 2004.
13 Myschik, S. and Sachs, G., “Flight Testing an Integrated Wind/Airdata and Navigation System for General Aviation

Aircraft,” AIAA Guidance, Navigation and Control Conference, AIAA Paper 2007-6796, American Institute of Aeronautics
and Astronautics, Reston, Virginia, August 2007.
14 de Divitiis, N., “Wind Estimation on a Lightweight Vertical Takeoff and Landing Uninhabited Vehicle,” Journal of

Aircraft, Vol. 40, No. 4, July-August 2003, pp. 759–767.


15 Military Specification, “Flying Qualities of Piloted Airplanes,” Tech. Rep. MIL-F-8785C, November 1980.
16 Etkin, B. and Reid, L. D., Dynamics of Flight: Stability and Control, John Wiley & Sons, New York, 3rd ed., 1996.
17 Misra, P. and Enge, P., Global Positioning System: Signals, Measurements and Performance, Ganga-Jamuna Press,

Lincoln, Massachusetts, 2nd ed., 2006.


18 Hoblit, F. M., Gust Loads on Aircraft: Concepts and Applications, AIAA Education Series, American Institute of

Aeronautics and Astronautics, Reston, Virginia, 1988.


19 Langelaan, J. W., “Gust Energy Extraction for Mini- and Micro- Uninhabited Aerial Vehicles,” Journal of Guidance,

Control and Dynamics, Vol. 32, No. 2, March-April 2009, pp. 464–473.

Appendix: Vehicle Properties

Table 3. Parameters for SB-XC glider.

variable value description


m 10 kg mass
b 4.34 m span
c 0.232 m MAC
S 1 m2 wing area
Iyy 1.87 kg.m2 pitch moment of inertia
CL0 0.37
CLα 5.54 /rad
CLQ -3.255 s/rad
CLα̇ -0.651 s/rad
CLδe -0.37 /rad
CLδf 1.63 /rad
fLD (ϕ) 0.1723ϕ4 − 0.3161ϕ3 + 0.2397ϕ2 ϕ = CL0 + CLα α
−0.0624ϕ + 0.0194
CDδe 0 /rad
CDδf 0.042 /rad
Cm0 0
Cmα -1.02 /rad
CmQ -14.6 s/rad
Cmδe 1.6275 /rad
Cmδf -0.254 /rad

Table 4. State limits and control saturation for SB-XC glider.

state/control range description


θ [−45◦ 45◦ ] pitch
va [11m/s 35m/s] airspeed
α [−2◦ 12◦ ] angle of attack
Q [−999 999] pitch rate
δe [−20◦ 20◦ ] elevator deflection

17 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


7.5

wind speed (m/s)


5
2.5
0
wz
ï2.5
wx
ï5
ï7.5
ï200
ï100
0
z (m)

base
100
known wind
200 estimated wind
300 smoothed estimates
400
200
100
0
etot (m)

ï100
ï200
ï300
ï400
35
x (m)
30
va (m/s)

25
20
15
10
20
15
10
be (deg)

5
0
ï5
ï10
ï15
ï20
0 1000 2000 3000 4000 5000 6000 7000 8000
x (m)

(a) Single run detail

0
ï50
ï100
etot (m)

ï150 base
ï200 known wind
ï250 estimated wind
ï300 smoothed estimates
ï350
0 1000 2000 3000 4000 5000 6000 7000 8000
distance (m)

(b) Mean total energy

Figure 8. Performance comparison for flight through Dryden turbulence, low altitude, light intensity. Baseline
(constant airspeed) control shown in red; energy harvesting control with known wind shown in green; energy
harvesting control with estimated wind shown in blue; energy harvesting control using smoothed estimates
shown in magenta. Subplot (a): upper plot shows true wind field (ix in red, iz in blue); second plot shows
flight path; third shows total energy; fourth shows airspeed; fifth (bottom) shows elevator deflection; Subplot
(b): mean value of total energy vs. distance over all runs. The dotted black line shows total energy change
versus distance for a steady glide in zero wind.

18 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


7.5

wind speed (m/s)


5
2.5
0
wz
ï2.5
wx
ï5
ï7.5
ï200
ï100
0
z (m)

base
100
known wind
200 estimated wind
300 smoothed estimates
400
200
100
0
etot (m)

ï100
ï200
ï300
ï400
35
x (m)
30
va (m/s)

25
20
15
10
20
15
10
be (deg)

5
0
ï5
ï10
ï15
ï20
0 1000 2000 3000 4000 5000 6000 7000 8000
x (m)

(a) Single run detail

0
ï50
ï100
etot (m)

ï150 base
ï200 known wind
ï250 estimated wind
ï300 smoothed estimates
ï350
0 1000 2000 3000 4000 5000 6000 7000 8000
distance (m)

(b) Mean total energy

Figure 9. Performance comparison for flight through Dryden turbulence, low altitude, moderate intensity.
Baseline (constant airspeed) control shown in red; energy harvesting control with known wind shown in green;
energy harvesting control with estimated wind shown in blue; energy harvesting control using smoothed
estimates shown in magenta. Subplot (a): upper plot shows true wind field (ix in red, iz in blue); second plot
shows flight path; third shows total energy; fourth shows airspeed; fifth (bottom) shows elevator deflection;
Subplot (b): mean value of total energy vs. distance over all runs. The dotted black line shows total energy
change versus distance for a steady glide in zero wind.

19 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


7.5

wind speed (m/s)


5
2.5
0
wz
ï2.5
wx
ï5
ï7.5
ï200
ï100
0
z (m)

base
100
known wind
200 estimated wind
300 smoothed estimates
400
200
100
0
etot (m)

ï100
ï200
ï300
ï400
35
x (m)
30
va (m/s)

25
20
15
10
20
15
10
be (deg)

5
0
ï5
ï10
ï15
ï20
0 1000 2000 3000 4000 5000 6000 7000 8000
x (m)

(a) Single run detail

0
ï50
ï100
etot (m)

ï150 base
ï200 known wind
ï250 estimated wind
ï300 smoothed estimates
ï350
0 1000 2000 3000 4000 5000 6000 7000 8000
distance (m)

(b) Mean total energy

Figure 10. Performance comparison for flight through Dryden turbulence, medium altitude, light intensity.
Baseline (constant airspeed) control shown in red; energy harvesting control with known wind shown in green;
energy harvesting control with estimated wind shown in blue; energy harvesting control using smoothed
estimates shown in magenta. Subplot (a): upper plot shows true wind field (ix in red, iz in blue); second plot
shows flight path; third shows total energy; fourth shows airspeed; fifth (bottom) shows elevator deflection;
Subplot (b): mean value of total energy vs. distance over all runs. The dotted black line shows total energy
change versus distance for a steady glide in zero wind.

20 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177


7.5

wind speed (m/s)


5
2.5
0
wz
ï2.5
wx
ï5
ï7.5
ï200
ï100
0
z (m)

base
100
known wind
200 estimated wind
300 smoothed estimates
400
200
100
0
etot (m)

ï100
ï200
ï300
ï400
35
x (m)
30
va (m/s)

25
20
15
10
20
15
10
be (deg)

5
0
ï5
ï10
ï15
ï20
0 1000 2000 3000 4000 5000 6000 7000 8000
x (m)

(a) Single run detail

0
ï50
ï100
etot (m)

ï150 base
ï200 known wind
ï250 estimated wind
ï300 smoothed estimates
ï350
0 1000 2000 3000 4000 5000 6000 7000 8000
distance (m)

(b) Mean total energy

Figure 11. Performance comparison for flight through Dryden turbulence, medium altitude, moderate inten-
sity. Baseline (constant airspeed) control shown in red; energy harvesting control with known wind shown in
green; energy harvesting control with estimated wind shown in blue; energy harvesting control using smoothed
estimates shown in magenta. Subplot (a): upper plot shows true wind field (ix in red, iz in blue); second plot
shows flight path; third shows total energy; fourth shows airspeed; fifth (bottom) shows elevator deflection;
Subplot (b): mean value of total energy vs. distance over all runs. The dotted black line shows total energy
change versus distance for a steady glide in zero wind.

21 of 21

American Institute of Aeronautics and Astronautics Paper 2010-8177

You might also like

pFad - Phonifier reborn

Pfad - The Proxy pFad of © 2024 Garber Painting. All rights reserved.

Note: This service is not intended for secure transactions such as banking, social media, email, or purchasing. Use at your own risk. We assume no liability whatsoever for broken pages.


Alternative Proxies:

Alternative Proxy

pFad Proxy

pFad v3 Proxy

pFad v4 Proxy