DWC-USRP - LectureNotes PDF
DWC-USRP - LectureNotes PDF
DWC-USRP - LectureNotes PDF
1
Figure 1: The components of a typical digital communication system.
2
• Decryption: purpose is to remove encryption to make the transmitted signal readable.
• Channel code : basic idea is to add redundancy to correct channel errors (i.e., use error correction
or error detection)
− May perform error correction, e.g., a repetition code
− May perform error detection, e.g., a CRC (cyclic redundancy check)
− Code rate = ##ofofuncoded bits
coded bits
− Types of forward error correction (FEC) also known as error control codes (ECC)
1. Block code (developed in the 50’s) - encode a block of bits to produce another block.
For example a R = 1/2 block code takes 5 bits in and produces 10 bits out. Block
codes are good for burst errors. Example is Reed-Solomon code used in DSL.
2. Convolutional code (developed 60’s - 70’s) - convolve data with multiple finite impulse
response (FIR) filters in the binary field and interleave the results. Note that convolu-
tional codes are good for random but not burst errors. Used in GSM, IEEE 802.11g,
IEEE 802.16, etc. Typically combined with interleaving. Puncturing used to control
the rate.
· Example (5, 7) rate 1/2 code
3
− The mapping from bits to waveforms may be linear or nonlinear.
− It can be memoryless or with memory.
− Modulator often consists of the following
bits → symbol mapping → constellation mapping → pulse shaping filter → D/A → m(t)
− Symbol mapping: Bits are grouped into symbols e.g.) |{z}
01 |{z} 10 11 · · ·
11 |{z}
s1 s2 s3
− Constellation mapping: Symbols are mapped to points in constellation C = {c1 , c2 , ..., cN }
Cardinality |C| = 2k = N , k → # of bits/symbol
e.g.) QPSK constellation : C = { √12 (±1, ±j)}
0 → +1
e.g.) PAM : BPSK or 2-PAM. Hence, C = {+1,1 } (constellation)
1 → −1
Tx 0
Mod (1, 1, 1)
Rx (1, 0.5, −0.5)
By soft decision, the decision is done by comparing “distance” between Rx symbol &
(+1, +1, +1), (−1, −1, −1).
Demod:
d2 (Rx, (+1, +1, +1)) = 02 + (1/2)2 + (3/2)2 = 2.5,
d2 (Rx, (−1, −1, −1)) = 22 + (3/2)2 + (1/2)2 = 6.5,
Thus, 0 is chosen.
† Soft decision is used for sequence detection and with more sophisticated types of
error control decoding algorithms.
4
• Channel
− Analog Front End : (After D/A at TX, before A/D at RX) performs all analog functions to
produce appropriate transmission waves and preprocess received wave before reception
· Filtering: use to bandlimit signals, remove out-of-band noise and intereference
· Mixing: used to upconvert signals to a carrier frequency and to downcovert or remove
the carrier frequency
− Propagation Channel
· Includes EM propagation effects such as reflection, transmission, diffraction, and scat-
tering
· Includes fading (random fluctuations of the signal envelope)
· Includes noise - random disturbance that degrades the signal
→ Equivalent system - includes all distortion resulting from the propagation channel
− Types of channels:
1. Additive noise - y(t) = x(t) + v(t), where v(t) models interference due to thermal
noise caused by random motion of electrons
RL
2. Multipath model (channel modeled as LTI system) - y(t) = 0 h(τ )x(t − τ )dτ + v(t)
3. Multiplicative - (scalar channel) y(t) = h(t)x(t) + v(t)
2 DSP Preliminaries
5
2 Stochastic Processes
6
· For a continuous-time random process x(t), t is the continuous-time index and x(t) is
a random variable at time t ∈ R
· For a discrete-time random process x[n], n is the integer index and x[n] is the random
variable at time n
− Focus explanation on continuous-valued discrete-time random processes (DTRP) for sim-
plicity
− A discrete-time random process is basically a sequence of random variable
− There are different characterizations of a random process based on what is known
· First order characterization of a DTRP is knowing the distribution for each n, i.e.
Fx[n] (α)
· Second order characterization of a DTRP is knowing the joint distribution between
x[n1 ] and x[n2 ] for any choice of n1 and n2 : Fx[n1 ],x[n2 ] (α1 , α2 ) (includes the first
order as a special case)
· Higher order characterizations can be similarly defined
· A random process is fully characterized by knowledge of all its higher order distribu-
tions
• Independent identically distributed (i.i.d.) random process
− Most common kind of random process we will consider
− All the collections of random variables (x[n1 ], x[n2 ], . . . , x[nk ]) for k > 1 are independent
Fx[n1 ],x[n2 ],...,x[nm ] (α1 , α2 , . . . , αm ) = Fx[n1 ] (α1 ) Fx[n2 ] (α2 ) · · · Fx[nm ] (αm ) .
Note that if the process is zero-mean Cxx [n1 , n2 ] = Rxx [n1 , n2 ]. Most processes we deal
with are zero mean.
7
− The variance is
σx2 [n] = Cxx [n, n].
The variance is the measure of the power of a random signal
− A process if called uncorrelated if
− No assumptions are made about joint probability distributions associated with a WSS ran-
dom process
− By construction an i.i.d. random process is also WSS
• Ergodicity
− Under an ergodicity assumption, sample averages converge to expectations. Deep subject.
− Basically can observe one realization and can use it to estimate the moments for the entire
random process
− WSS RP are typically ergodic (necessary & sufficient conditions provided by Slutsky’s
theorem)
− Practical question: suppose you obtain an observation x[0], x[1], . . . , x[N − 1]. Possible
estimators
N −1
1 X
mx = lim x[n] (2)
N →∞ N
n=0
and
−1−k
NX
1
Rxx [k] = lim x[n]x∗ [n + k]. (3)
N →∞ N − k
n=0
1 (x−m)2
fv (x) = √ e 2σ 2 .
2πσ 2
8
· Real and imaginary parts are independent with the same variance but possible different
mean
· Distribution be written as 2
1 |x−m|
fv (x) = e σ2
πσ 2
where x is complex
− The relevant moments are
mx = m (4)
2
Cxx [n] = σ δ[n]. (5)
1 T
Z
2π
Analysis X[n] = x(t)e−j T nt dt (8)
T 0
∞
X 2π
Synthesis x(t) = X[n]ej T nt (9)
n=−∞
9
− For a well behaved discrete-time signal
X
Analysis X(ej2πf ) = x[n]e−j2πf n (11)
n=−∞
Z 1/2
Synthesis x[n] = X(ej2πf n )ej2πf n df. (12)
−1/2
The DTFT is also often written in radians using ω = 2πf . Perhaps the most important
difference between the CTFT and DTFT is that with the DTFT, f is only defined on any
finite interval of unit length. Typically f ∈ (−1/2, 1/2] or f ∈ [0, 1).
• Also deal with the Discrete Fourier Transform (will be defined later)
2 Sampling
10
xc (t )
xc (nT )
(a)
x[n]
(b)
0 1 2 3 4 5 6 7 8
Figure 2: Illustration of sampling in the time domain. Essentially periodic samples of xc (t) in (a) form the
values for the discrete-time signal x[n] in (b).
x[n] = xc (nT )
and
11
Xc( f )
(a)
fN f
X ( e j 2π f )
(b) fs > 2 f N
1/ 2 1
f NT 1 − f NT
X ( e j 2π f )
(c ) fs < 2 f N
1/ 2 1
Figure 3: Illustration of sampling in the frequency domain. (a) Magnitude spectrum of a continuous-time
signal. (b) Corresponding magnitude spectrum for a discrete-time signal assuming that the Nyquist criterion
is satisfied. (c) Corresponding magnitude spectrum for a discrete-time signal assuming that the Nyquist
criterion is satisfied. In this example fS > fN and fS < 2fN .
t − nT
sin π
T
x[n] D/C xc (t ) = ∑ x[n]
t − nT
n
π
T
− hl (t) is the low-pass filtered channel, i.e. h(t) filtered with an ideal low-pass filter with
cut-off frequency of fN .
− h[n] is the equivalent channel.
12
yc (t ) C/D y[n] = yc (nT )
for f ∈ [−1/2, 1/2) where LfN (f ) is a low-pass filter with cutoff frequency fN .
xc (t ) hc (τ ) yc (t )
(a)
(b)
T T
(c )
Figure 6: (a) A continuous-time LTI system with a bandlimited input. (b) Generating a bandlimited input
using a discrete-to-continuous converter, followed by processing with an LTI system, followed by sampling
with a continuous-to-discrete converter. (c) The discrete-time equivalent system.
2 Bandwidth of a signal
13
− Passband signals have energy that is nonzero for a frequency band concentrated about f =
+/ − fc where fc is the carrier frequency and fc 0.
− All wireless signals are passband.
• Measures of bandwidth
− Absolute: smallest f2 − f1 such that Px (f ) = 0 for f > f2 and Px (f ) = 0 for f < f1
− Half-power (or 3dB bandwidth): smallest f2 − f1 such that Px (f1 )/Px (fmax ) = 0.5 and
Px (f2 )/Px (fmax ) where fmax is the frequency where Px (f ) achieves its maximum value.
− XdB bandwidth: extension of 3dB bandwidth to XdB.
− Fractional containment:
R∞ let X%R be the containment. Then the R f1bandwidth isR the smallest
f2 − f1 such that f2 Px (f )df / Px (f )df = (1 − X)/2 and −∞ Px (f )df / Px (f )df =
(1 − X)/2.
Figure 7: Illustration of two different notions of bandwidth in baseband and passband signals.
• Objective: Define and calculate the power spectrum of a wide sense stationary stochastic pro-
cess.
• Random signals do not have a conventional definition of a spectrum. For example, if xc (t) is a
random processes, what does the Fourier transform of xc (t) mean? Is it well defined?
• The autocovariance function provides a definition of spectrum for WSS random signals.
• For continuous-time random processes, the power spectrum is defined using the CTFT as
Z ∞
Px (f ) = Cxx (t)e−j2πf t dt.
−∞
14
2 Complex envelope representation of wireless passband signals
Re {xb (t )}
cos (2π f ct ) x p (t )
Im {xb (t )}
− sin (2π f c t )
Figure 8: Mathematical block diagram model for direct upconversion of a baseband signal to a passband
signal. The real analog may not perform a direct conversion but rather may have a series of up conversions
and downcoversions.
15
xb (t ) x p (t )
e j 2π f c t
y p (t ) LPF 2
cos (2π f ct ) x p (t )
j
y p (t ) LPF 2
− sin (2π f c t )
Figure 10: Mathematical block diagram for direct downconversion of a passband signal to a baseband
signal. The real analog may not perform a direct conversion but rather may have a series of up conversions
and downconversions. Additionally there is typically a low-noise amplifier and a bandlimiting filter just
after the antenna and a series of gain control circuits.
y p (t ) yb ( t )
e − j 2π f c t
16
• To obtain the final signal we need a suitably chosen low-pass filter and a gain of 2
− Note that
1 1
Yp (f ) = He (f − fc )X(f − fc ) + He (−f − fc )X(−f − fc ). (19)
2 2
= Hp (f )Xp (f ) (20)
1 1 1 1
= Hb (f − fc ) + Hb (−f − fc ) X(f − fc ) + X(−f − fc ) (21)
2 2 2 2
1 1
= Hb (f − fc )X(f − fc ) + Hb (−f − fc )X(−f − fc ) (22)
4 4
1
− He (f ) = 2 Hb (f ) or 2He (f ) = Hb (f )
17
|Xp ( f )|
|H ( f )|
|Yp ( f )|
Figure 12: Illustration of convolution between the passband signal and the channel. In this case the total
response of the channel H(f ) is illustrated.
h[n] = T he (nT )
18
|Xp ( f )|
|H p( f )|
|Yp ( f )|
Figure 13: Illustration of convolution between the passband signal and the channel.
• With the complex baseband equivalent, digital modulation is equivalent to mapping a sequence
of bits to a bandlimited complex baseband waveform
19
|H( f )|
- fc fc f
|H p ( f )|
- fc fc f
|H b ( f )|
2
|H e ( f )|
1
• Mathematically the block diagram generates the following complex baseband signal
p X∞
x(t) = Ex s[n]gtx (t − nT )
n=−∞
20
RF h(τ) RF
xb(t) Upconversion Downconversion
yb(t)
C = {s0 , ..., sM −2 , sM −1 }
|C| = M = 2# of bits/symbol
2 Constellations
21
Im Im Im
(01) (01) (00)
j
(0) (1) (11) (00)
Re Re Re
-1 1 -1 1
-j
(10)
(11) (10)
BPSK QPSK 4-QAM
Im Im
(0000) (0100) (1100) (1000) (011)
(010) j (001)
(0001) (1001)
(0101) (1101) (110) (000)
(0111) (1111) Re -1 1 Re
(0011) (1011)
(111) (100)
-j (101)
(0010)(0110) (1110) (1010)
16-QAM 8-PSK
Im
(000000) (001000) (011000) (010000) (110000) (111000) (101000) (100000)
Re
(000110) (001110) (011110) (010110) (110110) (111110) (101110) (100110)
64-QAM
Figure 15: Several different constellations with generally accepted bit to symbol mappings based on Gray
labeling.
· 8-PSK is used in EDGE
• Bit labeling is typically done according to the Gray coding principle. This means that adjacent
symbols differ by a single binary digit.
• Constellation energy
h i
− Definition: The constellation energy is defined as Es := Es |s[n]|2
− Used for zero-mean constellation, since if you didn’t, there would be a DC component that
22
causes problems with transmission and reception.
− Assume that s[n] is an i.i.d. random variable with probability mass function Ps [m]
h i M
X −1
2
E = E |s[n]| = |sm |2 Ps [m]
m=0
− If the symbols are equally likely and zero mean, as is usually assumed,
M −1
1 X
E = |sm |2
M
m=0
− We always normalize C such that Es = 1, to control transmit power. The reason is that we
use Ex to control / model transmit gain.
− To normalize the constellation, find an α such that
• Objective: Calculate the bandwidth, energy, and power of a general amplitude modulated sig-
nal.
• Bandwidth
−
p ∞
X
x(t) = Ex s[n]gtx (t − nT )
n=−∞
Px (f ) = = Ex |Gtx (f )|2
23
− The transmit energy is in Joules
Z ∞
Px (f )df = Ex
−∞
v(t)
(AWGN)
x(t) y(t)=x(t)+v(t)
(Baseband signal)
• AWGN is a good model for the impairments due to thermal noise present in any wireless com-
munication system
• x(t) is the complex baseband signal, v(t) is the AWGN, y(t) is the observation
• v(t) AWGN means
− Noise is additive
− v(t) is an Independent and identically distributed (i.i.d.) complex Gaussian random variable
v(t) ∼ Nc 0, σ 2
σ2
Re{v(t)} ∼ N 0,
2
σ2
Im{v(t)} ∼ N 0,
2
and E [Re{v(t)}Im{v(t)}] = 0
− σ 2 = No kTe is Boltzman’s constant k = 1.38 × 10−23 J/K and the effective noise
temperature of the device is Te in Kelvins. Assume Te = 290K in the absence of other
information.
− The noise is white because it is i.i.d. This means Rv (τ ) = σ 2 (τ ) or equivalently Pv (f ) =
σ2.
− Signal-to-noise ratio
Ex |x(t)|2 Ex
SN R = =
Ev |v(t)|2 No
2 Overview of the AWGN transmitter and receiver
24
Tx
Rx
Inverse bits
y(t) gRx(t) C/D y[n] Detection Symbol Mapping
2 Pulse-shape design
• Objective: Determine properties of the optimal receiver pulse-shape for the AWGN channel.
• Claim: The gr x(t) that maximizes the received SNR is optimal. This can be proven from detec-
tion theory.
• Consider the received signal (let ⊗ stand for convolution)
!
p X
y(t) = Ex grx (t) ⊗ gtx (t) ⊗ s[m]δ(t − mT ) + grx (t) ⊗ v(t)
m
25
− Intersymbol interference energy:
2
X X
|g(mT )|2
p
Es Ex
s[m]g((n − m)T ) = Ex
m,m6=n m6=0
Ex |g(0)|2
SIN R :=
|Grx (f )|2 df + Ex m6=n |g(mT )|2
R P
No
(
− Equality holds when grx (t) = gtx − t)
− Matched filter: grx (t) = gtx (−t)
• Zero-ISI condition Ex m6=0 |g(mT )|2 = 0 equivalent to
P
g(nT ) = cδ[n].
Note that with our normalization of gtx (t), c = g(0) = |gtx (t)|2 dt = 1. Do such pulse shapes
R
exist?
2 Nyquist pulse-shapes
• Objective: Describe tradeoffs between bandwidth, excess bandwidth, and sampling frequency of
the raised cosine pulseshape.
• Objective: Define Nyquist pulse criterion and determine if a given pulse shape satisfies that
criterion.
26
• A necessary and sufficient condition for
g(nT ) = δ[n].
sin(πt/T )
gsync (t) =
πt/T
Figure 16: Illustration of the raised cosine pulse-shape in time and frequency domains for different choices
of roll-off. Replace with Matlab simulation
27
• Standard example is the raised cosine pulse-shape
T, ≤ |f | ≤ (1 − α)/2T
01−α
T πT 1−α 1+α
Grc (f ) = 1 + cos |f | − , 2T ≤ 2T
2 α 2T
0, |f | > 1+α
2T
where v[n] is i.i.d. complex Gaussian noise with Nc (0, No ) (follows because grx (t) is a matched
filter and forms a Nyquist pulse-shape).
• Detection problem is to find a good guess of s[n] given an observation of y[n]
• Maximum likelihood is a detection rule that maximizes the likelihood of the observation under
the hypothesis that a given symbol was transmitted.
− Likelihood function: fy|s (y[n]|s[n] = s)
− fy|s (x) is the conditional probability distribution function of y[n] given s[n]
√
− For the AWGN channel, given s[n] = s, y[n] is complex Gaussian with mean Ex s and
variance No √
1 − |x− NEx s|2
fy|s (x|s) = e o
πNo
28
• The ML detector solves the optimization
√
1 − |y[n]−N Ex s|2
arg min fy|s (y[n]|s[n] = s) = arg min e o
s∈C s∈C πNo
√
|y[n]− Ex s|2
−
arg min fy|s (y[n]|s[n] = s) = arg min e No
s∈C s∈C
√
|y[n] − Ex s|2
arg min ln fy|s (y[n]|s[n] = s) = arg min
s∈C s∈C No
p
arg min ln fy|s (y[n]|s[n] = s) = arg min |y[n] − Ex s|2
s∈C s∈C
• Objective: Derive the probability of symbol error for the ML detector in an AWGN channel.
• Objective: Calculate the probability of symbol error.
• Performance of a dector is measured by the probability of error
• Can be computed in closed form in some cases, estimated via bounds in most cases
• Interested in the probability of symbol error since symbol detection is employed (can also derive
probability of bit error, frame error, etc)
• For equally likely symbols in AWGN the probability of symbol error is
M −1
Ex 1 X Ex
Pe = Pe|sm .
No M No
m=0
Ex
− It is a function of the SNR No
Ex
Pe|sm = Pr {sm is detected incorrectly|sm was transmitted}
No
M
X −1
= Pr {sm is decoded as sl |sm was transmitted, m 6= l} (28)
l=0
l6=m
29
Ex Ex Ex Ex
− , ,
2 2 2 2
• •
v2 v1
Ex E Ex E
− ,− x ,− x
2 2 2 2
• v3 • v4
Figure 17: Voronoi regions for the 4-QAM constellation are the quadrants of the complex plane. Any point
y[n] that falls in a Voronoi region is mapped to the corresponding symbol that generate that region through
the ML detection process.
30
• Hard to compute in practice thus we use a bound based on the pairwise error probability, defined
as
n
p
p
o
Pr {sm → sl } = Pr
y − Ex sm
>
y − Ex sl
s
2
E x ksm − sl k
= Q
No 2
− Note:
Z ∞
1 2
Q(x) = √ e−t /2 dt
2π x
1 −x2 /4
≤ e
2
− Use the Chernoff bound to simplify
• The PEP assumes only two symbols in the constellation thus provides an upper bound
31
• For M-QAM
6
d2min = .
M −1
Substituting !
r
Ex Ex 3
PeQAM ≤ (M − 1)Q .
No No M − 1
• Exact form
r ! 2 " r !#2
E x 1 E x 3 1 E x 3
PeQAM = 4 1− √ Q −4 1− √ Q .
No M No M − 1 M No M − 1
• Suppose that Tx = T /L for some integer L for duration of lecture (extensions possible though
more complex)
X∞
c[n] = s[m]gtx (nTx − mLTx )
m=−∞
32
• Let gtx [n] := gtx (nTx )
∞
X
c[n] = s[m]gtx [n − mL]
m=−∞
• Note that
∞
!
X
c[n] = s[m]δ[n − mL] ⊗ gtx [n]
m=−∞
S̄(ej2πf ) = S(ej2πf L )
s[n] ↑L s [ n]
s[0] s[0]
s[1] s[1]
s[2] s[2]
0 1 2 0
L
2L
L−1 zeros L−1 zeros
Tx
Figure 19: An implementation of transmit pulse shaping simplified using upsampling identities.
33
(0)
s[n] gTX [ n] ↑L D/C Ex x(t )
Tx
z−1
z −1
( L −1)
g TX [ n] ↑L
• Objective: Implement discrete-time pulse shaping at the receiver using oversampling combined
with downsampling.
• Objective: Apply downsampling identities to implement and simplify receive pulse shaping
• Thus far we have considered the following QAM receiver
Tz Tz T = MTz
Figure 21: An implementation of receive matched filtering in continuous-time using discrete-time process-
ing.
g[n] = Tz grx (nTz )
For simplicity we neglect the Tz term since receiver scaling does not matter
grx [n] := grx (nTz )
34
• Simplify using downsampling ↓ M
y[n] = z[nM ]
M −1
1 X j2πf /M −j2πm/M
Y (ej2πf ) = Z e
M
m=0
z[n] ↓M y[n]
z[0] z[0]
z[1] z[2] z[ M ]
⇒
0 1 2 0 1
Tz
Figure 23: An implementation of receive matched filtering in continuous-time using discrete-time process-
ing.
• Note that the straightforward convolution results in lots of extra computations that are wasted
because we toss those coefficients
• Use downsampling equivalence to reduce computations
X
y[n] = z[mM ]g[n − m]
m
!
X X
= z[m] g[p]δ[nM − m − pM ]
m p
X
= z[m]ḡ[nM − m]
m
35
• Using a transformation k = pM − m
X
y[n] = grx [k]z[nM − k]
k
X
= z[k]grx [nM − k]
k
XM
X −1
= z[pM − m]grx [nM − pM + m]
p m=0
XM −1
(m)
X
= z[pM − m]grx [n − p]
k m=0
(0)
z (t ) C/D gRX [ n] ↓M y[n]
−1
z
(1)
g RX [ n]
Tz
( M −1)
g RX [ n]
• Objective: Increase and decrease the effective sample rate of a discrete-time signal using multi-
rate DSP.
• Can generalize transmit and receive pulse shaping to T = M Ts /L using the concept of resam-
pling
• Consider a bandlimited signal x(t) sampled with sampling period T such that Nyquist is satisfied
• Increasing the sampling rate by L
− Have x[n] = x(nT ) but would like z[n] = x(nT /L)
X sin(π(t − nT )/T
x(t) = x[n]
n
π(t − nT )/T
thus
X sin(π(nT /L − mT )/T
x(nT /L) = x[m]
m
π(t − nT )/T
X sin(π(n − mL)/L)
= x[m] .
m
π(n − mL)/L
36
LPF
x[n] ↑L Gain L z[n]
Cutoff 1/L
Figure 25: Increasing the sampling rate by an integer factor L. Also known as interpolation.
LPF
x[n] Gain L ↓M x[n]
Cutoff 1/M
Figure 26: Decreasing the sampling rate by an integer factor M . Also known as decimation.
LX sin(π(nM − m)/R
x̃[n] = x[m] .
R m (nM − m)/R
• Objective: Explain different impairments caused by the frequency flat wireless communication
channel.
• Thus far we have considered transmission and reception in an ideal channel using the following
structure
• What happens in a frequency flat channel?
− Baseband channel is h(τ ) = αejφ δ(t − τd )
− In the frequency domain H(f ) = αe−j2πτd +jφ
− Frequency flat because |H(f )| is constant
37
LPF
x[n] ↑L Gain L ↓M x[n]
Cutoff
min(1/L, 1/M)
Figure 27: Changing the sampling rate by a factor of L/M . Also known as resampling.
Tx
Ts/M
Rx
Ts/N
x(t ) α e jθ δ(t − τ ) z (t )
Figure 29: A frequency flat wireless channel consisting of AWGN, attenuation by α, phase shift by φ, and
delay by τd .
• Consider the signal after matched filtering and sampling with 0 < τd < T
p X
y[n] = Ex αejφ s[m]g((n − m)T − τd ) + v[m]
m
p p X
jφ
= E αe s[n]g(τd ) + Ex αejφ s[m]g((n − m)T − τd ) + v[n]
| x {z } |{z}
m6=n
desired | {z } noise
ISI
38
• Suppose that τd = dT for some integer d
p X
y[n] = Ex αejφ s[m]g((n − m)T − τd ) + v[m]
m
p X
jφ
= Ex αe s[m]g((n − m)T − dT ) + v[m]
m
p
= Ex αejφ s[n − d] + v[m]
Ts Ts
Ts
Analog Digital N Digital
Timing Synch Synch
39
C/D g(m)[n] z-k M
k
Ts
M Determine
optimal sample
Interpolation
C/D N:M
g(m)[n] z-k M
k
Ts
N Determine
optimal sample
• The best approach would be to formulate and solve for the maximum likelihood symbol timing
estimate, somewhat complex in practice
• Output maximization is one criteria for symbol timing that has a simpler implementation
− Consider the continuous-time output of the matched filter y(t) followed by sampling at
nT + τ
Jopt (τ ) = E |y (nT + τ )|2
− The maximum output energy solution is
− How to solve?
· Differentiating the expectation and approximating
n o
d d 2
J
dτ opt (τ ) ' E dτ |y (nT s + τ )|
δ ∗
∗ δ
= E y(nT + τ ) δτ y (nT + τ ) + E y (nT + τ ) δτ y(nT + τ )
δ ∗
= 2Re E y(nT + τ ) δτ y (nT + τ )
δ ∗
· Discrete-time difference δτ y (nT + τ ) ' y ∗ (nTs + τ + δ) − y ∗ (nTs + τ − δ)
· Replace E{·} by time-average
P −1
d 1 X
Jopt (τ ) ' 2Re {y (nTs + τ ) (y ∗ (nTs + τ + δ) − y ∗ (nTs + τ − δ))}
dτ P
n=1
40
· Assume oversampling or interpolation then discretize τ and δ on [0, 1, . . . , M − 1]
P
X −1
∗ ∗
δJ[k] = 2Re {rover [nP + k] (rover [nP + k + δ] − rover [nP + k − δ])}
n=0
kopt T
For k = 0, ..., M − 1, kopt = arg min dJ[k] and τ̂d = M .
k
• Once an estimate of the offset τ̂d is obtained then it is possible to incorporate the delay in to the
discrete-time matched filter to reduce processing complexity.
• How do we estimate the error rate after synchronization for pulse amplitude modulation with the
union bound
v
Ex |g(τd − τ̂d )|2
u
u 1
Pe ≤ (M − 1) Q u
t 3M − 1 E · P 2
x |g(mT − τ d )| + N 0
m6=0
2 Frame synchronization
41
− Special sequences with low correlation can improve performance
· Length 16 Frank sequence
where 0 ≤ n ≤ q 2 − 1 and q is any integer. For our purpose we can take q = 4 and
r = 3 to obtain a length 16 QPSK sequence (you may need to phase shift to get a QPSK
from a 4-PSK sequence).
· Neuman-Hoffman binary code
ˆ Symbol
z (t ) C/D g RX [n] zk M z d̂ Detector sˆ[n]
-1
kˆ d̂ hˆ
T Symbol Frame Channel
M Sync Sync Estimator
Figure 31: Receiver with symbol synchronization based on oversampling, frame synchronization, and chan-
nel estimation.
42
− Top term is the correlator - can jointly perform frame synchronization and channel estima-
tion!
− Bottom term corrects for scaling
• To correct for h simply include scaling in ML detector |y[n] − hs[n]|2
• To simplify detection note that if h 6= 0
• Objective: Explain different impairments caused by the frequency selective wireless communi-
cation channel.
Figure 32: A frequency selective wireless channel consisting of convolution with an impulse response fol-
lowed by AWGN.
43
2 Least squares estimation of intersymbol interference channels
ĥ = (T∗ T)−1 T∗ y.
• Objective: Derive and compute the least-squares equalizer using an estimate of the channel.
• An equalizer is a filter that removes frequency selective distortion
• A good equalizer, in the absence of noise, satisfies
Lf
X
ŝ[n − nd ] = fnd [l]y[n − l]. (30)
l=0
or equivalently
Lf
X
f [l]ĥ[n − l] ≈ δ[n − nd ]. (31)
l=0
44
− nd is the delay, a design parameter
− Generally nd > 0 improves performance
• One approach for solving is the least-squares equalizer is to use the channel estimate
• Consider the least-squares FIR inverse that minimizes the squared error w/ estimated channel
Lf +L Lf
X X
Jf [nd ] = |δ[n − nd ] − fnd [l]ĥ[n − l]|2
n=0 l=0
Symbol
z(t ) C/D g RX [n] zk̂ M f[l] zn̂ d
Detector sˆ[n]
k̂
Ts Symbol Equalizer
M Sync Computation
Channel
Estimator
Figure 33: QAM receiver with channel estimation and linear equalization.
• Objective: Derive and compute the least-squares equalizer without first estimating the channel.
45
• Consider the received signal
L
X
y[n] = h[l]s[n − l] + v[n]
l=0
for n = 0, 1, . . . , Nt .
• Squared error
N t −1 Lf
X X
Jf [nd ] = |t[n] − fnd [l]y[n + nd − l]|2
n=0 l=0
• LS solution, under the assumption that Y is full rank (which is reasonable in the presence of
noise) −1 ∗
f̂nd = Yn∗ d Ynd Ynd t.
• Optimize order based on squared error
−1
Jf [nd ] = kt − Ŷnd f̂nd k2 = kt − Ynd Yn∗ d Ynd Yn∗ d tk2
46
Symbol
z(t ) C/D g RX [n] zk̂ M f[l] zn̂ d
Detector sˆ[n]
k̂
Ts Symbol Equalizer
M Sync Computation
Figure 34: QAM receiver with direct equalizer estimation and linear equalization.
• Objective: Explain origin of frequency offset and discuss nature of the impairment.
• What is it? Frequency offset occurs when fc 6= fc0 and is unknown!
'
e j 2π f c t e − j 2π f c t
47
− Non-blind methods use some form of training to estimate the offset and correct
• Objective: Use the Moose method to perform joint frequency offset estimation and frame syn-
chronization.
Frame
... ...
Nt Nt N-2T data symbols
Training
• Least squares is one solution but in the exponent requires a nonlinear least squares solution
• As an alternative, consider a simplification of the least squares problem
N
X t −1
• Solution is PNt −1 ∗
l=L y [n + Nt ]y[n]
â = N1 −1
.
2
P
l=L |y[n + Nt ]|
− Can neglect denominator since only the phase of â is of interest
• Simple frequency offset estimator
PNt −1
arg l=L y ∗ [n + Nt ]y[n]
ˆ =
2πNt
or PNt −1
arg y ∗ [n + Nt ]y[n]
fˆe = l=L
2πT Nt
where arg donotes the principle phase of the argument.
48
1
• Estimate of will only be accurate for |Nt | ≤ 2 or equivalently
1
|| ≤
2Nt
or
1
|fe | ≤ .
2T Nt
• Example 1M s/s QAM signal, fc = 2GHz, Nt = 10
1 1 1 1
max |fe | = = 106 = 105 = 50kHz
2Ts T 2 10 2
− In practice we only have a few samples of s[n] and cannot wait to acquire all of s[n]
− Further h[n] is not time invariant over a long period
• Simplify frequency domain equalization
− Use specially designed s[n] to enable frequency domain equalization
− Leverage principles of the discrete Fourier transform (DFT)
49
• The DFT is a basis expansion for finite-length signals
N −1
X 2π
Analysis : X[k] = x[n]e−j N kn k = 0, 1, ..., N − 1
n=0
N −1
1 X 2π
Synthesis : x[n] = X[k]ej N kn n = 0, 1, ..., N − 1
N
k=0
(N : length of signal)
• The DFT can be computed efficiently with the Fast Fourier transform for N a power of 2 and
certain other special cases
• Circular shift property of the DFT
k
j2π ( N )m x [((n − m))N ] 0 ≤ n ≤ N − 1
If X1 [k] = e X[n] ⇒ x1 [n] =
0 else
• Circular convolution
− To illustrate, let length of h[n] be L + 1, length of s[n] be N > L
− Zero-pad h[n] with N − 1 − L zeros
N
X −1
y[n] = h[l]s [((n − l))N ]
l=0
L
X
= h[l]s [((n − l))N ]
l=0
n L
P P
h[l]s[n − l] + h[l]s[n + N − l] 0 ≤ n < L
l=0 l=N +1
= L
P
h[l]s[n − l] n≥L
l=0
n1 L +1
s2 s2
n2 N
⇓ ⇓
n1 + n2 + 1 N
50
2 Single carrier frequency domain equalization
• Objective: Use cyclic prefix to convert a linear convolution to a circular convolution and equal-
ize in frequency domain.
• Need to make a linear convolution look circular
• Let s[n], n = 0, ..., N − 1 be N QAM symbols for transmission
• Create the following signal
− Add a cyclic prefix of length Lc
w[n] = s[n + N − Lc ] n = 0, 1, . . . , Lc − 1
w[n + Lc ] = s[n] n = 0, 1, . . . , N − 1
• Neglecting the first Lc terms of the convolution (discarding the cyclic prefix)
L
X
y[n + L] = h[l]w[n + L − l]
l=0
L
X
= h[l]s[(n − l)N ]
l=0
(34)
• Can use standard symbol timing, frame timing, and channel estimation algorithms.
51
z (t ) C/D g RX [n] z m̂ ↓M z d̂ Serial Lc
to
m̂ d̂ Parallel
T
Symbol Frame 1: N + Lc DFT
IDFT
M Sync Sync
H −1[k ]
Channel
S/P DFT
Estimation
QAM Parallel
sˆ[n]
Detection to Serial
N:1
Figure 35: Receiver with cyclic prefix removal and a frequency domain equalizer.
• Advantages of OFDM
− Allows simple frequency domain equalization at the receiver
− Allows sophisticated types of adaptive modulation where information is adapted to the fre-
quency response of the channel
− Obtains diversity against fading when combined with error control coding
• Applications of OFDM
− WiFi - IEEE 802.11g, IEEE 802.11a, IEEE 802.11n
− WiMax - IEEE 802.16
− Mobile broadband wireless - IEEE 802.20
− Digital video broadcast - DVB (used in Europe), DVB-h
• OFDM transmitter
Serial Parallel
bits to IFFT Add to
QAM CP
L gTX [n] D/C
Parallel N Serial
...
...
...
T
L
Figure 36: Block diagram of an OFDM transmitter. In practice the IDFT would instead be implemented
with an IFFT
−1
− Suppose we want to transmit {s[n]}N n=0
− Let Lc be the length of the cyclic prefix
52
− The OFDM transmitter sends the samples
N −1
1 X m(n−Lc )
w[n] = s[m]ej2π N n = 0, ..., N + Lc − 1
N
n=0
Channel
DFT
Estimation
QAM Parallel
sˆ[n]
Detection to Serial
N:1
53
− The receiver then takes the DFT of these samples
Ȳ [k] = DF T [ȳ[n]]
N −1
X 2πkn
= z̃[n]e−j N
n=0
N −1 N −1 L
!
1 X X X
−j 2πml 2πmn 2πkn
= h[l]e N s[m]ej N e−j N
N
n=0 m=0 l=0
N −1 L N −1 N −1
! !
1 X X
−j 2πml
X
j
2πn(m−k) X
j
2πn(m−k)
= h[l]e N s[m] e N ← e N = N δ[m − k]
N
m=0 l=0 n=0 n=0
L
!
X 2πml
= h[l]e−j N s[k]
l=0
= H[k]s[k]
· Guard interval: Lc T
54
2 Frequency Offset Estimation in OFDM
• Objective: Describe and implement carrier frequency offset estimation for an OFDM system.
• General OFDM transmitter
Serial Parallel
bits to IFFT Add to
QAM CP
L gTX [n] D/C
Parallel N Serial
...
...
...
1:N (N+L c ):1
T
L
Figure 38: Block diagram of an OFDM transmitter. In practice the IDFT would instead be implemented
with an IFFT
• General OFDM receiver
Serial
Remove to FFT QAM
EQ Demapping
CP Parallel
1:N
N Detection
Channel
Estimation
55
CP Data
p N/2 N/2
56
− Using the structure of S2 [k] for even k
2Lc m
Y2 [k]Y1∗ [k] = ej2π N |H[(k − 2m)N ]|2 V [(k − 2m)N ] + noise
Solving
PN/2−1
k=0 V ∗ [(2k − 2m)N ]Y2 [2k]Y1∗ [2k]
α = PN/2−1
k=0 |V [(k − 2m)N ]|2
The best m is the one that minimizes the squared error
57
− Mathematical description
or in matrix form
or in matrix form
58
− 802.11h, i, e, s,...
• Why develop standards?
− Need compatibility between equipment vendors
− Allow for competition, reduces prices for consumers
• Why should we study a standard?
− To see how all the tricks we discussed manifest in practice
− Standards are well thought out - it’s in the details
• Standards under consideration
− ANSI/IEEE Std. 802.11, 1999 edition
− IEEE Std. 802.11a-1999
• How to read the standard?
− Look at the table of contents
− Decode vocabulary
− Look at criteria
• IEEE 802.11a specifications (very similar to IEEE 802.11g but I have the IEEE 802.11a stan-
dard)
− MAC protocol - control access to medium, etc.
− PHY protocol - waveform, coding, modulation, etc.
• Overview
− WLAN: 5.15-5.25, 5.25-5.35, 5.785-5.825GHz, UNII band
− Payloads: 6, 9, 12, 18, 24, 36, 48, 54 Mbps (6, 12, and 24Mbps are mandatory)
− Modulation: BPSK, QPSK, 16-QAM, 64-QAM
− N = 64-point FFT, 48 data tones, 4 pilots
− Coding: rate 1/2, 2/3, 3/4 convolutional codes with puncturing
• Transmission of data (see page 7, Figure 107)
− PPDU - PHY convergence layer protocol (Frame format)
PLLP Preamble
12 Symbols
SIGNAL
1 OFDM Symbol
DATA
Variable # of OFDM Symbol
Training
Information about Data packets in OFDM
AGC
when is to come
Synchronization
59
PLLP SIGNAL DATA
TGI TFFT
TR
T = TGI + TFFT
NSD 48
NSP 4
NST 52
∆F 0.3125MHz (20MHz/64)
TF F T 3.2µs (1/∆F )
TP REAM BLE 16µs (TSHORT + TLON G )
TSIGN AL 4µs (TGI + TF F T )
TGI 0.8 µs (TF F T /4)
TGI2 1.6 µs (TF F T /2)
TSY M 4 µs (TGI + TF F T )
TSHORT 8 µs (10 × TF F T /4)
TLON G 8 µs (TGI2 + 2 × TF F T )
• Possible data rates (used for adaptive modulation)
60
• PLCP preamble used for synchronization (Section 17.3.3)
− The PLCP preamble field is used for synchronization
− t1 to t10 denote short training symbols and T1 and T2 denote long training symbols
− Short OFDM training symbol consists of 12 subcarriers
− Long OFDM training symbol consists of 53 subcarriers (including a zero value at dc)
• DATA field (Section 17.3.5)
− The DATA field contains the SERVICE field, the PSDU, the TAIL bits (6bits), and the PAD
bits.
− Pad bits: first pad the symbols to make sure there are the appropriate integer number of
symbols
− Scrambling: all bits in the DATA field are scrambled with a length 127 frame-synchronous
scrambler.
· The frame synchronous scrambler uses the generator polynomial S(x) as
S(x) = x7 + x4 + 1
− Convolutional encoding: the DATA field, composed of SERVICE, PSDU, tail, and pad
parts, shall be coded with a convolutional encoder of coding rate R = 1/2, 2/3 or 3/4,
corresponding to the desired data rate. Viterbi decoding is recommended.
· The convolutional encoder shall use the industry-standard generator polynomials.
· The bit denoted as “A” shall be output from the encoder before the bit denoted as “B”.
− Puncturing: the higher rates are derived from it by employing “puncturing”. Puncturing is
a procedure for omitting some of the encoded bits in the transmitter and inserting a dummy
“zero” metric in to the convolutional encoder on the receive side in place of the omitted bits.
− Interleaving: defined by a two-step permutation
1. Adjacent coded bits → mapped onto nonadjacent subcarriers
61
2. Adjacent coded bits → mapped alternately onto less and more significant bits (LSB and
MSB) on the constellation
− Subcarrier modulation mapping: the OFDM subcarriers shall be modulated by using
BPSK, QPSK, 16-QAM, or 64-QAM modulation.
· According to Gray-encoded constellation mapping, the output values, d, are formed by
d = (I + jQ) × KM OD
62
· Phase 2: 1993 added SMS, fax, etc. data
· Phase 2+: evolution of GSM (EDGE, 2.5G)
− Next phase is third generation system 3G called Wideband CDMA (UMTS)
· Uses the same network infrastructure
• GSM is a standard that includes many frequency bands, vocoder, data rates, etc.
• What is included in the GSM standard?
BTS
Abis
Um
BTS BSC
Mobile
station
MS
BSS VLR
(base station subsystem)
MSC Gateway
TE MT MSC
Terminal Mobile Mobile
equipment termination switching
MS center HLR
SIM
(subscirber
I/O module)
AuC DIR
63
− BSS - base station subsystem
− MSC - mobile switching center routes call to/from users
− HLR - home location registry store subscriber specific information
− AuC - authentication center
− VLR - visitor location register
• Where is the GSM standard?
− www.etsi.org
− Standard can be downloaded for free but it helps to know the document numbers
· ETSI TS 100 959 v.8.4.0 Digital cellular telecommunications system (Phase 2+); Mod-
ulation contains modulation information
· ETSI TS 100 910 v.8.9.0 Digital cellular telecommunications system (Phase 2+); Radio
transmission and reception
· ETSI TS 100 908 v.8.9.0 Digital cellular telecommunications system (Phase 2+); Mul-
tiplexing and multiple access on the radio path
· ETSI TS 100 573 v.8.7.0 Digital cellular telecommunications system (Phase 2+); Phys-
ical layer on the radio path; general description
− Is about 5,000 pages in print
• GSM is a TDMA/FDMA system
− TDMA: time division multiple access
· Resource divided into different periods over time-slots
− FDMA: frequency division multiple access
· resource divided into different carrier
• Basic Tx/Rx
Channel
Channel
estimator
64
x(t) = ejφ(t)+φ0
where
X π 1 3
φ(t) = s[k]Φ(t − kT ), Φ(xT ) = G x− −G x−
2 2 2
k
Z ∞
√
2
1 − t2 σ − t22 ln 2
G(x) = x √ e 2σ dt + √ e 2σ , σ =
−∞ 2πσ 2π 2π · 0.3
− Introduce ISI at Tx
− Can be written as an equivalent linearized QPSK system with differential encoding
• GSM framing structure is quite interesting
− Normal burst
Training
58 5 26 5 58
3 tail 3 tail
bits bits
· 8 training sequence
· 16bits, cyclically extends 5bits
· Good auto-correlation
· Low cross-correlation
− Frequency correction burst (send a control)
Guard (252 µ s )
65
2 Introduction to Propagation and Fading Channels
n: h 2
Gai
: d2
vels
Tra
Tx Rx
Travels: d0 Gain: h0
Trav
els:
d
1 Gai
n: h
1
− h(t, τ ) is the baseband equivalent time-varying impulse response of the channel (can as-
sume bandlimited)
− t is the time index, τ is the lag
− Models the combination of different propagation effects in the channel
− Creates fluctuations of the signal over time called fading and intersymbol interference
− Includes many different propagation effects
• There are several different mechanisms of propagation all leading to the presence of multiple RF
paths (or multi-path) between the transmitter and receiver
− Transmission - wave propagation through the medium, typically refers to the line-of-sight
path but also includes propagation through objects
· Always first component received
· Typically strongest component received
66
− Reflection - wave impinging on an object with dimensions λ
− Scattering - the wave is impinging on object with irregularities ≈ λ. “roughness”
− Diffraction - “bending” of wave around large structure with irregularities (coverage in urban
area). Stronger with low frequencies (larger wavelengths)
67
2 Modeling received signal strength
• Objective: Describe the components of a typical model for received signal strength.
• Perhaps the first propagation models were for the received signal strength as a function of loca-
tion Pr (d)
• Purpose of model is to account for typical behavior as a function of distance not to predict a
specific path loss in a given environment
• For the flat fading model Pr (d) = Ps |h(d)|2
• Model should include the following phenomena
− Large-scale fading - Median signal strength as a function of distance, captures general decay
of received signal, variation of the signal power over larger distances on the order of 100’s
of wavelengths, shadowing by buildings, etc. Captures general loss in signal as a function
of distance.
− Small-scale fading - Variation of the signal power over small distances, on the order of
λ0 s, as a result of constructive + destructive multi-path interference. Captures more subtle
multi-path effects.
Large-scale fading
Small-scale fading
Figure 41: Illustration of the variation of received signal strength as a function of location.
68
− αlarge [dB] = 10 log10 αlarge : attenuation in dB, often modeled as a random variable
− αsmall [dB] = 10 log10 αsmall : attenuation in dB, often modeled as a random variable
− Pt [dB]: transmit power in dB
− Path loss is Pr (d)[dB] − Pt [dB]
• Objective: Calculate gain and power in linear, dB, and dBm scales.
• Signal strength is often measured in Watts or dBW (referenced to 1 Watt)
G[dB] = 10 log10 G
where G is unitless.
• Because mobile wireless systems typically use < 1W att of power, often milliWatts or dBmW
are instead used
P [dBmW ] = 10 log10 P [mW ]/1mW
We call this dBm when there is no chance for confusion.
• The following conversion is useful
69
• Objective: Explain motivation for large scale versus small scale fading phenomena
• Both large-scale and small-scale propagation phenomena are important
− Large-scale influence system planning, link budget, captures “typical” loss in received sig-
nal strength as a function of distance
− Small-scale influences physical layer link design, modulation schemes, captures local con-
structive and destructive multi-path effects
• Objective: Calculate received signal strength, path loss, and received SNR as a function of dis-
tance for the Friis freespace equation, log-distance equation, and log-normal Gaussian models.
• Large-scale fading typically models received signal strength
• The Friis free space equation is the foundation of most large scale fading models
Pt G t G r λ 2
Pr (d) =
(4π)2 d2 L
or more commonly in dB notation (we assume dB from now on unless otherwise noted)
70
• Observations about Friis
− If the distance doubles, the received power increases by 6dB.
− If the wavelength doubles, the received power drops by 6dB
− If the frequency doubles (inversely proportional to the wavelength), then the received power
drops by 6dB
• The Friis free space equation is too optimistic for mobile systems
• Need to account for the typical (mean or median) signal and variation of the signal at a given
distance d → path loss models
• Log distance path loss model with shadowing (everything in dB now)
Pr (d) = Pt − L(d)
71
2. Suppose that σ = 8dB. What is the probability that Pr (100m) < −60dBm?
Prob {Pr (100m) < −60dBm} = Prob −50dBm + Xσ < −60dBm
|{z}
∼N (0,σ)
= Prob {Xσ < −10dB}
= Prob {Xσ > 10dB}
Xσ 10dB
= Prob >
σ σ
10dB
= Q = Q (1.25)
8dB
= 0.106 ∼ 10% outage
⇒ Q(α) = 0.05
⇒ α = 1.65
⇒ 65dBm + Pt − Ls (d0 ) − 10n log dd0 = 1.65σ
⇒ 65dBm + 20dBm − 10dBm − 30 log d = 1.65 × 8
⇒ 61.8 = 30 log d
⇒ d ' 114m
72
Frequency
Flat Fading
Selective Fading
Fast Fading
Symbol Period
Fast Fading
Signal Bandwidth
− Coherence bandwidth
1
Bc ≈
5στ
73
• Coherence Bandwidth Bc is the range of frequencies over which the channel remains fairly
constant
• A channel is frequency flat if the symbol time
T στ
B Bc
• Measure Sm (τ ) by estimating several channel realizations and estimating the average power by
replacing the expectation with the sample mean.
• Measure Rm (∆f ) by sending sinusoids at ∆f = f1 − f2 and estimating the correlation between
their respective channels
• Mitigation of frequency selective fading: linear equalization, decision feedback equalization,
maximum likelihood sequence detection
Sd (τ ) = F {Rd (τ )}
• Doppler spread can be defined in a similar way as rms delay spread. In mobile channels we
often use the maximum Doppler shift (as a worst case)
vfc
fm =
c
• Coherence time
1
Tc ≈
fm
• A channel can be assumed to be time invariant (not time selective) if
T Tc
or equivalently
B fm
74
• Note: we often consider packet length
KT Tc with K = # of symbols
• Estimate coherence time using either the maximum expected Doppler frequency or by estimating
the coherence time directly
• Mitigation of time-selective fading:
− More robust modulation schemes
− Increase the symbol rate
− Adaptive estimation and tracking
− Error control coding and interleaving
• Objective: Be able to determine which of the four channel combinations is applicable under a
given set of assumptins.
• Example: What kind of fading is experienced by GSM?
− BW=200kHz, T = 3.7µsec, burst time= 0.57ms
− Carrier frequency= 890 − 915, 935 − 960MHz
− rms delay spread
· NYC: 1300ns(avg.), 3500ns(max) @ 900MHz
· Indoor: 10-50ns @ 1500MHz
− Mobility
· Train(300km/h), car(120km/h), pedestrian(4km/h)
− Is GSM frequency selective?
· στ = 3.5µ → BC = 5kHz and BW= 10kHz → frequency-selective
− Is GSM time selective?
· Take 1.9GHz
1h
· Train 300km/h · 3600s · 1000m
1km = 83m/s → fm = 525
· TC ' 1/fm = 1.9ms
· Burst is 0.5ms, so roughly constant
• Objective: Calculate a bound on the probability of symbol error for Rayleigh fading channels.
• The coherence time & coherence bandwidth determine the equivalent system model used to
design the receiver
− Flat/Slow: y[n] = hs[n] + v[n]
· Estimate s[n] = h− 1y[n]
2
· SN R = |h|N0Es
· If |h| is small, BER will increase. We can use diversity techniques.
− Flat/Fast: y[n] = h[n]s[n] + v[n]
75
· Estimate h[n] maybe using h[n − 1] (Channel tracking)
· Consider error control coding, interleaving, or time diversity
P
− Frequency selective/Slow: y[n] = l h[l]x[n − l] + v[n]
· Estimate h[l] at the Rx and equalize
P
− Frequency selective/Fast: y[n] = l h[l, n]x[n − l] + v[n]
· Use adaptive loops to estimate h[l, n] and equalize
• The impact of fading in the channel on symbol error rate depends on the type of fading mitigation
techniques employed
− For complex systems this may be estimated using Monte Carlo simulations
− For some special cases the average probability of error can be calculated
• Consider estimating the symbol error rate in a flat fading channel with discrete-time model
p
y[n] = Ex h[n]s[n] + v[n]
− Assuming independent detection this model works for both slow fading and fast fading
− We explicitly factor the Ex term out of the equivalent channel to make SNR computations
easier
− Model h[n] as an i.i.d. random variable
• Instantaneous symbol error rate for M-QAM is a random variable
r ! 2 r !2
Ex 1 Ex 2
3 1 Ex 3
Pe |h[n] = 4 1− √ Q |h[n]| −4 1− √ |h[n]|2 .
No M No M −1 M No M −1
• Rayleigh fading channel is the most common flat fading model, typically a worst-case model
− h[n] ∼ NC (0, 1) ⇒ h[n] = hR [n] + jhI [n] with hR [n] & hI [n] ∼ i.i.d. N 0, 21
76
x2
2. Chernoff bound: Q(x) ≤ e− 2
Es d 2
min |x|
2
Z
−
Pe (SNR) = e 4N0 fx (x)dx
x
Es d 2
» –
Es d 2 2
min |x| 1 −|x|2 min +1
Z Z
− 1 −|x|2 4N0
e 4N0 e dx = e dx
x π x π
h 2 i−1 − " |x|2
Es dmin 2
#−1
Z +1
4N0
E d
s min
+1
4N0
= h 2 i−1 e dx
E d
x π s4Nmin
0
+ 1
1
⇒ Pe (SNR) ≤ Es d2min
≈ SNR−1
4N0 +1
Figure 43: Probability of error curve comparing Gaussian and Rayleigh fading.
• Impact of Rayleigh fading is that much more SNR is required to achieve a target probability of
symbol error
Figure 44: Illustration of different diversity sources fading independently. The idea is to use a diversity
scheme to ride the peaks and avoid the valleys.
77
− Explicit form of diversity where multiple antennas are used for reception
− Exploit: combining, beamforming, or general DSP
− Easier to exploit antennas at the receiver, multiple transmit antennas require complex space-
time coding
− Receive diversity is used on most base stations in cellular systems, switched diversity is
used in IEEE 802.11
• Polarization diversity
− Explicit: send or receive data on multiple polarizations
− Exploit: similar to spatial diversity. Provides diversity advantage with small headsets (spac-
ing not required)
− Used on most base stations to accommodate different mobile device orientations
• Pattern (or angle) diversity
− Explicit: receive on multiple patterns, instead of multiple receive antennas
− Exploited: similar as array processing
− Less extensively studied than other forms of diversity
• Time diversity: receive data at different times
− Explicit: send data at multiple times. using coding and interleaving. ARQ.
− Exploited: similar as array processing but depends on the coding scheme
− Used in the GSM system (speech coded and interleaved over four GSM bursts)
• Frequency (or path) diversity
− Explicit: send data on multiple frequencies
− Implicit: use frequency selective equalizer
− Used in the GSM system, IEEE 802.11, IS-95, WCDMA, etc.
− Degree of diversity obtained depends on the type of receiver employed
• Selection diversity: process the received signal from the diversity branch with the largest instan-
taneous SNR
78
• Maximum ratio combining - the SNR maximizing combination of all diversity sources
y1 [n]
z[n] = w∗ .. ∗
=w y
.
yM [n]
∗ 2
s |w h|
Find W to maximize SNR → solve max E|w| 2
N w 0
m=1 m=1
√
M
∗ 2
|hm [n]|2 s[n] + w∗ v[n] and SNR = ENs |w|w|h|2 = |h|2 Es
P
Then, z[n] = Es N0
0
m=1
• Evaluating the symbol error probability
v M
u
2
u Ex d2min
P
|hm [n]|
u
Ex t m=1
Pe |h1 [n], ..., hM [n] ≤ αQ
No
2N0
v M
u
u Es d2min |hm [n]|2
u P
Ex t m=1
Pe ≤ Eh αQ
No
2N 0
M
Es d2 |hm [n]|2
P
min
m=1
−
≤ Eh αe 4N0
∗ −1
M dimensional NC (0, R) ∼ f (x) = 1
π M |R|
e−x R x
Hence,
" ∗
# ∗
Es d2
min h h Es d2
min h h
Z Z
− − 1 −h∗ h
Eh e 4N0 = ··· e 4N0 e dh
πM
Es d2
„ «
−1
−h∗ Es d2min
min +1
1 |R|
Z Z
4N0
h
= ··· e dh ←R= +1 I
π M |R| 4N0
1
= M
Es d2min
4N0 +1
Consequently,
Ex α
Pe = M
No Es d2min
4N0 +1
79
Figure 45: Illustration of the probability of error for different orders of diveresity assuming independent
Rayleigh fading.
2 Link Budget
• Objective: Calculate a bound on the probability of symbol error for Rayleigh fading channels.
• A link budget is an accounting of how power is “spent” in the link
• Helps determine cell range or area under different assumptions
− Type of service - influences target BER, data rate
− Type of environment (indoor, outdoor) - determines assumptions about channel
− System configuration - antennas, available power, losses, gains
− Coverage probability - determines allowable outage
− Cost - determines quality of hardware and associated parameters
• Typical link budget
− Transmit power
− Antenna gain
− Effective noise temperature
− Interference power
− Cable and body losses
− Model specific parameters like path-loss exponent, frequency, reference distance
− Small-scale fade margin - depends on amount of diversity available
− Shadowing variance
− Large-scale fade margin
− Range
• Typically one computes a link budget to find the given range but it can be used to backsolve for
basically any parameter e.g., required transmit power, antenna gain, noise figure, or diversity
order
• UMTS link budget calculation
− Go through link budget example
− Discuss how budget “adds up”
80
Figure 46: Example link budget from http://www.umtsworld.com/technology/linkbudget.htm for the uplink
of the UMTS cellular system.
81
Figure 47: Illustration of the hexagonal tessellation.
Ik is the k − th interferer with distance Dk . Typically consider the first tier of interferers.
− Assume log-distance path loss model Pr (d) = Pt (d/d0 )−n
S R−n
= P −n
I k Dk
− Uplink S/I calculation (generally easier) with hex cells and first tier of interference. All
interfering base stations are distance D away
S R−n Qn
= =
I 6(D)−n 6
− Downlink S/I calculation (generally harder) with hex cells and first tier of interference
S R−n
≈
I 2(D − R)−n + 2(D + R)−n + 2D−n
or
S 1
≈ −n
I 2(Q − 1) + 2(Q + 1)−n + 2Q−n
82
Assuming all interferers are distance D − R away (worst case)
S R−n (Q − 1)n
≈ =
I 6(D − R)−n 6
• Example of S/I calculations as a function of reuse
− Hex: N = 3, Q = 3, n = 2, S/Iup = 1.8dB,S/Idown ≈ −1.7dB
− Hex: N = 3, Q = 3, n = 4, S/Iup = 11.3dB,S/Idown ≈ 4.25dB
− Hex: N = 7, Q = 4.58, n = 4, S/Iup = 18.6dB,S/Idown ≈ 14.4dB
• SINR calculations
−1 −1 !−1
S S S
= + (37)
I + Noise I Noise
2 Improving S/I
Figure 48: Illustration of sectoring using either three sectors or six sectors.
− One approach for reducing interference is to employ cell sectoring courtesy of directional
antennas
− Basic idea is to divide up frequencies among different sectors
− Reduces the number of first tier interferers (60o sector has one strong interferer, 120o sector
has two strong interferers)
− Often expressed as N × K
· Uplink S/I calculation
S R−n Qn
= =
I 2(D)−n 2
· Downlink S/I calculation (worst case)
S R−n (Q − 1)n
≈ =
I 2(D − R)−n 2
− Example of S/I calculations as a function of reuse w/ sectors
· Hex: N = 3, Q = 3, n = 2, 3 sectors, S/Iup = 6.5dB,S/Idown ≈ 3dB
· Hex: N = 3, Q = 3, n = 4, 3 sectors, S/Iup = 16dB,S/Idown ≈ 9dB
· Hex: N = 7, Q = 4.58, n = 4, 3 sectors, S/Iup = 23dB,S/Idown ≈ 19dB
83
− Issues with sectors
· Loss in trunking efficiency since the frequencies are dividing among cells
· Sectors are not quite orthogonal in the presence of multipath interference
· Need to consider handoff between sectors
• Multiuser detection
− Refers to a broad class of signal processing techniques for mitigating effects of interference
− Typically use a model that includes structure of the interference, i.e. does not assume it is
Gaussian noise
p p I
X
y[n] = Ex h0 s0 [n] + Ex hk sk [n] + v[n]
k=1
2 Handoff
84