You are on page 1of 16

An Introduction to Multicarrier Modulation

Notes for ECE1520 Data Communications

Teng Joon Lim


Edwards S. Rogers Sr. Dept. of Elect. & Comp. Engineering
University of Toronto

Abstract
Multicarrier modulation helps to reduce the detrimental effects of multipath fading. Because of its
robustness to multipath, and the ease of implementating it in transmitters and receivers using the
fast Fourier transform (FFT), the MCM concept is growing rapidly in practical importance. It can
be found today in IEEE standards 802.11a, 802.15.3 and 802.16a, as well as standards for digital
broadcasting of television and radio. This document serves to derive the multicarrier modulation
method from first principles.

1 Scope and Objectives


Multicarrier modulation is an idea which was introduced over three decades ago and is of increasing
interest today because it can now be implemented using powerful integrated circuits optimized for
performing discrete Fourier transforms. Because of its increasingly widespread acceptance as the
modulation scheme of wireless networks of the future, it attracts a lot of research attention, in
areas such as time-domain equalization, peak-to-average ratio reduction, phase noise mitigation
and pulse shaping.
Despite the number of papers which have been written about multicarrier modulation in recent
years, a comprehensive review paper which covers the fundamentals of the topic for the beginning
graduate student is hard to find. This document hopes to set this anomaly right, and introduces the
newcomer to the fundamental operations of an OFDM system using little more than fundamental
concepts of signal processing and linear algebra.

2 Fundamental Concepts
2.1 Motivation
Consider a system in which the required symbol or baud rate 1/Tsym symbols/s is larger than the
coherence bandwidth of the channel 1/Tm . Tm is also known as the channel delay spread, and
can be visualized as the maximum time extent of the channel impulse response. The number of
symbols of inter-symbol interference (ISI) in the channel is given by
¹ º
Tm
L= , (1)
Tsym

where bxc is the largest integer smaller than the real number x. Clearly, the higher the required
symbol rate, the larger the value of L and the more severe ISI becomes for a given channel.

1
Introduction to Multicarrier Modulation 2

Traditionally, ISI is removed using an equalizer, which may be implemented either in the time
or frequency domains, with symbol-by-symbol or sequence estimation algorithms. However, the
complexity of an equalizer increases with the severity of the ISI introduced by the channel, and
in the modern context of wireless networks with broadband links providing several mega-bits per
second (e.g. 802.11a promises 54 Mbps), it may not be practical to implement an equalizer at all
because of overwhelming complexity.
On the other hand, if we could somehow reduce the symbol rate so that ISI becomes negligible
(ie. L = 0 or at least a very small integer) while still maintaining the required information bit
rate, equalization becomes unnecesssary. One way to do this is simply to increase the level of
modulation in an M -ary pulse modulation scheme but there is a limit on how large M can be
before modulation and demodulation complexity becomes overwhelming. For instance, suppose we
have 100 symbols of ISI (L = 100) which is realistic for transmissions at mega-bps over wireless
channels. Let each symbol carry only one bit. Then to increase the symbol interval to the extent
that L becomes close to nothing requires each symbol to carry 100 bits, or M = 2100 , which would
be impossible to modulate or demodulate.
The other way to increase the symbol interval is through parallel transmission over many
orthogonal channels. Continuing with the previous example, if we choose 100 channels to transmit
over, each one will transport only one bit, e.g. using BPSK, per T = 100·Tsym seconds, and ISI will
be avoided on all channels. To create these 100 orthogonal channels requires us to design a set of
100 signals gn (t), n = 0, . . . , 99, that are mutually orthogonal. If we constrain bandwidth usage to
be the same in the serial and parallel transmission schemes, we can use gn (t) = exp(j2πfn t)w(t),
where fn − fn−1 = 1/T and w(t) = u(t) − u(t − T ) is a rectangular window of length T seconds.
The bandwidth occupied by these 100 pulses is approximately 100/T Hz, which is identical to the
1/Tsym Hz required by the serial transmission scheme.

