Chapter 3 PDF
Chapter 3 PDF
Chapter 3 PDF
1. d = vt
2
r + r0 = d + 2hd
Equivalent low-pass channel impulse response is given by
Tm = max τm − τc
m
Z Z Z2π Zz
1 −(x2 +y)2 1 −r2 −z 2
Fz (z)= P [x2 +y 2 ≤ z 2 ] = e 2σ 2 dxdy = e rdrdθ = 1 − e 2σ 2 (z ≥ 0)
2πσ 2 2πσ 2 2σ 2
x2 +y 2 ≤z 2 0 0
df z (z) z − z22
= 2 e 2σ → Rayleigh
dz σ
For Power:
√ −z 2
Fz 2 (z)=P [Z ≤
z] = 1 − e 2
2σ
1 −z
fz (z)= 2 e 2 → Exponential
2σ 2σ
6. For Rayleigh fading channel
2
P r(Pr < P0 ) = 1 − e−P0 /2σ
2σ 2 = −80dBm, P0 = −95dBm, P r(Pr < P0 ) = 0.0311
2σ 2 = −80dBm, P0 = −90dBm, P r(Pr < P0 ) = 0.0952
8. 2σ 2 = -80dBm = 10−11
Target Power P0 = -80 dBm = 10−11
Avg. power in LOS component = s2 = -80dBm = 10−11
10−5
P r[z 2 ≤ 10−11 ] = P r[z ≤ √ ]
10
10 −5
Let z0 = √
10
Z z0 −(z 2 +s2 ) ³ zs ´
z −
2σ 2
= e I0 dz, z≥0
0 σ2 σ2
= 0.3457
To evaluate this, we use Matlab and I0 (x) = besseli(0,x). Sample Code is given:
For the Nakagami-m approximation to Ricean distribution, we set the Nakagami m parameter to be
(K + 1)2 /(2K + 1). CDF of Nakagami-m distribution is
Z z
Nakagami-m
FZ (z) = pNakagami-m
Z (z)
0
where · ¸
2mm z 2m−1 −mz 2
pNakagami-m
Z (z) = exp , z ≥ 0, m ≥ 0.5
Γ(m)P rm Pr
We need to plot the two CDF curves for K = 1,5,10 and P r =1 (we can choose any value for Pr as it
is the same for both the distributions and our aim is to compare them). Sample code is given:
As seen from the curves, the Nakagami-m approximation becomes better as K increases. Also, for a
fixed value of K and x, prob(γ<x) for x large is always greater for the Ricean distribution. This is seen
from the tail behavior of the two distributions in their pdf, where the tail of Nakagami-distribution is
always above the Ricean distribution.
10. (a) W = average received power
Zi = Shadowing over link i
Pr i = Received power in dBW, which is Gaussian with mean W, variance σ 2
(b)
Poutage = P [Pr,1 < T ∩ Pr,2 < T ] = P [Pr,1 < T ] P [Pr,2 < T ] since Z1 , Z2 independent
· µ ¶¸2 · µ ¶¸2
W −T 4
= Q = Q
σ σ
(c)
Z∞
Pout = P [Pr,1 ≤ T , Pr,2 < T |Y = y] fy (y) dy
−∞
¡ ¢
Pr,1 |Y = y ~ N W + by,a2 σ 2 , and [Pr,1 |Y = y] ⊥ [Pr,2 |Y = y]
Z∞ · µ ¶¸2
W + by − T 1 y2
Poutage= Q √ e− 2σ2 dy
aσ 2πσ
−∞
K=5 K = 10
1 1 1
Ricean Ricean
Nakagami−m Nakagami−m
0.9 0.9 0.9
Ricean
0.6 Nakagami −m 0.6 0.6
0 0 0
0 0.5 1 1.5 2 2.5 3 0 0.5 1 1.5 2 2.5 3 0 0.5 1 1.5 2 2.5 3
K=1 K=5 K = 10
1 1.5 2
Ricean
Nakagami−m
0.9 1.8
Ricean
0.8 Nakagami−m 1.6
Ricean
0.7 1.4
Nakagami − m
1
0.6 1.2
0.5 1
0.4 0.8
0.5
0.3 0.6
0.2 0.4
0.1 0.2
0 0 0
0 0.5 1 1.5 2 2.5 3 0 0.5 1 1.5 2 2.5 3 0 0.5 1 1.5 2 2.5 3
−31 K = 10
x 10
2
1.8
1.6
1.4
Ricean
1.2 Nakagami−m
0.8
0.6
0.4
0.2
0
3.5 4 4.5 5 5.5 6
Tail Behavior
Figure 1: The CDF and PDF for K = 1, 5, 10 and the Tail Behavior
y
let σ= u
Z∞ · µ ¶¸ Z∞ · µ ¶¸
1 W − T + buσ 2 −u2 1 4 + byσ 2 −y 2
= √ Q e 2 du = √ Q e dy
2π aσ 2π aσ 2
−∞ −∞
11. There are many acceptable techniques for this problem. Sample code for both the stochastic tech-
nique(preferred) and the Jake’s technique are included.
Jakes: Summing of appropriate sine waves
%Jake’s Method
close all; clear all;
%choose N=30
N=30; M=0.5*(N/2-1); Wn(M)=0; beta(M)=0;
%We choose 1000 samples/sec
ritemp(M,2001)=0; rqtemp(M,2001)=0; rialpha(1,2001)=0; fm=[1 10
100]; Wm=2*pi*fm; for i=1:3
for n=1:1:M
for t=0:0.001:2
%Wn(i)=Wm*cos(2*pi*i/N)
Wn(n)=Wm(i)*cos(2*pi*n/N);
%beta(i)=pi*i/M
beta(n)=pi*n/M;
%ritemp(i,20001)=2*cos(beta(i))*cos(Wn(i)*t)
%rqtemp(i,20001)=2*sin(beta(i))*cos(Wn(i)*t)
ritemp(n,1000*t+1)=2*cos(beta(n))*cos(Wn(n)*t);
rqtemp(n,1000*t+1)=2*sin(beta(n))*cos(Wn(n)*t);
%Because we choose alpha=0,we get sin(alpha)=0 and cos(alpha)=1
%rialpha=(cos(Wm*t)/sqrt(2))*2*cos(alpha)=2*cos(Wm*t)/sqrt(2)
%rqalpha=(cos(Wm*t)/sqrt(2))*2*sin(alpha)=0
rialpha(1,1000*t+1)=2*cos(Wm(i)*t)/sqrt(2);
end
end
%summarize ritemp(i) and rialpha
ri=sum(ritemp)+rialpha;
%summarize rqtemp(i)
rq=sum(rqtemp);
%r=sqrt(ri^2+rq^2)
r=sqrt(ri.^2+rq.^2);
%find the envelope average
mean=sum(r)/2001;
subplot(3,1,i);
time=0:0.001:2;
%plot the figure and shift the envelope average to 0dB
plot(time,(10*log10(r)-10*log10(mean)));
titlename=[’fd = ’ int2str(fm(i)) ’ Hz’];
title(titlename);
xlabel(’time(second)’);
ylabel(’Envelope(dB)’);
end
fd = 1 Hz
5
Envelope(dB)
−5
−10
0 0.2 0.4 0.6 0.8 1 1.2 1.4 1.6 1.8 2
fd = 10 Hz
10
Envelope(dB)
−10
−20
0 0.2 0.4 0.6 0.8 1 1.2 1.4 1.6 1.8 2
fd = 100 Hz
10
Envelope(dB)
−10
−20
0 0.2 0.4 0.6 0.8 1 1.2 1.4 1.6 1.8 2
Figure 2: Problem 11
Stochastic: Usually two guassian R.V.’s are filtered by the Doppler Spectrum and summed. Can also
just do a Rayleigh distribution with an adequate LPF, although the above technique is prefered.
% Required parameters
if f_s < 1000;
f_s = 1000; % [Hz] Minumum required sampling rate
end;
N = ceil( t*f_s ); % Number of samples
if mod( N, 2) == 1
N = N+1; % Use even number of samples in calculation
end;
f = linspace(-f_s,f_s,N); % [Hz] Frequency samples used in calculation
% Quadrature :
Gfq_p = randn(2,N/2); CGfq_p = Gfq_p(1,:)+i*Gfq_p(2,:); CGfq = [
conj(fliplr(CGfq_p)) CGfq_p ];
% Generate fading spectrum, this is used to shape the Gaussian line spectra
omega_p = 1; % this makes sure that the average received envelop can be 0dB
S_r = omega_p/4/pi./(f_D*sqrt(1-(f/f_D).^2));
% Take care of samples outside the Doppler frequency range, let them be 0
idx1 = find(f>=f_D); idx2 = find(f<=-f_D); S_r(idx1) = 0;
S_r(idx2) = 0; S_r(idx1(1)) = S_r(idx1(1)-1);
S_r(idx2(length(idx2))) = S_r(idx2(length(idx2))+1);
−10
−20
−30
0 0.2 0.4 0.6 0.8 1 1.2 1.4 1.6 1.8 2
10Hz
10
−10
−20
−30
0 0.2 0.4 0.6 0.8 1 1.2 1.4 1.6 1.8 2
l00 Hz
20
−20
−40
−60
0 0.2 0.4 0.6 0.8 1 1.2 1.4 1.6 1.8 2
Figure 3: Problem 11
12. Pr = 30dBm
fD = 10Hz
2
eρ − 1
P0 = 0dBm, tz = √ = 0.0013s
ρfD 2π
P0 = 15dBm, tz = 0.0072s
P0 = 25dBm, tz = 0.0264s
13. In the reader, we found the level crossing rate below a level by taking an average of the number of
times the level was crossed over a large period of time. It is easy to convince that the level crossing
rate above a level will have the same expression as eq. 3.44 in reader because to go below a level again,
we first need to go above it. There will be some discrepancy at the end points, but for a large enough
T it will not effect the result. So we have
√ 2
LZ (above) = LZ (below) = 2πfD ρe−ρ
And,
p(z > Z)
tZ (above) =
LZ (above)
2 2
p(z > Z) = 1 − p(z ≤ Z) = 1 − (1 − e−ρ ) = e−ρ
1
tZ (above) = √
2πfD ρ
The values of tZ (above) for fD = 10,50,80 Hz are 0.0224s, 0.0045s, 0.0028s respectively. Notice that as
fD increases, tZ (above) reduces.
MATLAB CODE:
N = [0 19.85 57.38 82.19 73.77 15.09 .03 0];
T = 10e-3;
for i = 1:8
if i == 1
p(i,1) = 0;
p(i,2) = (N(i+1)*T)/Pi(i);
p(i,3) = 1-(p(i,1)+p(i,2));
elseif i == 8
p(i,1) = (N(i)*T)/Pi(i);
p(i,2) = 0;
p(i,3) = 1-(p(i,1)+p(i,2));
else
p(i,1) = (N(i)*T)/Pi(i);
p(i,2) = (N(i+1)*T)/Pi(i);
p(i,3) = 1-(p(i,1)+p(i,2));
end
end
% p =
%
% 0 0.0199 0.9801
% 0.0023 0.0068 0.9909
% 0.0033 0.0047 0.9921
% 0.0023 0.0020 0.9957
% 0.0023 0.0005 0.9973
% 0.0036 0.0000 0.9964
% 0.0066 0 0.9934
% 0 0 1.0000
15. (a)
α1 δ(τ ) ρ = 70Hz
S(τ, ρ) = α2 δ(τ − 0.022µsec) ρ = 49.5Hz
0 else
The antenna setup is shown in Fig. 15
From the figure, the distance travelled by the LOS ray is d and the distance travelled by the first
multipath component is sµ ¶
d 2
2 + 64
2
Given this setup, we can plot the arrival of the LOS ray and the multipath ray that bounces off
the ground on a time axis as shown in Fig. 15
So we have sµ ¶
d 2
2 + 82 − d = 0.022 × 10−6 3 × 108
2
µ 2 ¶
d
⇒4 + 82 = 6.62 + d2 + 2d(6.6)
4
⇒ d = 16.1m
fD = v cos(θ)/λ. v = fD λ/ cos(θ). For the LOS ray, θ = 0 and for the multipath component,
θ = 45o . We can use either of these rays and the corresponding fD value to get v = 23.33m/s.
(b)
4ht hr
dc =
λ
dc = 768 m. Since d ¿ dc , power fall-off is proportional to d−2 .
(c) Tm = 0.022µs, B −1 = 0.33µs. Since Tm ¿ B −1 , we have flat fading.
d meters
0.022 us
0 t0 t1 t
t0 = (d/3e8)
t1 = 2 sqrt[(d/2)^2+8^2]/3e8
R
∞
τ Ac (τ )dτ
0
(c) Avg Delay Spread = R
∞ = 5µsec
Ac (τ )dτ
v 0
u∞
u R (τ −µT m )2 Ac (τ )dτ
u
RMS Delay Spread = t 0 ∞ R = 2.89µsec
Ac (τ )dτ
0
W
Doppler Spread = 2 = 50 Hz
1
(d) βu > Coherence BW ⇒ Freq. Selective Fading ≈ Tm = 105 ⇒ βu > = 105 kHz
Can also use µT m or σT m instead of Tm
(e) Rayleigh fading, since receiver power is evenly distributed relative to delay; no dominant LOS
path
2
eρ √
−1 W
(f) tR = ρFD 2π
with ρ = 1, fD = 2 → tr = .0137 sec
(g) Notice that the fade duration never becomes more than twice the average. So, if we choose our
data rate such that a single symbol spans the average fade duration, in the worst case two symbols
will span the fade duration. So our code can correct for the lost symbols and we will have error-free
transmission. So t1R = 72.94 symbols/sec
10 us
tau