SlideShare a Scribd company logo
1 of 5
Download to read offline
12 N. KOSTOV, MOBILE RADIO CHANNELS MODELING IN MATLAB
Mobile Radio Channels Modeling in MATLAB
Nikolay KOSTOV
Department of Radio Engineering, Technical University of Varna, Student 1, 9010 Varna, Bulgaria
n_kostov@mail.bg
Abstract. In this paper, a MATLAB based approach for
mobile radio channels modeling is presented. Specifically,
the paper introduces the basic concepts for modeling flat
fading channels in MATLAB by means of user-defined m-
files. Typical small-scale fading channel models are deri-
ved such as uncorrelated Rician fading channel and Ray-
leigh fading channel with Doppler shift. Further, simple
and useful MATLAB constructions for approximation of
cumulative distribution functions (CDFs) and probability
density functions (PDFs) are also given. Finally, a MAT-
LAB based Monte Carlo simulation example is presented,
which comprises performance estimation of phase shift
keying (PSK) signaling over a Rician fading channel.
Keywords
MATLAB, fading channels, distribution, simulation.
1. Introduction
In digital communication theory the most frequently
assumed model for a transmission channel is the additive
white Gaussian noise (AWGN) channel. However, for ma-
ny communication systems the AWGN channel is a poor
model, and one must resort to more precise and complica-
ted channel models. One basic type of non-Gaussian chan-
nel, which frequently occurs in practice, is the fading chan-
nel. A typical example of such a fading channel is the mo-
bile radio channel, where the small antennas of portable
units pick up multipath reflections. Thus, the mobile chan-
nel exhibits a time varying behavior in the received signal
energy, which is called fading.
Using MATLAB for digital communication systems
simulation one has the advantage of exploiting the power-
ful features of its Communications Toolbox along with
a nice programming language. However, the Communica-
tions Toolbox of MATLAB suffers from absence of proper
mobile channel models. The only available channel model
in the current Communications Toolbox 2.1 is the awgn m-
file, which is appropriate for an AWGN channel simula-
tion. So, the users of MATLAB should build appropriate
channels (i.e., m-files) in their own to reach the desired
simulation model.
The paper is organized as follows. In Section 2, a
brief introduction to fading channels is given. The basic
concepts for modeling flat fading channels in MATLAB
are presented in Section 3. In this section, example m-files
are proposed to model different types of flat fading chan-
nels. In Section 4, a MATLAB based Monte Carlo simula-
tion example is presented, which describes the basic con-
cepts of digital modulations performance estimation over
fading channels. Finally, the concluding remarks are given
in Section 5.
2. The Mobile Radio Channel
The mobile radio channel is characterized by two
types of fading effects: large-scale fading and small scale
fading [1], [2]. Large-scale fading is the slow variation of
the mean (distant-dependent) signal power over time. This
depends on the presence of obstacles in the signal path and
on the position of the mobile unit. The large-scale fading is
assumed to be a slow process and is commonly modeled as
having lognormal statistics. Small-scale fading is also cal-
led Rayleigh or Rician fading because if a large number of
reflective paths is encountered the received signal envelope
is described by a Rayleigh or a Rician probability density
function (PDF) [3]. The small-scale fading under conside-
ration is assumed to be a flat fading (i.e., there is no inter-
symbol interference). It is also assumed that the fading le-
vel remains approximately constant for (at least) one sig-
naling interval. With this model of fading channel the main
difference with respect to an AWGN channel resides in the
fact that fading amplitudes are now Rayleigh- or Rician-
distributed random variables, whose values affect the signal
amplitude (and, hence, the power) of the received signal.
The fading amplitudes can be modeled by a Rician or
a Rayleigh distribution, depending on the presence or ab-
sence of specular signal component. Fading is Rayleigh if
the multiple reflective paths are large in number and there
is no dominant line-of-sight (LOS) propagation path. If
there is also a dominant LOS path, then the fading is Ri-
cian-distributed. The fading amplitude ri at the ith time in-
stant can be represented as
22
)( iii yxr ++= β , (1)
where β is the amplitude of the specular component and xi,
yi are samples of zero-mean stationary Gaussian random
processes each with variance σ0
2
. The ratio of specular to
defuse energy defines the so-called Rician K-factor, which
is given by
RADIOENGINEERING, VOL. 12, NO. 4, DECEMBER 2003 13
2
0
2
2/ σβ=K . (2)
The best- and worst-case Rician fading channels associated
with K-factors of K = ∞ and K = 0 are the Gaussian and
Rayleigh channels with strong LOS and no LOS path, res-
pectively. So, the Rayleigh fading channel can be conside-
red as a special case of a Rician fading channel with K = 0.
The Rician PDF is given by [3]
[ ] 02/)(exp)( 2
0
0
2
0
22
2
0
≥





+−= r
r
Ir
r
rfRice
σ
β
σβ
σ
, (3)
where I0[.] is the zero-order modified Bessel function of the
first kind. Now, if there is no dominant propagation path,
K = 0 and I0[.] = 1 yielding the worst-case Rayleigh PDF
[ ] 02/exp)( 2
0
2
2
0
≥−= rr
r
rfRayleigh σ
σ
. (4)
The Rician cumulative distribution function (CDF) takes
the shape of [3]
( ) ∑
∞
=






⋅



−−=
0
2
0
exp1)(
m
m
m
Rice
r
I
r
rC
σ
ββ
γ , (5)
where γ = (K + r2
/ 2σ0
2
). Clearly, this formula is more dif-
ficult to evaluate than the PDF of (3) due to the summation
of an infinite number of terms. However, in practical terms
it is sufficient to increase m to the value, where the last
terms contribution becomes less than 0.1 percent.
0 200 400 600 800 1000
-20
-15
-10
-5
0
5
Samples
Amplitude/RMS(dB)
Fig. 1. A typical Rician fading envelope for K = 5 dB.
Having described the main fading statistics let us consider
the effects of the Doppler frequency shift. Doppler shift
from the carrier frequency fc occurs when the distance bet-
ween the mobile receiver and the transmitter is changing.
The magnitude of the Doppler frequency shift fm is determi-
ned by
c
fv
f c
m = , (6)
where ν is the mobile station velocity and c = 3⋅108
m/s is
the speed of light. The Doppler frequency fm is often called
fading bandwidth or fading fate of the channel. The rela-
tionship between fm and the coherence time Tm of the chan-
nel (i.e., the time over which the channel’s response to a
sinusoid is essentially invariant) is given by [1]
m
m
f
T
5.0
≈ . (7)
The Doppler power spectral density S(f) of the mobile
channel is often expressed as [4], [5]
2
)/(1
1
)(
mm fff
fS
−
=
π
. (8)
The above equality holds for frequency shifts of f in the
range ±fm about the carrier frequency fc.
Some important notes are in order here. First, the pri-
mary factor, which affects the performance of digital com-
munication systems in a mobile environment, is the small-
scale fading. So, we will consider Rayleigh and Rician fa-
ding channels from now on. Second, uncorrelated Ray-
leigh- or Rician-distributed fading sequences can be obtai-
ned directly by exploiting (1). Third, correlated fading se-
quences can be obtained by means of “colored” Gaussian
noise processes. A well-known approach is the so-called
sum-of-sinusoids method in which a “colored” Gaussian
noise is approximated by a finite sum of weighted and pro-
perly designed sinusoids [5]-[8]. In this paper we opt on the
modified sum-of-sinusoids method as described in [8], be-
cause of its improved statistical properties and simple
software realization.
3. Fading Generation in MATLAB
Let us first consider the generation of uncorrelated
Rician-distributed fading sequences in MATLAB. The
mean-squared value of the Rician distribution is known to
be 2σ0
2
( K + 1), where σ0
2
is the variance of the component
Gaussian noise processes in (1). Further, it is often required
a Rician distribution with unit mean-squared value, i.e.,
E{r2
} = 1, so that the signal power and the signal-to-noise
ratio (SNR) coincide. In order to meet the requirement
E{r2
} = 1, the equation (1) can be written in the form
)1(2
)2( 22
+
++
=
K
yKx
r ii
i
, (9)
where now xi, yi are samples of zero-mean stationary Gaus-
sian random processes each with variance σ0
2
= 1. So, the
desired Rician fading sequences can be generated accor-
ding to (9) by using the MATLAB random number genera-
tor randn, which produces normally distributed random
numbers. The following MATLAB m-file rice_fading
does the task.
function r = rice_fading(Kdb, N, Mi)
K = 10^(Kdb/10); const = 1/(2*(K+1));
x = randn(1,N); y = randn(1,N);
r = sqrt(const*((x + sqrt(2*K)).^2 + y.^2));
rt = zeros(1,Mi*length(r)); ki = 1;
14 N. KOSTOV, MOBILE RADIO CHANNELS MODELING IN MATLAB
for i=1:length(r) r = sqrt(0.5*(x.^2 + y.^2));
step = 0.1; range = 0:step:3;rt(ki:i*Mi) = r(i); ki = ki+Mi;
end h = hist(r, range);
fr_approx = h/(step*sum(h));r = rt;
fr = (range/0.5).*exp(-range.^2);
With this MATLAB code one can obtain both the “symbol-
level” and “block-level” Rician fading channels for a pro-
per chosen interpolation factor Mi. Also, Rayleigh fading
samples can be obtained for Kdb = -inf. A typical Rician
fading envelope is shown in Fig.1, where the fading ampli-
tudes are plotted in decibels (about the root-mean-squared
(RMS) value).
plot(range, fr_approx,'ko', range, fr,'k');
grid;
0 0.5 1 1.5 2 2.5 3
0
0.1
0.2
0.3
0.4
0.5
0.6
0.7
0.8
0.9
rf(r)
approximated PDF
analytical PDF
Now, we will consider a MATLAB based approxima-
tion of the Rician CDF. In the MATLAB code below, the
Rician CDF is approximated from the derived fading samp-
les according to the m-file rice_fading.
Kdb=7; N=100000; Mi=1;
r=rice_fading(Kdb,N,Mi);
RdB = 20*log10(r);
Rt
for m = 1:length(Rt)
= [min(RdB):max(RdB)];
fade = find(RdB < Rt(m));
Nm = length(fade); AF(m) = Nm/N;
end Fig. 3. The approximated and analytical Rayleigh PDF for σ0
2
= 0.5.
semilogy(Rt,AF,'k-o'); grid;
In the above code the approximated Rayleigh PDF (deno-
ted as fr_approx) is derived in MATLAB by means of
the useful function hist (the histogram function). Then, a
two-dimensional plot is used (by means of the MATLAB
function plot) to compare the approximated PDF with the
analytical PDF (denoted as fr) over a range of interest.
In this example the Rician CDF is derived by means of an
iterative construction, where at each iteration the MAT-
LAB functions find and length are used to obtain the num-
ber of fades, which are below the specified threshold value.
The obtained CDF is plotted in Fig. 2.
Finally, we will consider the generation of correlated
Rayleigh-distributed fading samples by using the modified
sum-of-sinusoids method as described in [8]. The quadra-
ture components of Rayleigh fading process are given by
-20 -15 -10 -5 0 5 10
10
-3
10
-2
10
-1
10
0
logCDF
Amplitude/RMS (dB)
∑
=
+=
M
n
nndt
M
tx
1
)coscos(
2
)( φαω , (10)
∑
=
+=
M
n
nndt
M
ty
1
)sincos(
2
)( ϕαω , (11)
with
Mn
M
n n
n ...,,2,1,
4
2
=
+−
=
θππ
α , (12)
where ωd is the maximum angular Doppler frequency, φn,
ϕn and θn are statistically independent and uniformly dis-
tributed on [–π, π) for all n. The following m-file, named
ray_doppler, exploits equations (9)-(12) for correlated
Rayleigh-distributed fading samples generation in MAT-
LAB.
Fig. 2. An approximated Rician CDF for K = 7 dB.
The Rician CDF in Fig.2 is plotted on a logarithmic proba-
bility scale, which allows us to expand the tail of the CDF,
where for example the 10 dB fading margin overload pro-
bability is seen to be approximately 10-2
.
function r = ray_doppler(fm, M, dt, N)The next MATLAB code is an example construction
for comparing an approximated Rayleigh PDF with the cor-
responding analytical PDF given by (4). The obtained re-
sult is shown in Fig. 3.
T = N*dt-dt; t = 0:dt:T;
c = sqrt(2/M); w = 2*pi*fm; x = 0; y = 0;
for n = 1:M
alpha = (2*pi*n-pi+(2*pi*rand-pi))/(4*M);
ph1 = 2*pi*rand - pi;N = 100000;
ph2 = 2*pi*rand - pi;x = randn(1, N); y = randn(1, N);
x = x + c*cos(w*t*cos(alpha) + ph1);
RADIOENGINEERING, VOL. 12, NO. 4, DECEMBER 2003 15
y = y + c*cos(w*t*sin(alpha) + ph2);
end
r = sqrt(x.^2 + y.^2)/sqrt(2);
Input arguments of the m-file ray_doppler are the maxi-
mum Doppler frequency (denoted as fm) in Hz, the number
of sinusoids (denoted as M), the time step (denoted as dt)
and the desired fading sequence length (denoted as N). All
values of φn, ϕn and θn are obtained by means of the MAT-
LAB random number generator rand, which produces uni-
formly distributed random numbers. Using proper values
for M (M should be not less than eight [8]), N and dt, one
can obtain the desired Doppler spread. The considered
approach can be extended with minor additions for correla-
ted Rician fading samples generation.
4. Monte Carlo Simulation Example
Let us consider a transmission of digitally modulated
symbols over an uncorrelated flat Rician fading channel.
Then, if si denotes the transmitted symbol at the ith time
instant, the received symbol vi can be expressed as
iiii nsrv +⋅= , (13)
where {ri} denotes a sequence of independent Rician-dis-
tributed random variables and ni’s are samples of a comp-
lex, zero-mean white Gaussian noise process with one-si-
ded power spectral density N0. A MATLAB m-file, named
psk_rice, is given below, wherein the performance of pha-
se shift keying (PSK) signaling over such a fading channel
is simulated. It should be mentioned that the simulation
example requires the Communications Toolbox of MAT-
LAB and the m-file rice_fading in order to run.
function BER = psk_rice(logEbNo,M,Kdb)
k = log2(M); EbNolin = 10.^(logEbNo/10)
Fd = 1; Fs = 1; Nit = 100000; Ns = 1000;
Tstop = 100;
for it_snr = 1:length(EbNolin)
nstd = sqrt(1/(2*k*EbNolin(it_snr)));
bit_err = 0;
for it = 1:Nit
a = randint(Ns,1,M);
s = dmodce(a,Fd,Fs,'psk',M);
r = rice_fading(Kdb,Ns,1); v_r = s.*r';
v = v_r + nstd*(randn(Ns,1) + ...
j*randn(Ns,1));
z = ddemodce(v, Fd, Fs,'psk',M);
errors = biterr(a,z);
bit_err = bit_err + errors;
if bit_err >= Tstop
break
end
end
B
end
ER(it_snr) = bit_err/(it*Ns*k);
semilogy(logEbNo, BER,'k');
xlabel('EbNo(dB)'); ylabel('BER'); grid;
Input arguments of the m-file psk_rice are the vector
logEbNo of energy-per-bit to noise power spectral density
values (in decibels), the PSK constellation size M and the
Rician K-factor Kdb in decibels. The Communications
Toolbox functions used in the simulation example are:
randint (generate matrix of uniformly distributed random
integers), dmodce (baseband digital modulator),
ddemodce (digital baseband demodulator) and biterr
(compute number of bit errors and bit error rate). Notice
how the for-end loops are used in the simulation. The outer
loop is used for signal-to-noise ratio (SNR) points enume-
ration, while (for each SNR point) the inner loop iterates a
finite number of frames of PSK symbols until a threshold
value of bit errors is reached (thanks to the if-break-end
construction) or the total number of frames is executed.
Finally, the estimated bit error rate (BER) is plotted versus
the SNR points by means of the MATLAB function
semilogy. It should be mentioned that the simulation accu-
racy is determined by the number of errors observed. A
rule of thumb is that after 100 errors the estimated BER is
within a factor 1.3 of the true BER (with approximately 99
percent confidence). So, a threshold value of 100 bit errors
is used in the simulation for early stopping the inner loop
iterations. One can also apply a set of SNR-dependent
threshold values to avoid a time-consuming simulation.
The simulation result is shown in Fig.4 for quadrature pha-
se shift keying (QPSK) signaling and two different Rician
K-factors (given in decibels).
0 5 10 15 20 25
10
-4
10
-3
10
-2
10
-1
10
0
Eb/No (dB)
BER
Kdb = -inf
Kdb = 5
Fig. 4. Bit error rate performance of QPSK signaling over an
uncorrelated Rician fading channel.
5. Conclusions
In this paper, an approach to demonstrate mobile
radio channels modeling in MATLAB is presented. The
basic types of small-scale fading channel models are
derived and simulated using MATLAB. The developed
channel models can be extended with minor additions to
model other types of fading channels (for example, a
correlated Rician fading channel). Further, simple and
useful MATLAB constructions for approximation of CDFs
and PDFs are also given. Finally, the presented Monte
Carlo simulation example can be used as a framework for
performance estimation of various digital modulation
schemes in MATLAB.
16 N. KOSTOV, MOBILE RADIO CHANNELS MODELING IN MATLAB
References
[1] SKLAR, B. Rayleigh fading channels in mobile digital communica-
tion systems, Part I: Characterization. IEEE Communications Maga-
zine, 1997, vol. 35, no. 7, p. 90 - 100.
[2] SUZUKI, H. A statistical model for urban radio propagation. IEEE
Transactions on Communications, 1977, vol. COM-25, no. 7, p. 673
to 680.
[3] PROAKIS, J. G. Digital communications. 2nd
ed. New York:
McGraw-Hill, 1989.
[4] CLARKE, R. H. A statistical theory of mobile-radio reception. Bell
Systems Technical Journal, 1968, vol. 47, no. 6, p. 957 - 1000.
[5] JAKES, W. C. Microwave mobile communications. New York:
Wiley, 1974.
[6] PATZOLD, M., KILLAT, U., LAUE, F., LI, Y. On the statistical
properties of deterministic simulation models for mobile fading
channels. IEEE Transactions on Vehicular Technology, 1998, vol.
47, no. 1, p. 254 - 269.
[7] HOEHER, P. A statistical discrete-time model for the WSSUS multi-
path channel. IEEE Transactions on Vehicular Technology, 1992,
vol. 41, no. 4, p. 461 - 468.
[8] ZHENG, Y., R., XIAO, C. Improved models for the generation of
multiple uncorrelated Rayleigh fading waveforms. IEEE Communi-
cations Letters, 2002, vol. 6, no. 6, p. 256 - 258.
About Author
Nikolay KOSTOV was born in Varna, Bulgaria, on Au-
gust 7, 1969. He received Dipl. Eng. and Dr. Eng. degrees
from the National Military University of Veliko Turnovo,
Bulgaria, in 1993 and 1999, respectively. He joined the
Radio Engineering Department at Technical University of
Varna, Bulgaria, in March 2001, where he is currently ser-
ving as an Assistant Professor. His research interests inclu-
de source/channel coding, modulation techniques, and
communications over fading channels.
Book Review:
Multimedia Communications. Multimedia Technology and Watermarking
Dušan Levický, Technical University of Košice
The monograph Multimedia communications written
by Dušan Levický, a professor of Electrical Engineering at
the Technical University of Košice tries to cover a full
spectrum of multimedia systems, methods and standards.
Many conferences and journals have been devoted to
the multimedia in several last years. Numerous standards,
coding methods and other techniques have been developed.
It is not easy to get desired detailed information from this
area or to obtain a general overview on multimedia. We
suppose, this could be the main reason for writing the mo-
nograph.
The first three chapters are devoted to the multimedia
systems, multimedia services and to the classification of
multimedia signals.
Chapter 4 presents basics of compression methods for
multimedia. The short but important last section of the
Chapter 4 contains evaluation methods of the decompres-
sed information quality. International digital facsimile co-
ding standards are described in Chapter 5.
Chapters 6, 7 and 8 present coding of pictures and
image sequences.
Existing digital video-coding standards are summari-
zed in Chapter 9.
Chapter 10 gives an introduction to speech-coding
standards, including standards for mobile communications.
Audio-coding standards are given in Chapter 11.
Chapter 12 is devoted to watermarking digital image
and video data.
The book contains list of references, list of standards
and a useful index.
It seems, the reviewed book successfully fills the gap
in the Slovak and Czech literature. Reviewers can recom-
mend Multimedia communications to any engineer, techni-
cian, student and researcher interested in this subject.
LEVICKÝ, D. Multimedia Communications. Multimedia
technology and Watermarking. Košice: Elfa s.r.o., 2003.
Address of the bookseller: Elfa, s.r.o. , Letná 9,
04200 Košice, Slovakia, knihy@elfa.sk
Price: 149 SK
Reviewers: Vladimír Šebesta and Stanislav Hanus

More Related Content

What's hot

2014.03.31.bach glc-pham-finalizing[conflict]
2014.03.31.bach glc-pham-finalizing[conflict]2014.03.31.bach glc-pham-finalizing[conflict]
2014.03.31.bach glc-pham-finalizing[conflict]Bách Vũ Trọng
 
Performance evaluation with a
Performance evaluation with aPerformance evaluation with a
Performance evaluation with aijmnct
 
Iaetsd chaos cdsk communication system
Iaetsd chaos cdsk communication systemIaetsd chaos cdsk communication system
Iaetsd chaos cdsk communication systemIaetsd Iaetsd
 
Multiuser MIMO Channel Estimation
Multiuser MIMO Channel Estimation Multiuser MIMO Channel Estimation
Multiuser MIMO Channel Estimation IJERA Editor
 
Design and Fabrication of a Two Axis Parabolic Solar Dish Collector
Design and Fabrication of a Two Axis Parabolic Solar Dish CollectorDesign and Fabrication of a Two Axis Parabolic Solar Dish Collector
Design and Fabrication of a Two Axis Parabolic Solar Dish CollectorIJERA Editor
 
MODIFIED LLL ALGORITHM WITH SHIFTED START COLUMN FOR COMPLEXITY REDUCTION
MODIFIED LLL ALGORITHM WITH SHIFTED START COLUMN FOR COMPLEXITY REDUCTIONMODIFIED LLL ALGORITHM WITH SHIFTED START COLUMN FOR COMPLEXITY REDUCTION
MODIFIED LLL ALGORITHM WITH SHIFTED START COLUMN FOR COMPLEXITY REDUCTIONijwmn
 
Impacto del 5G en los seres humanos
Impacto del 5G en los seres humanosImpacto del 5G en los seres humanos
Impacto del 5G en los seres humanosmauroflores37
 
Compressive spectrum sensing using two-stage scheme for cognitive radio netwo...
Compressive spectrum sensing using two-stage scheme for cognitive radio netwo...Compressive spectrum sensing using two-stage scheme for cognitive radio netwo...
Compressive spectrum sensing using two-stage scheme for cognitive radio netwo...IJECEIAES
 
An improved dft based channel estimation
An improved dft based channel estimationAn improved dft based channel estimation
An improved dft based channel estimationsakru naik
 
EVALUATION OF MIMO SYSTEM CAPACITY OVER RAYLEIGH FADING CHANNEL
EVALUATION OF MIMO SYSTEM CAPACITY OVER RAYLEIGH FADING CHANNELEVALUATION OF MIMO SYSTEM CAPACITY OVER RAYLEIGH FADING CHANNEL
EVALUATION OF MIMO SYSTEM CAPACITY OVER RAYLEIGH FADING CHANNELIJCSES Journal
 
Localized Algorithm for Channel Assignment in Cognitive Radio Networks
Localized Algorithm for Channel Assignment in Cognitive Radio NetworksLocalized Algorithm for Channel Assignment in Cognitive Radio Networks
Localized Algorithm for Channel Assignment in Cognitive Radio NetworksIJERA Editor
 
09 23sept 8434 10235-1-ed performance (edit ari)update 17jan18tyas
09 23sept 8434 10235-1-ed performance (edit ari)update 17jan18tyas09 23sept 8434 10235-1-ed performance (edit ari)update 17jan18tyas
09 23sept 8434 10235-1-ed performance (edit ari)update 17jan18tyasIAESIJEECS
 
Interferogram Filtering Using Gaussians Scale Mixtures in Steerable Wavelet D...
Interferogram Filtering Using Gaussians Scale Mixtures in Steerable Wavelet D...Interferogram Filtering Using Gaussians Scale Mixtures in Steerable Wavelet D...
Interferogram Filtering Using Gaussians Scale Mixtures in Steerable Wavelet D...CSCJournals
 

What's hot (20)

2014.03.31.bach glc-pham-finalizing[conflict]
2014.03.31.bach glc-pham-finalizing[conflict]2014.03.31.bach glc-pham-finalizing[conflict]
2014.03.31.bach glc-pham-finalizing[conflict]
 
MIMO Communications
MIMO CommunicationsMIMO Communications
MIMO Communications
 
Performance evaluation with a
Performance evaluation with aPerformance evaluation with a
Performance evaluation with a
 
Iaetsd chaos cdsk communication system
Iaetsd chaos cdsk communication systemIaetsd chaos cdsk communication system
Iaetsd chaos cdsk communication system
 
Multiuser MIMO Channel Estimation
Multiuser MIMO Channel Estimation Multiuser MIMO Channel Estimation
Multiuser MIMO Channel Estimation
 
9517cnc05
9517cnc059517cnc05
9517cnc05
 
Design and Fabrication of a Two Axis Parabolic Solar Dish Collector
Design and Fabrication of a Two Axis Parabolic Solar Dish CollectorDesign and Fabrication of a Two Axis Parabolic Solar Dish Collector
Design and Fabrication of a Two Axis Parabolic Solar Dish Collector
 
MODIFIED LLL ALGORITHM WITH SHIFTED START COLUMN FOR COMPLEXITY REDUCTION
MODIFIED LLL ALGORITHM WITH SHIFTED START COLUMN FOR COMPLEXITY REDUCTIONMODIFIED LLL ALGORITHM WITH SHIFTED START COLUMN FOR COMPLEXITY REDUCTION
MODIFIED LLL ALGORITHM WITH SHIFTED START COLUMN FOR COMPLEXITY REDUCTION
 
Impacto del 5G en los seres humanos
Impacto del 5G en los seres humanosImpacto del 5G en los seres humanos
Impacto del 5G en los seres humanos
 
www.ijerd.com
www.ijerd.comwww.ijerd.com
www.ijerd.com
 
Compressive spectrum sensing using two-stage scheme for cognitive radio netwo...
Compressive spectrum sensing using two-stage scheme for cognitive radio netwo...Compressive spectrum sensing using two-stage scheme for cognitive radio netwo...
Compressive spectrum sensing using two-stage scheme for cognitive radio netwo...
 
Masters Report 1
Masters Report 1Masters Report 1
Masters Report 1
 
Masters Report 2
Masters Report 2Masters Report 2
Masters Report 2
 
An improved dft based channel estimation
An improved dft based channel estimationAn improved dft based channel estimation
An improved dft based channel estimation
 
Masters Report 3
Masters Report 3Masters Report 3
Masters Report 3
 
EVALUATION OF MIMO SYSTEM CAPACITY OVER RAYLEIGH FADING CHANNEL
EVALUATION OF MIMO SYSTEM CAPACITY OVER RAYLEIGH FADING CHANNELEVALUATION OF MIMO SYSTEM CAPACITY OVER RAYLEIGH FADING CHANNEL
EVALUATION OF MIMO SYSTEM CAPACITY OVER RAYLEIGH FADING CHANNEL
 
Localized Algorithm for Channel Assignment in Cognitive Radio Networks
Localized Algorithm for Channel Assignment in Cognitive Radio NetworksLocalized Algorithm for Channel Assignment in Cognitive Radio Networks
Localized Algorithm for Channel Assignment in Cognitive Radio Networks
 
09 23sept 8434 10235-1-ed performance (edit ari)update 17jan18tyas
09 23sept 8434 10235-1-ed performance (edit ari)update 17jan18tyas09 23sept 8434 10235-1-ed performance (edit ari)update 17jan18tyas
09 23sept 8434 10235-1-ed performance (edit ari)update 17jan18tyas
 
Interferogram Filtering Using Gaussians Scale Mixtures in Steerable Wavelet D...
Interferogram Filtering Using Gaussians Scale Mixtures in Steerable Wavelet D...Interferogram Filtering Using Gaussians Scale Mixtures in Steerable Wavelet D...
Interferogram Filtering Using Gaussians Scale Mixtures in Steerable Wavelet D...
 
wcnc05
wcnc05wcnc05
wcnc05
 

Similar to Mobile radio chaneel matlab kostov

Multi-carrier Equalization by Restoration of RedundancY (MERRY) for Adaptive ...
Multi-carrier Equalization by Restoration of RedundancY (MERRY) for Adaptive ...Multi-carrier Equalization by Restoration of RedundancY (MERRY) for Adaptive ...
Multi-carrier Equalization by Restoration of RedundancY (MERRY) for Adaptive ...IJNSA Journal
 
Simulation model for a frequency selective land mobile satellite communicatio...
Simulation model for a frequency selective land mobile satellite communicatio...Simulation model for a frequency selective land mobile satellite communicatio...
Simulation model for a frequency selective land mobile satellite communicatio...Alexander Decker
 
Fading models text
Fading models textFading models text
Fading models textSagar Ahir
 
Performance of cognitive radio networks with maximal ratio combining over cor...
Performance of cognitive radio networks with maximal ratio combining over cor...Performance of cognitive radio networks with maximal ratio combining over cor...
Performance of cognitive radio networks with maximal ratio combining over cor...Polytechnique Montreal
 
SαS noise suppression for OFDM wireless communication in rayleight channel
SαS noise suppression for OFDM wireless communication in rayleight channel SαS noise suppression for OFDM wireless communication in rayleight channel
SαS noise suppression for OFDM wireless communication in rayleight channel IJECEIAES
 
Performance Analysis of Rician Fading Channels using Nonlinear Modulation Met...
Performance Analysis of Rician Fading Channels using Nonlinear Modulation Met...Performance Analysis of Rician Fading Channels using Nonlinear Modulation Met...
Performance Analysis of Rician Fading Channels using Nonlinear Modulation Met...IOSR Journals
 
Iterative Soft Decision Based Complex K-best MIMO Decoder
Iterative Soft Decision Based Complex K-best MIMO DecoderIterative Soft Decision Based Complex K-best MIMO Decoder
Iterative Soft Decision Based Complex K-best MIMO DecoderCSCJournals
 
Iterative Soft Decision Based Complex K-best MIMO Decoder
Iterative Soft Decision Based Complex K-best MIMO DecoderIterative Soft Decision Based Complex K-best MIMO Decoder
Iterative Soft Decision Based Complex K-best MIMO DecoderCSCJournals
 
Improvement of Fading Channel Modeling Performance for Wireless Channel
Improvement of Fading Channel Modeling Performance for Wireless Channel Improvement of Fading Channel Modeling Performance for Wireless Channel
Improvement of Fading Channel Modeling Performance for Wireless Channel IJECEIAES
 
On the Performance Analysis of Composite Multipath/Shadowing (Weibull-Log Nor...
On the Performance Analysis of Composite Multipath/Shadowing (Weibull-Log Nor...On the Performance Analysis of Composite Multipath/Shadowing (Weibull-Log Nor...
On the Performance Analysis of Composite Multipath/Shadowing (Weibull-Log Nor...IJEEE
 
Design of Low-Pass Digital Differentiators Based on B-splines
Design of Low-Pass Digital Differentiators Based on B-splinesDesign of Low-Pass Digital Differentiators Based on B-splines
Design of Low-Pass Digital Differentiators Based on B-splinesCSCJournals
 
Narrowband Spectrum Sensing for Different Fading Channels for Cognitive Radio...
Narrowband Spectrum Sensing for Different Fading Channels for Cognitive Radio...Narrowband Spectrum Sensing for Different Fading Channels for Cognitive Radio...
Narrowband Spectrum Sensing for Different Fading Channels for Cognitive Radio...IJMERJOURNAL
 
Performance of Wideband Mobile Channel with Perfect Synchronism BPSK vs QPSK ...
Performance of Wideband Mobile Channel with Perfect Synchronism BPSK vs QPSK ...Performance of Wideband Mobile Channel with Perfect Synchronism BPSK vs QPSK ...
Performance of Wideband Mobile Channel with Perfect Synchronism BPSK vs QPSK ...Editor Jacotech
 
Bounds on the Achievable Rates of Faded Dirty Paper Channel
Bounds on the Achievable Rates of Faded Dirty Paper Channel Bounds on the Achievable Rates of Faded Dirty Paper Channel
Bounds on the Achievable Rates of Faded Dirty Paper Channel IJCNCJournal
 
Fixed Point Realization of Iterative LR-Aided Soft MIMO Decoding Algorithm
Fixed Point Realization of Iterative LR-Aided Soft MIMO Decoding AlgorithmFixed Point Realization of Iterative LR-Aided Soft MIMO Decoding Algorithm
Fixed Point Realization of Iterative LR-Aided Soft MIMO Decoding AlgorithmCSCJournals
 

Similar to Mobile radio chaneel matlab kostov (20)

Multi-carrier Equalization by Restoration of RedundancY (MERRY) for Adaptive ...
Multi-carrier Equalization by Restoration of RedundancY (MERRY) for Adaptive ...Multi-carrier Equalization by Restoration of RedundancY (MERRY) for Adaptive ...
Multi-carrier Equalization by Restoration of RedundancY (MERRY) for Adaptive ...
 
Simulation model for a frequency selective land mobile satellite communicatio...
Simulation model for a frequency selective land mobile satellite communicatio...Simulation model for a frequency selective land mobile satellite communicatio...
Simulation model for a frequency selective land mobile satellite communicatio...
 
Dr35672675
Dr35672675Dr35672675
Dr35672675
 
Fading models text
Fading models textFading models text
Fading models text
 
Performance of cognitive radio networks with maximal ratio combining over cor...
Performance of cognitive radio networks with maximal ratio combining over cor...Performance of cognitive radio networks with maximal ratio combining over cor...
Performance of cognitive radio networks with maximal ratio combining over cor...
 
SαS noise suppression for OFDM wireless communication in rayleight channel
SαS noise suppression for OFDM wireless communication in rayleight channel SαS noise suppression for OFDM wireless communication in rayleight channel
SαS noise suppression for OFDM wireless communication in rayleight channel
 
Hg3413361339
Hg3413361339Hg3413361339
Hg3413361339
 
Performance Analysis of Rician Fading Channels using Nonlinear Modulation Met...
Performance Analysis of Rician Fading Channels using Nonlinear Modulation Met...Performance Analysis of Rician Fading Channels using Nonlinear Modulation Met...
Performance Analysis of Rician Fading Channels using Nonlinear Modulation Met...
 
Iterative Soft Decision Based Complex K-best MIMO Decoder
Iterative Soft Decision Based Complex K-best MIMO DecoderIterative Soft Decision Based Complex K-best MIMO Decoder
Iterative Soft Decision Based Complex K-best MIMO Decoder
 
Iterative Soft Decision Based Complex K-best MIMO Decoder
Iterative Soft Decision Based Complex K-best MIMO DecoderIterative Soft Decision Based Complex K-best MIMO Decoder
Iterative Soft Decision Based Complex K-best MIMO Decoder
 
Improvement of Fading Channel Modeling Performance for Wireless Channel
Improvement of Fading Channel Modeling Performance for Wireless Channel Improvement of Fading Channel Modeling Performance for Wireless Channel
Improvement of Fading Channel Modeling Performance for Wireless Channel
 
On the Performance Analysis of Composite Multipath/Shadowing (Weibull-Log Nor...
On the Performance Analysis of Composite Multipath/Shadowing (Weibull-Log Nor...On the Performance Analysis of Composite Multipath/Shadowing (Weibull-Log Nor...
On the Performance Analysis of Composite Multipath/Shadowing (Weibull-Log Nor...
 
Ijst 131202
Ijst 131202Ijst 131202
Ijst 131202
 
Design of Low-Pass Digital Differentiators Based on B-splines
Design of Low-Pass Digital Differentiators Based on B-splinesDesign of Low-Pass Digital Differentiators Based on B-splines
Design of Low-Pass Digital Differentiators Based on B-splines
 
45
4545
45
 
Narrowband Spectrum Sensing for Different Fading Channels for Cognitive Radio...
Narrowband Spectrum Sensing for Different Fading Channels for Cognitive Radio...Narrowband Spectrum Sensing for Different Fading Channels for Cognitive Radio...
Narrowband Spectrum Sensing for Different Fading Channels for Cognitive Radio...
 
Performance of Wideband Mobile Channel with Perfect Synchronism BPSK vs QPSK ...
Performance of Wideband Mobile Channel with Perfect Synchronism BPSK vs QPSK ...Performance of Wideband Mobile Channel with Perfect Synchronism BPSK vs QPSK ...
Performance of Wideband Mobile Channel with Perfect Synchronism BPSK vs QPSK ...
 
FK_icassp_2014
FK_icassp_2014FK_icassp_2014
FK_icassp_2014
 
Bounds on the Achievable Rates of Faded Dirty Paper Channel
Bounds on the Achievable Rates of Faded Dirty Paper Channel Bounds on the Achievable Rates of Faded Dirty Paper Channel
Bounds on the Achievable Rates of Faded Dirty Paper Channel
 
Fixed Point Realization of Iterative LR-Aided Soft MIMO Decoding Algorithm
Fixed Point Realization of Iterative LR-Aided Soft MIMO Decoding AlgorithmFixed Point Realization of Iterative LR-Aided Soft MIMO Decoding Algorithm
Fixed Point Realization of Iterative LR-Aided Soft MIMO Decoding Algorithm
 

Recently uploaded

"LLMs for Python Engineers: Advanced Data Analysis and Semantic Kernel",Oleks...
"LLMs for Python Engineers: Advanced Data Analysis and Semantic Kernel",Oleks..."LLMs for Python Engineers: Advanced Data Analysis and Semantic Kernel",Oleks...
"LLMs for Python Engineers: Advanced Data Analysis and Semantic Kernel",Oleks...Fwdays
 
Advanced Test Driven-Development @ php[tek] 2024
Advanced Test Driven-Development @ php[tek] 2024Advanced Test Driven-Development @ php[tek] 2024
Advanced Test Driven-Development @ php[tek] 2024Scott Keck-Warren
 
Beyond Boundaries: Leveraging No-Code Solutions for Industry Innovation
Beyond Boundaries: Leveraging No-Code Solutions for Industry InnovationBeyond Boundaries: Leveraging No-Code Solutions for Industry Innovation
Beyond Boundaries: Leveraging No-Code Solutions for Industry InnovationSafe Software
 
Vertex AI Gemini Prompt Engineering Tips
Vertex AI Gemini Prompt Engineering TipsVertex AI Gemini Prompt Engineering Tips
Vertex AI Gemini Prompt Engineering TipsMiki Katsuragi
 
Tech-Forward - Achieving Business Readiness For Copilot in Microsoft 365
Tech-Forward - Achieving Business Readiness For Copilot in Microsoft 365Tech-Forward - Achieving Business Readiness For Copilot in Microsoft 365
Tech-Forward - Achieving Business Readiness For Copilot in Microsoft 3652toLead Limited
 
Streamlining Python Development: A Guide to a Modern Project Setup
Streamlining Python Development: A Guide to a Modern Project SetupStreamlining Python Development: A Guide to a Modern Project Setup
Streamlining Python Development: A Guide to a Modern Project SetupFlorian Wilhelm
 
costume and set research powerpoint presentation
costume and set research powerpoint presentationcostume and set research powerpoint presentation
costume and set research powerpoint presentationphoebematthew05
 
Connect Wave/ connectwave Pitch Deck Presentation
Connect Wave/ connectwave Pitch Deck PresentationConnect Wave/ connectwave Pitch Deck Presentation
Connect Wave/ connectwave Pitch Deck PresentationSlibray Presentation
 
Tampa BSides - Chef's Tour of Microsoft Security Adoption Framework (SAF)
Tampa BSides - Chef's Tour of Microsoft Security Adoption Framework (SAF)Tampa BSides - Chef's Tour of Microsoft Security Adoption Framework (SAF)
Tampa BSides - Chef's Tour of Microsoft Security Adoption Framework (SAF)Mark Simos
 
SQL Database Design For Developers at php[tek] 2024
SQL Database Design For Developers at php[tek] 2024SQL Database Design For Developers at php[tek] 2024
SQL Database Design For Developers at php[tek] 2024Scott Keck-Warren
 
AI as an Interface for Commercial Buildings
AI as an Interface for Commercial BuildingsAI as an Interface for Commercial Buildings
AI as an Interface for Commercial BuildingsMemoori
 
My INSURER PTE LTD - Insurtech Innovation Award 2024
My INSURER PTE LTD - Insurtech Innovation Award 2024My INSURER PTE LTD - Insurtech Innovation Award 2024
My INSURER PTE LTD - Insurtech Innovation Award 2024The Digital Insurer
 
SIP trunking in Janus @ Kamailio World 2024
SIP trunking in Janus @ Kamailio World 2024SIP trunking in Janus @ Kamailio World 2024
SIP trunking in Janus @ Kamailio World 2024Lorenzo Miniero
 
"ML in Production",Oleksandr Bagan
"ML in Production",Oleksandr Bagan"ML in Production",Oleksandr Bagan
"ML in Production",Oleksandr BaganFwdays
 
Install Stable Diffusion in windows machine
Install Stable Diffusion in windows machineInstall Stable Diffusion in windows machine
Install Stable Diffusion in windows machinePadma Pradeep
 
Ensuring Technical Readiness For Copilot in Microsoft 365
Ensuring Technical Readiness For Copilot in Microsoft 365Ensuring Technical Readiness For Copilot in Microsoft 365
Ensuring Technical Readiness For Copilot in Microsoft 3652toLead Limited
 
My Hashitalk Indonesia April 2024 Presentation
My Hashitalk Indonesia April 2024 PresentationMy Hashitalk Indonesia April 2024 Presentation
My Hashitalk Indonesia April 2024 PresentationRidwan Fadjar
 
SAP Build Work Zone - Overview L2-L3.pptx
SAP Build Work Zone - Overview L2-L3.pptxSAP Build Work Zone - Overview L2-L3.pptx
SAP Build Work Zone - Overview L2-L3.pptxNavinnSomaal
 
Are Multi-Cloud and Serverless Good or Bad?
Are Multi-Cloud and Serverless Good or Bad?Are Multi-Cloud and Serverless Good or Bad?
Are Multi-Cloud and Serverless Good or Bad?Mattias Andersson
 
Commit 2024 - Secret Management made easy
Commit 2024 - Secret Management made easyCommit 2024 - Secret Management made easy
Commit 2024 - Secret Management made easyAlfredo García Lavilla
 

Recently uploaded (20)

"LLMs for Python Engineers: Advanced Data Analysis and Semantic Kernel",Oleks...
"LLMs for Python Engineers: Advanced Data Analysis and Semantic Kernel",Oleks..."LLMs for Python Engineers: Advanced Data Analysis and Semantic Kernel",Oleks...
"LLMs for Python Engineers: Advanced Data Analysis and Semantic Kernel",Oleks...
 
Advanced Test Driven-Development @ php[tek] 2024
Advanced Test Driven-Development @ php[tek] 2024Advanced Test Driven-Development @ php[tek] 2024
Advanced Test Driven-Development @ php[tek] 2024
 
Beyond Boundaries: Leveraging No-Code Solutions for Industry Innovation
Beyond Boundaries: Leveraging No-Code Solutions for Industry InnovationBeyond Boundaries: Leveraging No-Code Solutions for Industry Innovation
Beyond Boundaries: Leveraging No-Code Solutions for Industry Innovation
 
Vertex AI Gemini Prompt Engineering Tips
Vertex AI Gemini Prompt Engineering TipsVertex AI Gemini Prompt Engineering Tips
Vertex AI Gemini Prompt Engineering Tips
 
Tech-Forward - Achieving Business Readiness For Copilot in Microsoft 365
Tech-Forward - Achieving Business Readiness For Copilot in Microsoft 365Tech-Forward - Achieving Business Readiness For Copilot in Microsoft 365
Tech-Forward - Achieving Business Readiness For Copilot in Microsoft 365
 
Streamlining Python Development: A Guide to a Modern Project Setup
Streamlining Python Development: A Guide to a Modern Project SetupStreamlining Python Development: A Guide to a Modern Project Setup
Streamlining Python Development: A Guide to a Modern Project Setup
 
costume and set research powerpoint presentation
costume and set research powerpoint presentationcostume and set research powerpoint presentation
costume and set research powerpoint presentation
 
Connect Wave/ connectwave Pitch Deck Presentation
Connect Wave/ connectwave Pitch Deck PresentationConnect Wave/ connectwave Pitch Deck Presentation
Connect Wave/ connectwave Pitch Deck Presentation
 
Tampa BSides - Chef's Tour of Microsoft Security Adoption Framework (SAF)
Tampa BSides - Chef's Tour of Microsoft Security Adoption Framework (SAF)Tampa BSides - Chef's Tour of Microsoft Security Adoption Framework (SAF)
Tampa BSides - Chef's Tour of Microsoft Security Adoption Framework (SAF)
 
SQL Database Design For Developers at php[tek] 2024
SQL Database Design For Developers at php[tek] 2024SQL Database Design For Developers at php[tek] 2024
SQL Database Design For Developers at php[tek] 2024
 
AI as an Interface for Commercial Buildings
AI as an Interface for Commercial BuildingsAI as an Interface for Commercial Buildings
AI as an Interface for Commercial Buildings
 
My INSURER PTE LTD - Insurtech Innovation Award 2024
My INSURER PTE LTD - Insurtech Innovation Award 2024My INSURER PTE LTD - Insurtech Innovation Award 2024
My INSURER PTE LTD - Insurtech Innovation Award 2024
 
SIP trunking in Janus @ Kamailio World 2024
SIP trunking in Janus @ Kamailio World 2024SIP trunking in Janus @ Kamailio World 2024
SIP trunking in Janus @ Kamailio World 2024
 
"ML in Production",Oleksandr Bagan
"ML in Production",Oleksandr Bagan"ML in Production",Oleksandr Bagan
"ML in Production",Oleksandr Bagan
 
Install Stable Diffusion in windows machine
Install Stable Diffusion in windows machineInstall Stable Diffusion in windows machine
Install Stable Diffusion in windows machine
 
Ensuring Technical Readiness For Copilot in Microsoft 365
Ensuring Technical Readiness For Copilot in Microsoft 365Ensuring Technical Readiness For Copilot in Microsoft 365
Ensuring Technical Readiness For Copilot in Microsoft 365
 
My Hashitalk Indonesia April 2024 Presentation
My Hashitalk Indonesia April 2024 PresentationMy Hashitalk Indonesia April 2024 Presentation
My Hashitalk Indonesia April 2024 Presentation
 
SAP Build Work Zone - Overview L2-L3.pptx
SAP Build Work Zone - Overview L2-L3.pptxSAP Build Work Zone - Overview L2-L3.pptx
SAP Build Work Zone - Overview L2-L3.pptx
 
Are Multi-Cloud and Serverless Good or Bad?
Are Multi-Cloud and Serverless Good or Bad?Are Multi-Cloud and Serverless Good or Bad?
Are Multi-Cloud and Serverless Good or Bad?
 
Commit 2024 - Secret Management made easy
Commit 2024 - Secret Management made easyCommit 2024 - Secret Management made easy
Commit 2024 - Secret Management made easy
 

Mobile radio chaneel matlab kostov

  • 1. 12 N. KOSTOV, MOBILE RADIO CHANNELS MODELING IN MATLAB Mobile Radio Channels Modeling in MATLAB Nikolay KOSTOV Department of Radio Engineering, Technical University of Varna, Student 1, 9010 Varna, Bulgaria n_kostov@mail.bg Abstract. In this paper, a MATLAB based approach for mobile radio channels modeling is presented. Specifically, the paper introduces the basic concepts for modeling flat fading channels in MATLAB by means of user-defined m- files. Typical small-scale fading channel models are deri- ved such as uncorrelated Rician fading channel and Ray- leigh fading channel with Doppler shift. Further, simple and useful MATLAB constructions for approximation of cumulative distribution functions (CDFs) and probability density functions (PDFs) are also given. Finally, a MAT- LAB based Monte Carlo simulation example is presented, which comprises performance estimation of phase shift keying (PSK) signaling over a Rician fading channel. Keywords MATLAB, fading channels, distribution, simulation. 1. Introduction In digital communication theory the most frequently assumed model for a transmission channel is the additive white Gaussian noise (AWGN) channel. However, for ma- ny communication systems the AWGN channel is a poor model, and one must resort to more precise and complica- ted channel models. One basic type of non-Gaussian chan- nel, which frequently occurs in practice, is the fading chan- nel. A typical example of such a fading channel is the mo- bile radio channel, where the small antennas of portable units pick up multipath reflections. Thus, the mobile chan- nel exhibits a time varying behavior in the received signal energy, which is called fading. Using MATLAB for digital communication systems simulation one has the advantage of exploiting the power- ful features of its Communications Toolbox along with a nice programming language. However, the Communica- tions Toolbox of MATLAB suffers from absence of proper mobile channel models. The only available channel model in the current Communications Toolbox 2.1 is the awgn m- file, which is appropriate for an AWGN channel simula- tion. So, the users of MATLAB should build appropriate channels (i.e., m-files) in their own to reach the desired simulation model. The paper is organized as follows. In Section 2, a brief introduction to fading channels is given. The basic concepts for modeling flat fading channels in MATLAB are presented in Section 3. In this section, example m-files are proposed to model different types of flat fading chan- nels. In Section 4, a MATLAB based Monte Carlo simula- tion example is presented, which describes the basic con- cepts of digital modulations performance estimation over fading channels. Finally, the concluding remarks are given in Section 5. 2. The Mobile Radio Channel The mobile radio channel is characterized by two types of fading effects: large-scale fading and small scale fading [1], [2]. Large-scale fading is the slow variation of the mean (distant-dependent) signal power over time. This depends on the presence of obstacles in the signal path and on the position of the mobile unit. The large-scale fading is assumed to be a slow process and is commonly modeled as having lognormal statistics. Small-scale fading is also cal- led Rayleigh or Rician fading because if a large number of reflective paths is encountered the received signal envelope is described by a Rayleigh or a Rician probability density function (PDF) [3]. The small-scale fading under conside- ration is assumed to be a flat fading (i.e., there is no inter- symbol interference). It is also assumed that the fading le- vel remains approximately constant for (at least) one sig- naling interval. With this model of fading channel the main difference with respect to an AWGN channel resides in the fact that fading amplitudes are now Rayleigh- or Rician- distributed random variables, whose values affect the signal amplitude (and, hence, the power) of the received signal. The fading amplitudes can be modeled by a Rician or a Rayleigh distribution, depending on the presence or ab- sence of specular signal component. Fading is Rayleigh if the multiple reflective paths are large in number and there is no dominant line-of-sight (LOS) propagation path. If there is also a dominant LOS path, then the fading is Ri- cian-distributed. The fading amplitude ri at the ith time in- stant can be represented as 22 )( iii yxr ++= β , (1) where β is the amplitude of the specular component and xi, yi are samples of zero-mean stationary Gaussian random processes each with variance σ0 2 . The ratio of specular to defuse energy defines the so-called Rician K-factor, which is given by
  • 2. RADIOENGINEERING, VOL. 12, NO. 4, DECEMBER 2003 13 2 0 2 2/ σβ=K . (2) The best- and worst-case Rician fading channels associated with K-factors of K = ∞ and K = 0 are the Gaussian and Rayleigh channels with strong LOS and no LOS path, res- pectively. So, the Rayleigh fading channel can be conside- red as a special case of a Rician fading channel with K = 0. The Rician PDF is given by [3] [ ] 02/)(exp)( 2 0 0 2 0 22 2 0 ≥      +−= r r Ir r rfRice σ β σβ σ , (3) where I0[.] is the zero-order modified Bessel function of the first kind. Now, if there is no dominant propagation path, K = 0 and I0[.] = 1 yielding the worst-case Rayleigh PDF [ ] 02/exp)( 2 0 2 2 0 ≥−= rr r rfRayleigh σ σ . (4) The Rician cumulative distribution function (CDF) takes the shape of [3] ( ) ∑ ∞ =       ⋅    −−= 0 2 0 exp1)( m m m Rice r I r rC σ ββ γ , (5) where γ = (K + r2 / 2σ0 2 ). Clearly, this formula is more dif- ficult to evaluate than the PDF of (3) due to the summation of an infinite number of terms. However, in practical terms it is sufficient to increase m to the value, where the last terms contribution becomes less than 0.1 percent. 0 200 400 600 800 1000 -20 -15 -10 -5 0 5 Samples Amplitude/RMS(dB) Fig. 1. A typical Rician fading envelope for K = 5 dB. Having described the main fading statistics let us consider the effects of the Doppler frequency shift. Doppler shift from the carrier frequency fc occurs when the distance bet- ween the mobile receiver and the transmitter is changing. The magnitude of the Doppler frequency shift fm is determi- ned by c fv f c m = , (6) where ν is the mobile station velocity and c = 3⋅108 m/s is the speed of light. The Doppler frequency fm is often called fading bandwidth or fading fate of the channel. The rela- tionship between fm and the coherence time Tm of the chan- nel (i.e., the time over which the channel’s response to a sinusoid is essentially invariant) is given by [1] m m f T 5.0 ≈ . (7) The Doppler power spectral density S(f) of the mobile channel is often expressed as [4], [5] 2 )/(1 1 )( mm fff fS − = π . (8) The above equality holds for frequency shifts of f in the range ±fm about the carrier frequency fc. Some important notes are in order here. First, the pri- mary factor, which affects the performance of digital com- munication systems in a mobile environment, is the small- scale fading. So, we will consider Rayleigh and Rician fa- ding channels from now on. Second, uncorrelated Ray- leigh- or Rician-distributed fading sequences can be obtai- ned directly by exploiting (1). Third, correlated fading se- quences can be obtained by means of “colored” Gaussian noise processes. A well-known approach is the so-called sum-of-sinusoids method in which a “colored” Gaussian noise is approximated by a finite sum of weighted and pro- perly designed sinusoids [5]-[8]. In this paper we opt on the modified sum-of-sinusoids method as described in [8], be- cause of its improved statistical properties and simple software realization. 3. Fading Generation in MATLAB Let us first consider the generation of uncorrelated Rician-distributed fading sequences in MATLAB. The mean-squared value of the Rician distribution is known to be 2σ0 2 ( K + 1), where σ0 2 is the variance of the component Gaussian noise processes in (1). Further, it is often required a Rician distribution with unit mean-squared value, i.e., E{r2 } = 1, so that the signal power and the signal-to-noise ratio (SNR) coincide. In order to meet the requirement E{r2 } = 1, the equation (1) can be written in the form )1(2 )2( 22 + ++ = K yKx r ii i , (9) where now xi, yi are samples of zero-mean stationary Gaus- sian random processes each with variance σ0 2 = 1. So, the desired Rician fading sequences can be generated accor- ding to (9) by using the MATLAB random number genera- tor randn, which produces normally distributed random numbers. The following MATLAB m-file rice_fading does the task. function r = rice_fading(Kdb, N, Mi) K = 10^(Kdb/10); const = 1/(2*(K+1)); x = randn(1,N); y = randn(1,N); r = sqrt(const*((x + sqrt(2*K)).^2 + y.^2)); rt = zeros(1,Mi*length(r)); ki = 1;
  • 3. 14 N. KOSTOV, MOBILE RADIO CHANNELS MODELING IN MATLAB for i=1:length(r) r = sqrt(0.5*(x.^2 + y.^2)); step = 0.1; range = 0:step:3;rt(ki:i*Mi) = r(i); ki = ki+Mi; end h = hist(r, range); fr_approx = h/(step*sum(h));r = rt; fr = (range/0.5).*exp(-range.^2); With this MATLAB code one can obtain both the “symbol- level” and “block-level” Rician fading channels for a pro- per chosen interpolation factor Mi. Also, Rayleigh fading samples can be obtained for Kdb = -inf. A typical Rician fading envelope is shown in Fig.1, where the fading ampli- tudes are plotted in decibels (about the root-mean-squared (RMS) value). plot(range, fr_approx,'ko', range, fr,'k'); grid; 0 0.5 1 1.5 2 2.5 3 0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 rf(r) approximated PDF analytical PDF Now, we will consider a MATLAB based approxima- tion of the Rician CDF. In the MATLAB code below, the Rician CDF is approximated from the derived fading samp- les according to the m-file rice_fading. Kdb=7; N=100000; Mi=1; r=rice_fading(Kdb,N,Mi); RdB = 20*log10(r); Rt for m = 1:length(Rt) = [min(RdB):max(RdB)]; fade = find(RdB < Rt(m)); Nm = length(fade); AF(m) = Nm/N; end Fig. 3. The approximated and analytical Rayleigh PDF for σ0 2 = 0.5. semilogy(Rt,AF,'k-o'); grid; In the above code the approximated Rayleigh PDF (deno- ted as fr_approx) is derived in MATLAB by means of the useful function hist (the histogram function). Then, a two-dimensional plot is used (by means of the MATLAB function plot) to compare the approximated PDF with the analytical PDF (denoted as fr) over a range of interest. In this example the Rician CDF is derived by means of an iterative construction, where at each iteration the MAT- LAB functions find and length are used to obtain the num- ber of fades, which are below the specified threshold value. The obtained CDF is plotted in Fig. 2. Finally, we will consider the generation of correlated Rayleigh-distributed fading samples by using the modified sum-of-sinusoids method as described in [8]. The quadra- ture components of Rayleigh fading process are given by -20 -15 -10 -5 0 5 10 10 -3 10 -2 10 -1 10 0 logCDF Amplitude/RMS (dB) ∑ = += M n nndt M tx 1 )coscos( 2 )( φαω , (10) ∑ = += M n nndt M ty 1 )sincos( 2 )( ϕαω , (11) with Mn M n n n ...,,2,1, 4 2 = +− = θππ α , (12) where ωd is the maximum angular Doppler frequency, φn, ϕn and θn are statistically independent and uniformly dis- tributed on [–π, π) for all n. The following m-file, named ray_doppler, exploits equations (9)-(12) for correlated Rayleigh-distributed fading samples generation in MAT- LAB. Fig. 2. An approximated Rician CDF for K = 7 dB. The Rician CDF in Fig.2 is plotted on a logarithmic proba- bility scale, which allows us to expand the tail of the CDF, where for example the 10 dB fading margin overload pro- bability is seen to be approximately 10-2 . function r = ray_doppler(fm, M, dt, N)The next MATLAB code is an example construction for comparing an approximated Rayleigh PDF with the cor- responding analytical PDF given by (4). The obtained re- sult is shown in Fig. 3. T = N*dt-dt; t = 0:dt:T; c = sqrt(2/M); w = 2*pi*fm; x = 0; y = 0; for n = 1:M alpha = (2*pi*n-pi+(2*pi*rand-pi))/(4*M); ph1 = 2*pi*rand - pi;N = 100000; ph2 = 2*pi*rand - pi;x = randn(1, N); y = randn(1, N); x = x + c*cos(w*t*cos(alpha) + ph1);
  • 4. RADIOENGINEERING, VOL. 12, NO. 4, DECEMBER 2003 15 y = y + c*cos(w*t*sin(alpha) + ph2); end r = sqrt(x.^2 + y.^2)/sqrt(2); Input arguments of the m-file ray_doppler are the maxi- mum Doppler frequency (denoted as fm) in Hz, the number of sinusoids (denoted as M), the time step (denoted as dt) and the desired fading sequence length (denoted as N). All values of φn, ϕn and θn are obtained by means of the MAT- LAB random number generator rand, which produces uni- formly distributed random numbers. Using proper values for M (M should be not less than eight [8]), N and dt, one can obtain the desired Doppler spread. The considered approach can be extended with minor additions for correla- ted Rician fading samples generation. 4. Monte Carlo Simulation Example Let us consider a transmission of digitally modulated symbols over an uncorrelated flat Rician fading channel. Then, if si denotes the transmitted symbol at the ith time instant, the received symbol vi can be expressed as iiii nsrv +⋅= , (13) where {ri} denotes a sequence of independent Rician-dis- tributed random variables and ni’s are samples of a comp- lex, zero-mean white Gaussian noise process with one-si- ded power spectral density N0. A MATLAB m-file, named psk_rice, is given below, wherein the performance of pha- se shift keying (PSK) signaling over such a fading channel is simulated. It should be mentioned that the simulation example requires the Communications Toolbox of MAT- LAB and the m-file rice_fading in order to run. function BER = psk_rice(logEbNo,M,Kdb) k = log2(M); EbNolin = 10.^(logEbNo/10) Fd = 1; Fs = 1; Nit = 100000; Ns = 1000; Tstop = 100; for it_snr = 1:length(EbNolin) nstd = sqrt(1/(2*k*EbNolin(it_snr))); bit_err = 0; for it = 1:Nit a = randint(Ns,1,M); s = dmodce(a,Fd,Fs,'psk',M); r = rice_fading(Kdb,Ns,1); v_r = s.*r'; v = v_r + nstd*(randn(Ns,1) + ... j*randn(Ns,1)); z = ddemodce(v, Fd, Fs,'psk',M); errors = biterr(a,z); bit_err = bit_err + errors; if bit_err >= Tstop break end end B end ER(it_snr) = bit_err/(it*Ns*k); semilogy(logEbNo, BER,'k'); xlabel('EbNo(dB)'); ylabel('BER'); grid; Input arguments of the m-file psk_rice are the vector logEbNo of energy-per-bit to noise power spectral density values (in decibels), the PSK constellation size M and the Rician K-factor Kdb in decibels. The Communications Toolbox functions used in the simulation example are: randint (generate matrix of uniformly distributed random integers), dmodce (baseband digital modulator), ddemodce (digital baseband demodulator) and biterr (compute number of bit errors and bit error rate). Notice how the for-end loops are used in the simulation. The outer loop is used for signal-to-noise ratio (SNR) points enume- ration, while (for each SNR point) the inner loop iterates a finite number of frames of PSK symbols until a threshold value of bit errors is reached (thanks to the if-break-end construction) or the total number of frames is executed. Finally, the estimated bit error rate (BER) is plotted versus the SNR points by means of the MATLAB function semilogy. It should be mentioned that the simulation accu- racy is determined by the number of errors observed. A rule of thumb is that after 100 errors the estimated BER is within a factor 1.3 of the true BER (with approximately 99 percent confidence). So, a threshold value of 100 bit errors is used in the simulation for early stopping the inner loop iterations. One can also apply a set of SNR-dependent threshold values to avoid a time-consuming simulation. The simulation result is shown in Fig.4 for quadrature pha- se shift keying (QPSK) signaling and two different Rician K-factors (given in decibels). 0 5 10 15 20 25 10 -4 10 -3 10 -2 10 -1 10 0 Eb/No (dB) BER Kdb = -inf Kdb = 5 Fig. 4. Bit error rate performance of QPSK signaling over an uncorrelated Rician fading channel. 5. Conclusions In this paper, an approach to demonstrate mobile radio channels modeling in MATLAB is presented. The basic types of small-scale fading channel models are derived and simulated using MATLAB. The developed channel models can be extended with minor additions to model other types of fading channels (for example, a correlated Rician fading channel). Further, simple and useful MATLAB constructions for approximation of CDFs and PDFs are also given. Finally, the presented Monte Carlo simulation example can be used as a framework for performance estimation of various digital modulation schemes in MATLAB.
  • 5. 16 N. KOSTOV, MOBILE RADIO CHANNELS MODELING IN MATLAB References [1] SKLAR, B. Rayleigh fading channels in mobile digital communica- tion systems, Part I: Characterization. IEEE Communications Maga- zine, 1997, vol. 35, no. 7, p. 90 - 100. [2] SUZUKI, H. A statistical model for urban radio propagation. IEEE Transactions on Communications, 1977, vol. COM-25, no. 7, p. 673 to 680. [3] PROAKIS, J. G. Digital communications. 2nd ed. New York: McGraw-Hill, 1989. [4] CLARKE, R. H. A statistical theory of mobile-radio reception. Bell Systems Technical Journal, 1968, vol. 47, no. 6, p. 957 - 1000. [5] JAKES, W. C. Microwave mobile communications. New York: Wiley, 1974. [6] PATZOLD, M., KILLAT, U., LAUE, F., LI, Y. On the statistical properties of deterministic simulation models for mobile fading channels. IEEE Transactions on Vehicular Technology, 1998, vol. 47, no. 1, p. 254 - 269. [7] HOEHER, P. A statistical discrete-time model for the WSSUS multi- path channel. IEEE Transactions on Vehicular Technology, 1992, vol. 41, no. 4, p. 461 - 468. [8] ZHENG, Y., R., XIAO, C. Improved models for the generation of multiple uncorrelated Rayleigh fading waveforms. IEEE Communi- cations Letters, 2002, vol. 6, no. 6, p. 256 - 258. About Author Nikolay KOSTOV was born in Varna, Bulgaria, on Au- gust 7, 1969. He received Dipl. Eng. and Dr. Eng. degrees from the National Military University of Veliko Turnovo, Bulgaria, in 1993 and 1999, respectively. He joined the Radio Engineering Department at Technical University of Varna, Bulgaria, in March 2001, where he is currently ser- ving as an Assistant Professor. His research interests inclu- de source/channel coding, modulation techniques, and communications over fading channels. Book Review: Multimedia Communications. Multimedia Technology and Watermarking Dušan Levický, Technical University of Košice The monograph Multimedia communications written by Dušan Levický, a professor of Electrical Engineering at the Technical University of Košice tries to cover a full spectrum of multimedia systems, methods and standards. Many conferences and journals have been devoted to the multimedia in several last years. Numerous standards, coding methods and other techniques have been developed. It is not easy to get desired detailed information from this area or to obtain a general overview on multimedia. We suppose, this could be the main reason for writing the mo- nograph. The first three chapters are devoted to the multimedia systems, multimedia services and to the classification of multimedia signals. Chapter 4 presents basics of compression methods for multimedia. The short but important last section of the Chapter 4 contains evaluation methods of the decompres- sed information quality. International digital facsimile co- ding standards are described in Chapter 5. Chapters 6, 7 and 8 present coding of pictures and image sequences. Existing digital video-coding standards are summari- zed in Chapter 9. Chapter 10 gives an introduction to speech-coding standards, including standards for mobile communications. Audio-coding standards are given in Chapter 11. Chapter 12 is devoted to watermarking digital image and video data. The book contains list of references, list of standards and a useful index. It seems, the reviewed book successfully fills the gap in the Slovak and Czech literature. Reviewers can recom- mend Multimedia communications to any engineer, techni- cian, student and researcher interested in this subject. LEVICKÝ, D. Multimedia Communications. Multimedia technology and Watermarking. Košice: Elfa s.r.o., 2003. Address of the bookseller: Elfa, s.r.o. , Letná 9, 04200 Košice, Slovakia, knihy@elfa.sk Price: 149 SK Reviewers: Vladimír Šebesta and Stanislav Hanus