So the lesson so far: To create N orthogonal channels for transporting N symbols at a symbol
rate of 1/Tsym , we can use N complex sinusoids with frequency separation 1/N Tsym Hz that will in
total occupy 1/Tsym Hz, or the same bandwidth as the serial transmission scheme... in an AWGN
channel.

Question: Are these channels still orthogonal and thus easy to demodulate (by processing each
one independently of the others) in the severe ISI channel we face in broadband transmission?

Answer: Yes, but at the cost of some decrease in spectral efficiency, through the insertion of a
“cyclic prefix”. This will be explained shortly (with the aid of some mathematics).

Multicarrier modulation can be seen as a parallel transmission scheme developed to mitigate ISI
through the lengthening of the symbol interval – this removes ISI in time, i.e. symbols transmitted
in succession fusing together. However, ISI in frequency i.e. interference from other symbols being
transmitted at the same time over different carriers, is non-negligible unless the cyclic prefix method
is used.

2.2 Signal Model for an AWGN Channel


From the description of the previous section, we can write the baseband-equivalent transmitted
signal over one symbol interval (T = N Tsym where N is the number of orthogonal carriers used)
as
N/2
X
s(t) = an mod N gn (t) (2)
n=−N/2+1
Introduction to Multicarrier Modulation 3

Bit Rate Bit Rate Symbol Rate Symbol Rate


M/RTsym M/Tsym 1/Tsym 1/T
-¾ -¾ -¾
ejω−N/2+1 t
- ×?
i -

ejω−N/2+2 t

Freq. Serial - ×?
i -
- Error - Modul- - Inter- - to q Σ - Amp/
Encode ation q Filter
leave Parallel q
ejωN/2 t

R = Code Rate - ×?
i -

Fig. 1: Conceptual multicarrier transmitter. ωn is defined as n∆ω, ∆ω = 2π/T . n ranges


from −N/2 + 1 to N/2 as described in the text.

where the N pulse shapes are


1
gn (t) = √ exp [j2πfn t] w(t). (3)
T

The scale factor 1/ T has been added to make the energy of each pulse unity. The notation
n mod N is read “n modulo N ”, and is the unique number within the range [0, N ] given by n + iN ,
where i is an integer (positive or negative). For instance, 4 mod 3 = 4 − 3 = 1; (2P + 3) mod P =
(2P + 3) − 2P = 3; −10 mod 4 = −10 + 12 = 2. Therefore the pulse gn (t) is associated with an
when n = 0, . . . , N/2; but gn (t) is associated with an+N when n = −N/2 + 1, . . . , −1. The reason
for this convoluted notation arises from the use of the IDFT to generate the transmitted signal
(see next section).
The frequencies satisfy fn − fn−1 = 1/T for orthogonality, so assuming that f0 = 0 we have
fn = Tn for n = −N/2 + 1, . . . , N/2. After up-conversion by the carrier frequency fc , the signal
N N
spectrum ranges (approximately) from fc − 2T to fc + 2T .
The conceptual transmitter block diagram is shown in Figure 1. The information bit stream
is first passed through an error correction encoder, and then a baseband pulse modulator, which
maps M bits at a time onto a complex symbol according to some predefined signal constellation.
If necessary, symbol streams from other users or services can be multiplexed at this point, and
the resulting sequence interleaved to randomize the allocation of carriers to symbols. This ensures
that, on average, a faded carrier will affect all streams in the multiplex equally. Next, N successive
symbols are buffered before each is used to modulate a complex sinusoid. Finally, these sub-carrier
signals are summed, amplified and filtered before being transmitted.
At the receiver, assuming s(t) was transmitted over an AWGN channel so that r(t) = s(t)+n(t)
where n(t) is a white Gaussian process with PSD N0 , the optimal projection receiver consists of
a bank of filters matched to gn (t), since the set {gn (t)} forms an orthonormal basis for the signal
Introduction to Multicarrier Modulation 4

subspace. The output of the nth matched filter is


Z T
1
yn = √ r(t) exp(−j2πfn t)dt
T 0
= an mod N + vn (4)

where vn ∼ CN (0, N0 ). Due to the orthogonality of {gn (t)}, vn and vm are independent whenever
m 6= n. Equation (4) show that the symbols {a0 , . . . , aN −1 } are transmitted over orthogonal
channels, and that the performance in every sense (BEP, spectral efficiency, etc.) of the minimum-
distance detector in an AWGN channel is unchanged by the use of MCM.

2.3 A Frequency Selective Channel


MCM or OFDM is only useful when dealing with frequency-selective channels, which cannot be
used at all without equalizers using conventional single-carrier methods. If the channel impulse
response is h(t), the received signal is
Z ∞
r(t) = h(τ )s(t − τ )dτ + n(t). (5)
−∞

If h(t) is non-zero from t = 0 to t = Tm only, r(t) may be simplified to


Z Tm
r(t) = h(τ )s(t − τ )dτ + n(t). (6)
0

If r(t) is processed by a bank of filters matched to gn (t), the mth output will be
N
X −1 Z Tm Z T

ym = an h(τ )gn (t − τ )gm (t)dt dτ. (7)
n=0 0 0

Since hgn (t − τ ), gm (t)i is not zero for all values of τ , it appears that ym is a linear combination of
all N symbols {a0 , . . . , aN −1 } or in other words, the MCM system has lost its orthogonality in a
time-dispersive channel h(t).
There is no doubt that the last statement is true, but in the next section we will show that
the DFT/IDFT implementation of OFDM reveals a simple solution to the problem.

2.4 Discrete-Time Implementation Using the DFT/IDFT


If OFDM were actually to require N very precise frequency generators in each transmitter and
receiver, it would be a prohibitively expensive system. Practical implementation relies on the fact
that the transmitted signal can be generated using an inverse discrete Fourier transform (IDFT).
Referring to (2), we note that for a given set of symbols {an }, s(t) has a spectrum which
consists of the weighted sum of a number of sinc functions, each with main-lobe bandwidth 2/T
and centered on fn . Clearly the bandwidth is approximately N/T , but a substantial fraction of
the energy of s(t) lies outside f ∈ (−N/2T, N/2T ), and s(t) will not be correctly represented
by sampling it at a rate of N/T . However, if a number of carriers at the edges of the band
(−N/2T, N/2T ) are unused (i.e. an = 0 for n = N/2 − p + 1, . . . , N/2 + p for some integer p ¿ N ),
then s(t) will approximately be given by its samples taken at the rate of N/T . This means that
s(t) can be reconstructed from its samples s(kT /N ). Therefore, assume that s(t) is band-limited
Introduction to Multicarrier Modulation 5

Insert
a0 - s0 - Cyclic
Prefix
a1 - s1 -
r ?
r sk - i s(t)
IDFT P/S + - DAC -
r
r N +P
r Rate T
aN −1 - sN −1
-

Fig. 2: Block diagram of OFDM transmitter with cyclic prefix insertion. P is the number
of samples in the cyclic prefix.

to within a bandwidth of N/T Hz because the carriers near the band edge are unused. Sampling
s(t) at rate N/T yields
N/2
X µ ¶ N/2
X
kT 1
sk = an mod N gn =√ an mod N exp (j2πfn kT /N )
N T
n=−N/2+1 n=−N/2+1
N −1 µ ¶
1 X 2πnk
= √ an exp j . (8)
T n=0 N

Note the change in summation limits from −N/2 + 1, . . . , N/2 to 0, . . . , N − 1 compared to (2).
This is valid because exp(j2πnk/N ) = exp(j2π(n + N )k/N ), and replacing the n < 0 complex
sinusoidal terms in (2) with exp(j2π(n + N )k/N ) gives (8).
Now, the IDFT of a sequence of N complex numbers Xn is another sequence of N complex
numbers xk given by
N −1 µ ¶
1 X 2πnk
xk = Xn exp j (9)
N n=0 N
when the DFT is defined as
N
X −1 µ ¶
2πnk
Xn = xk exp −j . (10)
N
k=0

Therefore, (8) says that we can generate N samples of sk through the DFT of an . In addition,
because of our assumption that s(t) is (almost) strictly bandlimited, the continuous-time signal
s(t) to be transmitted can be constructed from sk using a digital-to-analog converter at the rate of
N/T Hz. The block diagram
√ of this implementation is shown in Figure 2, where we have ignored
the scaling factor N/ T necessary for a strictly accurate implementation.

Example√ Consider a multi-carrier system with constant-envelope PSK pulse modulation so that
|an | = Es for all n. Then the signal s(t) of (2) has a spectral density that is the sum of sinc
functions, each with mainlobe width 2/T and centered at n/T , n = −N/2 + 1, . . . , N/2. This is
shown in the top half of Figure 3 where for simplicity, we assume T = 1 and N = 16.
The spectrum of the discrete-time signal sk of (8) is a periodic extension in frequency of the
PN −1
spectrum of n=0 an exp(j2πnt/T )w(t), which is itself a sum of sinc functions separated by 1/T
Hz and centered on n/T Hz, where n = 0, . . . , N − 1. This is shown in Figure 3(b).
Introduction to Multicarrier Modulation 6

Next, the digital-to-analog converter (DAC) output is the lowpass filtered version of Figure 3(b)
– the passband of the lowpass filter is the region between the two thick dashed lines. Clearly, if the
carriers near the edge of the passband, i.e. n = N/2 + 1, . . . , N/2 + p and n = N/2 − p + 1, . . . , N/2,
are turned off, the spectra of the DAC output and s(t) will be nearly identical. This demonstrates
that the DFT/DAC combination is capable of producing an OFDM signal.

The receiver is designed to be implementable using the DFT – it is a bank of filters matched
to the nth carrier waveform gn (t) rather than to h(t) ∗ gn (t) as it should be in theory. Since gn (t)
is associated with the (n mod N )th symbol, we label the matched filter outputs accordingly and
find Z Z

yn mod N = r(t)gn (t)dt = r(t) exp(−j2πfn t)dt, (11)

where again, we have left out the scaling term for simplicity. Note that in this expression, n runs
from −N/2 + 1 through N/2. Next, since the signal component of r(t), which is h(t) ∗ s(t), is
bandlimited by assumption to (−N/2T, N/2T ), we can sample r(t) at rate N/T (after lowpass
filtering) without loss of information, and express yn mod N as
N
X −1 µ ¶
2πnk
yn mod N = rk exp −j (12)
N
k=0

to within a scale factor1 .


If we define n0 = n mod N , then n0 goes from 0 through N − 1, and substitution in (12) yields
N
X −1 µ ¶
2πn0 k
yn0 = rk exp −j (13)
N
k=0

where the right-hand side holds because of the periodicity of the complex exponential. Therefore
y0 to yN −1 are obtained through the DFT of the samples r0 through rN −1 , where rk = r(kT /N ).
This results in the receiver structure shown in Figure 4.

2.5 The Cyclic Prefix


The question now is: how do we ensure that yn does not suffer from interference from symbols
am , m 6= n? The answer comes from a well-known result in digital signal processing which states
that circular convolution in the discrete-time domain is equivalent to multiplication in the discrete-
frequency domain.
To be precise, suppose xk is a length-N sequence. Its circular convolution with another se-
quence {hk }k=0,...,N −1 is defined as
N
X −1 N
X −1
yk = xk ~ hk = hl x(k−l) mod N = xl h(k−l) mod N . (14)
l=0 l=0

This is the same as periodically extending hl and xl to form the periodic sequences h̃l and x̃l , and
then summing h̃l x̃k−l over one period of N samples, as illustrated in Figure 5 for k = 0 and N = 3.
PN −1
Then the DFT of yk , k = 0, . . . , N − 1, is Yn = Hn Xn where Hn = k=0 hk exp(−j2πnk/N ).
The proof of this result is straightforward and left as an exercise.
1
Calculating these scale factors is not important and is left to the interested reader.
Introduction to Multicarrier Modulation 7

0.9

aN/2+1
aN/2
0.8

0.7

0.6

0.5

0.4

0.3

0.2

0.1

0
−15 −10 −5 0 5 10 15
Frequency (normalized so that T = 1)

(a)
1

0.9

0.8 a0
aN−1

0.7

0.6

0.5

0.4

0.3

0.2

0.1

0
−25 −20 −15 −10 −5 0 5 10 15 20 25
Frequency (normalized so that T = 1)

(b)

Fig. 3: (a) Spectrum of the desired OFDM baseband continuous-time signal s(t). (b)
Spectrum of the DFT output before (an endless repetition of the fundamental
segment shown in solid lines) and after (the part between the two dashed thick
lines) the DAC.
Introduction to Multicarrier Modulation 8

r0 - - y0
n(t)
r1 - - y1
s(t)- h(t) - +? Remove rk -
i r(t)- ADC - Cyclic S/P DFT
Prefix
(N +P )
Rate T rN −1
- - yN −1

Fig. 4: Block diagram of OFDM receiver based on the DFT.

d x−l d x̃−l d d
d d d d
-
d d d d

× × × - hk ~ xk |k=0
d d d d
h̃l
hl d d d d
-
d d d d

l 0 1 2 ··· 0 1 2 ···

Fig. 5: Circular convolution of xk and hk , both having three non-zero samples, so N =


3. Note that the convolution window can be moved to span any three sampling
intervals, and the result will remain the same.
Introduction to Multicarrier Modulation 9

In OFDM, the baseband received signal sampled at rate N/T is obtained by passing the
sampled transmitted signal sk through a linear channel with discrete-time impulse response hk ,
and then adding receiver noise nk i.e.
L−1
X
rk = hk ∗ sk + nk = hl sk−l + nk (15)
l=0

where ∗ denotes linear convolution. hk is obtained from the continuous-time channel response h(t)
by setting t = kT /N . In fact, when L ¿ N which is the usual case, linear convolution is identical
to circular convolution, except at the beginning and end of the sequence.
To make the two operations exactly identical, we can periodically extend the input xk , as
shown in Figure 6, by P samples where P ≥ L − 1. The input sequence will now have length
N + P , so that the output sequence will have N + P + L − 1 samples. The N output samples at
times P + 1 through N + P can be shown to be the output of a circular convolution operation:
L−1
X
yk = hl x(k−l) mod N = hk ~ xk , k = P + 1, . . . , N + P. (16)
l=0

It is very important to note that the equivalence between linear and circular convolution exists
only under the following conditions:
1. The cyclic prefix is longer than the channel delay spread or P ≥ L − 1;
2. The observation window applied to the output spans the samples P + 1 through N + P –
translating the window in either direction invalidates the result.
Assuming these conditions hold, we can now state the following theorem:

Theorem 1: For a discrete-time channel hk of length L, and a channel input sk that is periodically
extended in its preamble by P ≥ L − 1 samples where {s0 , . . . , sN −1 } = IDFT{a0 , . . . , aN −1 }, the
channel output rk = hk ∗ sk + nk has the property that

rk = hk ~ sk + nk , k = P + 1, . . . , N + P, (17)

with ~ representing circular convolution. The DFT of {rP +1 , . . . , rN +P } is, by the duality between
circular convolution in the time domain and multiplication in the discrete frequency domain,

y = Fr = hf ◦ a + n (18)

where all vectors have N complex elements, x ◦ y is the element-wise product of vectors x and
y, Fn,k = exp(j2πnk/N ) is the DFT matrix, hf = Fh is the N th-order DFT of h and n is a
circularly symmetric Gaussian vector with covariance matrix N0 I. ¥

In scalar notation, the nth DFT output is yn = Hn · an + noise, where Hn is the nth DFT
N −L
z }| {
coefficient of {h0 , . . . , hL−1 , 0, . . . , 0}. Since the nth “matched filter” output is independent of am ,
m 6= n, the cyclic prefix together with the DFT/IDFT implementation of the transceiver creates
N orthogonal flat-fading channels.
Introduction to Multicarrier Modulation 10

d
d
hl
d
d d d d d d d d d
× × × × × × × × × × × × - yN +1 = hk ∗ xk |k=N +1
d (Linear convolution)
d
xN +1−l d
d
d
d d d
d
d
d
d

d
d
hl
d
d d d d d d d d d
× × × × × × × × × × - yk = hk ~ xk
d k = 2, . . . , N + 1
d (Linear convolution, but these
d
x̃N +1−l d N samples identical to output
d of circular convolution.)
d
d
d
d d
d d

Fig. 6: Adding a cyclic prefix to the input signal makes linear convolution look like circular
convolution, and removes ISI in the OFDM signal. In this example, the input
sequence length is N = 10, the channel response length is L = 3. If the input has
a cyclic prefix of length L − 1 = 2, the N outputs {y2 , . . . , yN +1 } are obtained by
circular convolution of xk and hk .
Introduction to Multicarrier Modulation 11

2.6 Single-Tap Equalization


Since yn = Hn an + vn where E[vm vn∗ ] = N0 δm,n , to recover an one can estimate Hn (usually
through the periodic transmission of known pilot symbols) and then form the statistic
yn vn
ân = ≈ an + (19)
Ĥn Ĥn

where Ĥn is the latest estimate of Hn . A slicer is then applied to ân to obtain hard decisions on an .
This approach comes from minimum-distance detection applied independently to each yn , which
will produce the minimum symbol error probability decision given that vm and vn are independent.

2.7 Loss in Spectral Efficiency


When a cyclic prefix of P samples is added to the block of N samples in time, the sampling rate (at
the DAC) needs to increase to (N + P )/T because the N + P samples still need to be transmitted
over T seconds. The lowpass filter at the DAC will have a cutoff frequency of (N + P )/2T Hz.
So the spectrum of the transmitted signal with cyclic prefix inserted occupies about (N + P )/2T ,
whereas without the prefix, it occupies only N/2T Hz. In that sense, the prefix has “wasted” P/2T
Hz of bandwidth since it does not carry any information and there is a fractional loss of P/(N + P )
in spectral efficiency.
So it is clear that inserting the cyclic prefix to solve the ISI problem comes at a price, and in
practice we always strive to make P as small a fraction of N as possible to limit the wastage of
bandwidth.

3 Advanced Topics
3.1 Frequency Offset in a Multi-User OFDMA Uplink
OFDM can be used to provide channel access to a number of users, much like FDMA (frequency
division multi-access) except that frequency bands used by different users need not be separated by
a guard band. This gives OFDMA a potentially higher spectral efficiency than FDMA. However,
OFDMA is very sensitive to frequency offsets, which may come from mismatches in the local
oscillators at transmitter and receiver ends of the link, or Doppler shifts in the case of mobile
applications. We now quantify the effects of frequency offsets.

3.1.1 Signal Model


Let Pk = {πk (1), . . . , πk (Nk )} be the set of carriers allocated to user k, and let {dk,p , p ∈ Pk } be
the Nk symbols transmitted by user k in some OFDM symbol. We assume that the guard interval
inserted into each OFDM symbol is long enough to prevent inter-symbol interference, and hence
the OFDM symbol index will be ignored. For a frequency offset of δωk , the continuous-time signal
transmitted by user k will be
 X

 ejδωk t dk,p ejωp t 0<t≤T

X p∈P
xk (t) = jδωk t
k
(20)

 e
 dk,p ejωp (t+T ) −Tg < t ≤ 0
p∈Pk

where T is the OFDM symbol interval, and Tg is the guard interval. ωp denotes the reference
frequency for the pth carrier, which in baseband-equivalent form would be ωp = 2πp/T . (With
Introduction to Multicarrier Modulation 12

pulse shaping to limit the bandwidth of the transmitted signal, the actual transmitted signal will
be xk (t) ∗ p(t) where p(t) is the impulse response of the pulse-shaping filter. However, since p(t)
can be absorbed into the channel, we lose no generality in treating xk (t) as the transmitted signal
and gain notational simplicity.)
The signal received from user k will be the convolution of xk (t) with the kth channel impulse
response hk (t), or
yk (t) = xk (t) ∗ hk (t). (21)
If we sample the received signal above its Nyquist rate and discard the cyclic prefix, we find that
the linear convolution becomes equivalent to a circular or periodic convolution, or

yk [n] = xk [n] ~ hk [n] (22)

with n = 0, . . . , N − 1 where N is the number of samples in T seconds, and xk [n] = xk (nT /N ).


Note that the sampling rate is N/T – if the carriers near the band edges are not used, then the one-
sided bandwidth of the OFDM signal is Nc /2T , and hence N = Nc will yield sufficient statistics
for the detection of all transmitted symbols. We therefore assume that N = Nc .
The discrete-time Fourier transform (DTFT) of yk [n] is simply the product of the DTFT’s of
xk [n] and hk [n], or
Yk (Ω) = Xk (Ω)Hk (Ω). (23)
We can show from first principles that Xk (F ) is a sum of frequency-shifted Dirichlet functions2 :
X
Xk (Ω) = dk,p drcl (Ω − (δωk + ωp )T /Nc , Nc ) (24)
p∈Pk

where
4 sin(N x/2)
drcl(x, N ) = . (25)
N sin(x/2)
P
To be more concise, we can write Xk (Ω) = p∈Pk dk,p Sk,p (Ω).
The complete received signal in the frequency domain is therefore
K
X K
X
Y (Ω) = Yk (Ω) + W (Ω) = Hk (Ω)Xk (Ω) + W (Ω) (26)
k=1 k=1
K
X X
= Hk (Ω) dk,p Sk,p (Ω) + W (Ω), (27)
k=1 p∈Pk

where W (Ω) is complex AWGN. In vector notation, treating Y (Ω), −π < Ω ≤ π as a vector y and
similarly converting all other frequency functions to vectors, we have
K
X
y= Hk Sk dk + w (28)
k=1

where Hk = diag(hk ), hk is the vector representing Hk (Ω), Sk = [sk,πk (1) , . . . , sk,πk (Nk ) ] and
dk = [dk,πk (1) , . . . , dk,πk (Nk ) ]. Finally, we can also write

y = HSd + w (29)

with H = [H1 , . . . , HK ], S = diag[S1 , . . . , SK ] and d = [dT1 , . . . , dTK ]T .


2
Complex scaling term ignored.
Introduction to Multicarrier Modulation 13

0.8

0.6

0.4

0.2

−0.2

−0.4
−4 −3 −2 −1 0 1 2 3 4
Ω (rad/s)

Fig. 7: 15 instances of Sk,p (Ω), with zero frequency offsets. Nc = 16.

3.1.2 Interpretations
The Dirichlet function defined in (25) is central to our analysis so we should study it more closely.
The following properties are important:
1. drcl(x, N ) has zero crossings at x = 2πp/N for integer p;
2. drcl(0, N ) = 1.
In this sense, the Dirichlet function is similar to the sinc function sinc(N x/2) where sinc(x) =
sin x/x. In fact, a plot of the two functions would be virtually indistinguishable.
If all users transmit over AWGN channels with unit gain, i.e. hk = 1, then the frequency-
domain received signal will be a linear combination of Dirichlet functions, plotted in Figure 7 where
we assumed 16 carriers. This is the spectrum or discrete-time Fourier transform (DTFT) of the
sequence y[n].
When the channels are frequency selective, the received signal will be a linear combination
of distorted versions of these Dirichlet functions, namely Hk (Ω)Sk,p (Ω), such as those plotted in
Figure 8. In this figure, the vertical lines indicate the frequencies Ω = 2πp/Nc – notice that at
these frequencies, all but one of the functions are zero. This is due to these frequencies being at
the zero crossings of the shifted Dirichlet functions of Figure 7.
In the presence of frequency offsets, the received signal becomes a linear combination of shifted
Dirichlet functions, which no longer all have zero crossings at Ω = 2πp/Nc . For instance, with four
users each having its own frequency offset, Sk,p (Ω) will look like the curves in Figure 9.
Introduction to Multicarrier Modulation 14

0.5

0.4

0.3

0.2

0.1

−0.1

−0.2

−0.3

−0.4

−0.5
−4 −3 −2 −1 0 1 2 3 4
Ω (rad/s)

Fig. 8: 15 instances of Hk (Ω)Sk,p (Ω), with zero frequency offsets.

3.1.3 Interference Introduced by Frequency Offset


Given that the desired component of y(t) is bandlimited to [−Nc /2T, Nc /2T ], sampling at the rate
of Nc /T over one OFDM symbol interval will yield sufficient statistics for detecting d. So the Nc
samples y(nTc /N ), n = 0, . . . , Nc − 1, are sufficient statistics, and any invertible function applied
to them will yield sufficient statistics too. In particular, the continuous-frequency function Y (Ω)
must be sufficient for detecting d since the DTFT is invertible. But since there are a total of Nc
independent symbols transmitted using Nc linearly independent vectors, the set {y(nTc /N ), n =
0, . . . , Nc − 1} is a minimal set of sufficient statistics, whereas the function Y (Ω) is not minimal.
A minimal set of sufficient statistics in the frequency domain is obtained by sampling Y (Ω) at
Nc points in [−π, π]3 . The most convenient Nc points to take are of course those evenly spaced
over [−π, π], in other words Y (2πp/Nc ), p = −Nc /2, . . . , Nc /2. These are directly found from the
discrete Fourier transform (DFT) of y[n].
We already established that in the absence of frequency offset, the frequency-domain received
signal is
y = HSd + w (30)
where the columns of HS have the property that their zero crossings match. Sampling y at intervals
of 2π/Nc will give
ȳ = Ad + w̄ ∈ CNc (31)
where A is a diagonal matrix, made up of the respective channel frequency responses at frequencies
2πp/Nc .
3
This is guaranteed since any set of Nc points in Y (Ω) is generated from a multiplication of the time-
domain received-signal vector with an invertible matrix.
Introduction to Multicarrier Modulation 15

0.8

0.6

0.4

0.2

−0.2

−2 −1.5 −1 −0.5 0 0.5 1 1.5 2


Ω (rad/s)

Fig. 9: Some of the frequency-domain basis functions for xk [n], with frequency offset. Ob-
serve that at frequencies Ω = 2πp/Nc , marked by the dashed vertical lines, several
of these functions will be non-zero, in contrast to the zero offset case.
Introduction to Multicarrier Modulation 16

Since A is diagonal, there is no interference in the minimal frequency-domain sufficient statistics


ȳ, and optimal detection proceeds on a per-user basis.
When frequency offset is present, then the columns of HS do not have the same zero crossings
(except those belonging to the same user), as we can see from Figure 9. Uniform sampling of Y (Ω)
will then give (31) but with a non-diagonal A, indicating non-zero multi-user interference.
The most important point proven here is that frequency offset in an OFDMA system creates
multi-user interference. Whether the offsets can be estimated and then used in multi-user detection,
or whether practical frequency offsets are small enough to avoid serious performance issues are
topics for future discussion.

You might also like