ELT DIGITAL COMMUNICATIONS

Size: px
Start display at page:

Download "ELT DIGITAL COMMUNICATIONS"

Transcription

1 ELT DIGITAL COMMUNICATIONS Matlab Exercise #2 Baseband equivalent digital transmission in AWGN channel: Transmitter and receiver structures - QAM signals, Gray coding and bit error probability calculations 1 SYSTEM MODEL AND GENERATION OF BIT SEQUENCE AND QAM SYMBOLS Note that this exercise uses a similar system model as was used in exercise 1, except that now we start from a bit sequence in the TX and end up to bit error rate (BER) calculations in the RX. Consequently, it is highly recommended that you use your Matlab code from the last exercise session as a starting point today. So please find the points where you need to change your code and do the changes according to the instructions. Note that the parts, which will be unchanged, are written in this document in gray color 1.1 SYSTEM MODEL In this exercise, we create a baseband equivalent QAM transmission system including a transmitter (TX), a receiver (RX), and a simple AWGN (Additive White Gaussian Noise) channel model. We consider the TX and RX structures to be similar to the ones shown in Fig. 1. Here, both the TX and RX structure are based on complex calculations, but the same structures can also be implemented by using only real-valued signals (i.e., I/Q-modulation with separate I and Q branches). As transmit and receive filters we use the Root-Raised-Cosine (RRC) filters. Together (in TX and RX) these filters fulfill the Nyquist criterion (i.e. no inter-symbol-interference (ISI)). Notice that a single RRC does not do this unlike with the conventional raised-cosine filter. Bit sequence bits Bits to symbols Transmitter Complex symbols k Transmit filter gt () Complex baseband signal a st () Noise r(t) Receive filter f(t) qt () Sampler Receiver q(k) Decicion Detected symbols aˆk Symbols to bits Detected bits Figure 1: Baseband equivalent system structure with AWGN channel. 1.2 CONSIDERED SYSTEM PARAMETERS First let s define the general system parameters as follows: SNR = 0:2:24; % Signal-to-noise ratio vector [db] T = 1/10e6; % Symbol time interval [s] r = 4; % Oversampling factor (r samples per pulse) N_symbols_per_pulse = 40; % Duration of TX/RX filter in symbols alpha = 0.20; % Roll-off factor (excess bandwidth)

2 Based on above we can define sampling frequency and sampling time interval as Fs = r/t; % Sampling frequency Ts = 1/Fs; % Sampling time interval 1.3 GENERATION OF BIT SEQUENCE AND QAM SYMBOLS We start by defining the number of symbols to be transmitted (to be compatible with the code from the last week). This way we can easily calculate how long bit sequence we need to generate. Note that in practice we would of course start from the bits, no matter how many of those we have. N_symbols = ; % Number of symbols Generate the symbol alphabet o Create a 64-QAM constellation (help bsxfun) o Scale the constellation so that the expected average power of transmitted symbols equals to one % Alphabet size M = 64; % Number of symbols in the QAM alphabet (e.g. 16 means 16-QAM). % Valid alphabet sizes are 4, 16, 64, 256, 1024,... % (i.e. the possible values are given by the vector 2.^(2:2:N), for any N) % Here qam_axis presents the symbol values in real/imaginary axis. % So, generally for different alphabet/constellation sizes (): qam_axis = -sqrt(m)+1:2:sqrt(m)-1; % For example, the above results in % qam_axis = [-1 1]; % for QPSK % qam_axis = [ ]; % for 16-QAM % qam_axis = [ ]; % for 64-QAM % generation of a complex constellation: alphabet = bsxfun(@plus,qam_axis',1j*qam_axis); %help bsxfun % equivalent to alphabet = repmat(qam_axis', 1, sqrt(alphabet_size)) +... % repmat(1j*qam_axis, sqrt(alphabet_size), 1); alphabet = alphabet(:).'; % alphabet symbols as a row vector % Scaling the constellation, so that the mean power of a transmitted symbol % is one (e.g., with QPSK this is 1/sqrt(2), and for 16-QAM 1/sqrt(10)) alphabet_scaling_factor = 1/sqrt(mean(abs(alphabet).^2)); alphabet = alphabet*alphabet_scaling_factor; Then generate a random bit sequence to be transmitted % Number of bits, defined for a fixed alphabet size and number of symbols N_bits = log2(m)*n_symbols; % Random bit sequence bits = randi(2,n_bits,1)-1; Reshape the bit sequence based on the symbol alphabet size (i.e. how many bits are plugged into a single symbol) and calculate the symbol indices corresponding to the bit block values % Block of bits in the columns B = reshape(bits,log2(m),[]);

3 % Powers of two:..., 2^3, 2^2, 2^1, 2^0 q = 2.^(log2(M)-1:-1:0); % Symbol indices between 0...M-1, i.e. bit blocks to decimal numbers symbol_indices = q*b; In this exercise, we use Gray coding. In order to make sure that you understand the basic principles of such coding, do the following task: PEN&PAPER TASK: Lets consider a 4-QAM symbol alphabet, i.e. the symbols are in the corners of a square. Your task is to place four different bit sequences (00, 01, 10, 11) into the symbol alphabet such that the resulting bit-to-symbol mapping fulfills the idea of Gray coding. Gray coding could be done directly by reordering the symbol alphabet, but now we use a Matlab function to map the original symbol indices to the ones, which take into account the requirement of the Gray code, i.e. that neighboring symbols differ always only by one bit. % Gray coded symbol indices. This is basically an operation where the % symbol indices are mapped to Gray-coded symbol indices. Another option % would be reordering the original symbol alphabet, but the overall effects % would be exactly the same. [Gray_symbol_indices, ~] = bin2gray(symbol_indices, 'qam', M); % Symbols from the alphabet, based on the Gray-coded symbol indices above. % Note that we need to add 1 to the indices since the indexing must be % between 1...M (the addition is later removed in the RX). symbols = alphabet(gray_symbol_indices+1); 2 TRANSMITTER STRUCTURE By following the TX structure in Fig. 1, we generate a continuous time QAM signal based on the abovedefined system parameters. Implement the transit filter: Root-Raised-Cosine (RRC) and plot the pulse shape % Filter generation gt = rcosdesign(alpha,n_symbols_per_pulse,r,'sqrt'); % Plot the pulse shape of the transmit/receive filter figure plot(-n_symbols_per_pulse*r/2*ts:ts:n_symbols_per_pulse*r/2*ts,gt,'b') hold on stem(- N_symbols_per_pulse*r/2*Ts:T:N_symbols_per_pulse*r/2*Ts,gt(1:r:end),'ro') xlabel('time [s]') ylabel('amplitude') title('transmit/receive RRC filter (pulse shape)') legend('pulse shape','ideal symbol-sampling locations') Filter the transmitted symbol sequence. Remember to upsample the symbol sequence rate to match with sampling rate of the filter/pulse: % Zero vector initilized for up-sampled symbol sequence symbols_upsampled = zeros(size(1:r*n_symbols)); % symbol insertion symbols_upsampled(1:r: r*n_symbols) = symbols; % now the up-sampled sequence looks like {a a a } st = filter(gt,1,symbols_upsampled); % Transmitter filtering st = st(1+(length(gt)-1)/2:end); % Filter delay correction

4 Plot the transmit signal s(t) in time and frequency domain figure % zoom manually to see the signal better plot(abs(st)) xlabel('time [s]') ylabel('amplitude (of a complex signal)') title('signal s(t) in time domain') NFFT = 2^14; %FFT size f = -Fs/2:1/(NFFT*Ts):Fs/2-1/(NFFT*Ts); %frequency vector % Plot the transmit signal in frequency domain figure(4) subplot(2,2,1); plot(f/1e6, fftshift(abs(fft(st, NFFT)))); xlabel('frequency [MHz]') ylabel('amplitude ') title('tx signal s(t)') ylim([0 500]); 3 CHANNEL MODEL Here we consider a simple AWGN channel model. We create white random noise, scale it with the proper scaling factor to obtain the desired SNR (after receive filtering), and then add it on top of the transmitted signal s(t). Generate the noise vector % Complex white Gaussian random noise n = (1/sqrt(2))*(randn(size(st)) + 1j*randn(size(st))); P_s = var(st); % Signal power P_n = var(n); % Noise power % Defining noise scaling factor based on the desired SNR: noise_scaling_factor = sqrt(p_s/p_n./10.^(snr./10)*(r/(1+alpha))); Add noise on top of the signal s(t). Remember that the variable SNR is now a vector. % Initialization for RX signal matrix, where each row represents the % received signal with a specific SNR value rt = zeros(length(snr), length(st)); % Received signal with different SNR values for ii = 1:1:length(SNR) rt(ii,:) = st + noise_scaling_factor(ii)*n; end Plot the amplitude spectrum of the noise and noisy bandpass signal % Plot the amplitude response of the noise with the SNR corresponding % to the last value in the SNR vector (just as an example) figure(4) subplot(2,2,2) plot(f/1e6, fftshift(abs(fft(noise_scaling_factor(end)*n, NFFT)))); xlabel('frequency [MHz]') ylabel('amplitude') title(['noise (corresponding to SNR = ', num2str(snr(end)), ' db)']) ylim([0 500]); % Received signal with the noise when the SNR is equal to the last value of % the SNR vector figure(4) subplot(2,2,3)

5 plot(f/1e6, fftshift(abs(fft(rt(end,:), NFFT)))); xlabel('frequency [MHz]') ylabel('amplitude') title(['rx signal r(t) (SNR = ', num2str(snr(end)), ' db)']) ylim([0 500]); 4 RECEIVER STRUCTURE Typically, due to many unknown/uncertain parameters, most of the complexity in a communications system is found on the RX side. Now, by following the RX structure in Fig. 1, we estimate the transmitted symbols from the received noisy bandpass QAM signal. 4.1 SIGNAL FILTERING AND SAMPLING Filter the received signal r(t) with the receive filter (RRC similar to TX) and sample the resulting continuous time signal q(t) in order to obtain the discrete time signal sequence q(k). % Creating the receive filter (it is the same as in the transmitter) ft = gt; % Plotting the amplitude response of the receive filter figure(4) subplot(2,2,4) plot(f/1e6, fftshift(abs(fft(ft, NFFT)))); xlabel('frequency [MHz]') ylabel('amplitude') title('rx filter f(t)') % Initialization for the received symbol matrix, where each row represents % the symbols with a specific SNR value qk = zeros(length(snr), N_symbols - N_symbols_per_pulse); % Note that due to filtering transitions, we loose some of the last % symbols of the symbol sequence. In practice we would simply continue % taking a few samples after the sequence to try to get all the symbols. % However, filter transitions in the beginning and in end are always % creating non-idealities to the transmission (the same is also happening % in frequency domain: e.g. compare data in the middle and in the edge of % the used band). % Filtering and sampling for ii = 1:1:length(SNR) qt = filter(ft,1,rt(ii,:)); % Receiver filtering qt = qt(1+(length(ft)-1)/2:end); % Filter delay correction end % Sampling the filtered signal. Remember that we used oversampling in % the TX. qk(ii,:) = qt(1:r:end); Plot the samples in a complex plane (constellation) with a few different SNR values % Plot a few examples of the noisy samples and compare them with the % original symbol alphabet figure(5) subplot(3,1,1) plot(qk(1,:),'b*') hold on plot(alphabet,'ro', 'MarkerFaceColor','r') hold off legend('received samples', 'Original symbols')

6 xlabel('re') ylabel('im') title(['received samples with SNR = ', num2str(snr(1)), ' db']) axis equal figure(5) subplot(3,1,2) mid_ind = ceil(length(snr)/2); % index for the entry in the middle plot(qk(mid_ind,:),'b*') hold on plot(alphabet,'ro', 'MarkerFaceColor','r') hold off legend('received samples ', 'Original symbols') xlabel('re') ylabel('im') title(['received samples with SNR = ', num2str(snr(mid_ind)), ' db']) axis equal figure(5) subplot(3,1,3) plot(qk(end, :),'b*') hold on plot(alphabet,'ro', 'MarkerFaceColor','r') hold off legend('received samples ', 'Original symbols') xlabel('re') ylabel('im') title(['received samples with SNR = ', num2str(snr(end)), ' db']) axis equal 4.2 OBTAINING SYMBOL DECISIONS, MAPPING SYMBOLS TO BITS AND CALCULATING BER The next step is to make the symbol decisions. This is done based on the minimum distance principle, where the symbol estimate is defined as that symbol of the alphabet, which minimizes the distance to the symbol sample. Calculate the Euclidian distance between each symbol sample and each alphabet symbol. Then find the indices of the alphabet symbols, which have the minimum distance to the symbol samples. Then decode the Gray-coded symbols to bits, and finally find out which bits were received incorrectly and define the observed Bit Error Rate (BER). Remember again that we used multiple SNR values and each row of the signal samples q(k) represents the received signal with different SNRs. % Initialization BER = zeros(1,length(snr)); for ii = 1:1:length(SNR) alphabet_error_matrix = abs(bsxfun(@minus,alphabet.',qk(ii,:))); % Now, rows represent the alphabet symbol indices and columns represent % the received symbol indices (e.g. the Euclidian distance between the % 5th received symbol and the 3rd symbol in the alphabet is given as % "alphabet_error_matrix(3,5)" % Searching for the indeces corresponding to the minimum distances [~,estimated_gray_symbol_ind] = min(alphabet_error_matrix);

7 % Decoding the Gray-coded symbol indices. Remember that we added 1 to % the Gray-coded symbol indices in the TX, so now its effects % need to be removed by substracting 1 from the estimated Gray coded % symbol indeces. estimated_symbol_indices =... gray2bin(estimated_gray_symbol_ind-1,'qam',m); % block of estimated bits in the columns estimated_bit_blocks =... rem(floor((estimated_symbol_indices(:))*2.^(1-log2(m):0)),2)'; % remember again that we have to remove one from the estimated symbol % indices ("estimated_symbol_ind(:)-1") in order to get numbers to start % from zero value % Bit blocks to bit vector estimated_bits = estimated_bit_blocks(:); % Finding out which bits were estimated incorrecly: bit_errors =... estimated_bits ~= bits(1:length(estimated_bits)); % Bit error rate (0 means 0% of errors, 1 means 100% of errors) BER(1,ii) = mean(bit_errors); end The final step is then to plot the obtained results and compare them with the theoretical approximation of the bit error probability. In order to do that, we need first to calculate the theoretical symbol error probability (see p. 153 from the lecture slides). % Based on the lecture slides on p. 156, an approximation for the BER can % be given as BER = 1/log2(M) * symbol_error_probability, assuming Gray % coding where the nearest neigbors differ only one bit. % Find out the minimum distance between two constellation points d = min(abs(alphabet(1)-alphabet(2:end))); % Sigma values. Note that we need to first divide the original power of the % noise by two in order to get the parameter used in the equations. % Variable noise_scaling_factor was used for amplitudes so we need to % square it for getting the corresponding power scaling factor. sigma = sqrt(0.5 * P_n * noise_scaling_factor.^2); % Theoretical symbol error probability applicable to all M-QAM alphabets. P_sym_error = (4*qfunc(d./(2*sigma)) - 4*qfunc(d./(2*sigma)).^2) *... ((M-4-4*(sqrt(M)-2))/M) +... (2*qfunc(d./(2*sigma))- qfunc(d./(2*sigma)).^2) * (4/M) +... (3*qfunc(d./(2*sigma)) - 2*qfunc(d./(2*sigma)).^2) * (4*(sqrt(M)-2)/M); Compare the simulated results with the theoretical results % Compare the simulated and theoretical results. figure semilogy(snr, BER, 'LineWidth', 3); hold on; semilogy(snr, (1/log2(M))*P_sym_error, 'r--', 'LineWidth', 2); title('bit error rate')

8 xlabel('snr [db]') ylabel('ber') legend('simulated BER with Gray coding',... 'Theoretical bit error probability (approx.)','location', 'SouthWest'); Do the simulated results match with the theoretical ones? Where you can see differences and why there?

ELT DIGITAL COMMUNICATIONS

ELT DIGITAL COMMUNICATIONS ELT-43007 DIGITAL COMMUNICATIONS Matlab Exercise #1 Baseband equivalent digital transmission in AWGN channel: Transmitter and receiver structures - QAM signals, symbol detection and symbol error probability

More information

ELT COMMUNICATION THEORY

ELT COMMUNICATION THEORY ELT 41307 COMMUNICATION THEORY Project work, Fall 2017 Experimenting an elementary single carrier M QAM based digital communication chain 1 ASSUMED SYSTEM MODEL AND PARAMETERS 1.1 SYSTEM MODEL In this

More information

Wireless Communication Systems Laboratory Lab#1: An introduction to basic digital baseband communication through MATLAB simulation Objective

Wireless Communication Systems Laboratory Lab#1: An introduction to basic digital baseband communication through MATLAB simulation Objective Wireless Communication Systems Laboratory Lab#1: An introduction to basic digital baseband communication through MATLAB simulation Objective The objective is to teach students a basic digital communication

More information

ELT Receiver Architectures and Signal Processing Fall Mandatory homework exercises

ELT Receiver Architectures and Signal Processing Fall Mandatory homework exercises ELT-44006 Receiver Architectures and Signal Processing Fall 2014 1 Mandatory homework exercises - Individual solutions to be returned to Markku Renfors by email or in paper format. - Solutions are expected

More information

Exercises for chapter 2

Exercises for chapter 2 Exercises for chapter Digital Communications A baseband PAM system uses as receiver filter f(t) a matched filter, f(t) = g( t), having two choices for transmission filter g(t) g a (t) = ( ) { t Π =, t,

More information

a) Abasebanddigitalcommunicationsystemhasthetransmitterfilterg(t) thatisshowninthe figure, and a matched filter at the receiver.

a) Abasebanddigitalcommunicationsystemhasthetransmitterfilterg(t) thatisshowninthe figure, and a matched filter at the receiver. DIGITAL COMMUNICATIONS PART A (Time: 60 minutes. Points 4/0) Last Name(s):........................................................ First (Middle) Name:.................................................

More information

Exploring QAM using LabView Simulation *

Exploring QAM using LabView Simulation * OpenStax-CNX module: m14499 1 Exploring QAM using LabView Simulation * Robert Kubichek This work is produced by OpenStax-CNX and licensed under the Creative Commons Attribution License 2.0 1 Exploring

More information

Digital Communication System

Digital Communication System Digital Communication System Purpose: communicate information at required rate between geographically separated locations reliably (quality) Important point: rate, quality spectral bandwidth, power requirements

More information

Digital Communication System

Digital Communication System Digital Communication System Purpose: communicate information at certain rate between geographically separated locations reliably (quality) Important point: rate, quality spectral bandwidth requirement

More information

FACULTY OF ENGINEERING LAB SHEET ETN3046 ANALOG AND DIGITAL COMMUNICATIONS TRIMESTER 1 (2018/2019) ADC2 Digital Carrier Modulation

FACULTY OF ENGINEERING LAB SHEET ETN3046 ANALOG AND DIGITAL COMMUNICATIONS TRIMESTER 1 (2018/2019) ADC2 Digital Carrier Modulation FACULTY OF ENGINEERING LAB SHEET ETN3046 ANALOG AND DIGITAL COMMUNICATIONS TRIMESTER 1 (2018/2019) ADC2 Digital Carrier Modulation TC Chuah (2018 July) Page 1 ADC2 Digital Carrier Modulation with MATLAB

More information

Revision of Lecture 3

Revision of Lecture 3 Revision of Lecture 3 Modulator/demodulator Basic operations of modulation and demodulation Complex notations for modulation and demodulation Carrier recovery and timing recovery This lecture: bits map

More information

EE3723 : Digital Communications

EE3723 : Digital Communications EE3723 : Digital Communications Week 11, 12: Inter Symbol Interference (ISI) Nyquist Criteria for ISI Pulse Shaping and Raised-Cosine Filter Eye Pattern Equalization (On Board) 01-Jun-15 Muhammad Ali Jinnah

More information

Fund. of Digital Communications Ch. 3: Digital Modulation

Fund. of Digital Communications Ch. 3: Digital Modulation Fund. of Digital Communications Ch. 3: Digital Modulation Klaus Witrisal witrisal@tugraz.at Signal Processing and Speech Communication Laboratory www.spsc.tugraz.at Graz University of Technology November

More information

Digital Signal Analysis

Digital Signal Analysis Digital Signal Analysis Objectives - Provide a digital modulation overview - Review common digital radio impairments Digital Modulation Overview Signal Characteristics to Modify Polar Display / IQ Relationship

More information

Computer Exercises in. Communication Theory SMS016

Computer Exercises in. Communication Theory SMS016 Luleå Tekniska Universitet Avd. för Signalbehandling Jan-Jaap van de Beek Frank Sjöberg Computer Exercises in Communication Theory SMS016 November 2001 Computer Exercises to be carried out in groups of

More information

LOOKING AT DATA SIGNALS

LOOKING AT DATA SIGNALS LOOKING AT DATA SIGNALS We diplay data signals graphically in many ways, ranging from textbook illustrations to test equipment screens. This note helps you integrate those views and to see how some modulation

More information

Revision of Wireless Channel

Revision of Wireless Channel Revision of Wireless Channel Quick recap system block diagram CODEC MODEM Wireless Channel Previous three lectures looked into wireless mobile channels To understand mobile communication technologies,

More information

Biomedical Signals. Signals and Images in Medicine Dr Nabeel Anwar

Biomedical Signals. Signals and Images in Medicine Dr Nabeel Anwar Biomedical Signals Signals and Images in Medicine Dr Nabeel Anwar Noise Removal: Time Domain Techniques 1. Synchronized Averaging (covered in lecture 1) 2. Moving Average Filters (today s topic) 3. Derivative

More information

Revision of Lecture 2

Revision of Lecture 2 Revision of Lecture 2 Pulse shaping Tx/Rx filter pair Design of Tx/Rx filters (pulse shaping): to achieve zero ISI and to maximise received signal to noise ratio Combined Tx/Rx filters: Nyquist system

More information

EE5713 : Advanced Digital Communications

EE5713 : Advanced Digital Communications EE573 : Advanced Digital Communications Week 4, 5: Inter Symbol Interference (ISI) Nyquist Criteria for ISI Pulse Shaping and Raised-Cosine Filter Eye Pattern Error Performance Degradation (On Board) Demodulation

More information

ELT COMMUNICATION THEORY

ELT COMMUNICATION THEORY ELT-41307 COMMUNICATION THEORY Matlab Exercise #5 Carrier mdulated digital transmissin: Transmitter and receiver structures QAM signals, up/dwncnversin, timing and phase synchrnizatin, and symbl detectin

More information

UNIT I Source Coding Systems

UNIT I Source Coding Systems SIDDHARTH GROUP OF INSTITUTIONS: PUTTUR Siddharth Nagar, Narayanavanam Road 517583 QUESTION BANK (DESCRIPTIVE) Subject with Code: DC (16EC421) Year & Sem: III-B. Tech & II-Sem Course & Branch: B. Tech

More information

Lecture 13. Introduction to OFDM

Lecture 13. Introduction to OFDM Lecture 13 Introduction to OFDM Ref: About-OFDM.pdf Orthogonal frequency division multiplexing (OFDM) is well-known to be effective against multipath distortion. It is a multicarrier communication scheme,

More information

Swedish College of Engineering and Technology Rahim Yar Khan

Swedish College of Engineering and Technology Rahim Yar Khan PRACTICAL WORK BOOK Telecommunication Systems and Applications (TL-424) Name: Roll No.: Batch: Semester: Department: Swedish College of Engineering and Technology Rahim Yar Khan Introduction Telecommunication

More information

Lecture 5: Simulation of OFDM communication systems

Lecture 5: Simulation of OFDM communication systems Lecture 5: Simulation of OFDM communication systems March 28 April 9 28 Yuping Zhao (Doctor of Science in technology) Professor, Peking University Beijing, China Yuping.zhao@pku.edu.cn Single carrier communcation

More information

Digital Modulation Schemes

Digital Modulation Schemes Digital Modulation Schemes 1. In binary data transmission DPSK is preferred to PSK because (a) a coherent carrier is not required to be generated at the receiver (b) for a given energy per bit, the probability

More information

MSK has three important properties. However, the PSD of the MSK only drops by 10log 10 9 = 9.54 db below its midband value at ft b = 0.

MSK has three important properties. However, the PSD of the MSK only drops by 10log 10 9 = 9.54 db below its midband value at ft b = 0. Gaussian MSK MSK has three important properties Constant envelope (why?) Relatively narrow bandwidth Coherent detection performance equivalent to that of QPSK However, the PSD of the MSK only drops by

More information

DE63 DIGITAL COMMUNICATIONS DEC 2014

DE63 DIGITAL COMMUNICATIONS DEC 2014 Q.2 a. Draw the bandwidth efficiency curve w.r.t E b /N o. Compute the value of E b /N o required to achieve the data rate equal to the channel capacity if the channel bandwidth tends to infinity b. A

More information

Lab 3.0. Pulse Shaping and Rayleigh Channel. Faculty of Information Engineering & Technology. The Communications Department

Lab 3.0. Pulse Shaping and Rayleigh Channel. Faculty of Information Engineering & Technology. The Communications Department Faculty of Information Engineering & Technology The Communications Department Course: Advanced Communication Lab [COMM 1005] Lab 3.0 Pulse Shaping and Rayleigh Channel 1 TABLE OF CONTENTS 2 Summary...

More information

Chapter 6 Passband Data Transmission

Chapter 6 Passband Data Transmission Chapter 6 Passband Data Transmission Passband Data Transmission concerns the Transmission of the Digital Data over the real Passband channel. 6.1 Introduction Categories of digital communications (ASK/PSK/FSK)

More information

TSEK02: Radio Electronics Lecture 2: Modulation (I) Ted Johansson, EKS, ISY

TSEK02: Radio Electronics Lecture 2: Modulation (I) Ted Johansson, EKS, ISY TSEK02: Radio Electronics Lecture 2: Modulation (I) Ted Johansson, EKS, ISY 2 Basic Definitions Time and Frequency db conversion Power and dbm Filter Basics 3 Filter Filter is a component with frequency

More information

Spring 2014 EE 445S Real-Time Digital Signal Processing Laboratory Prof. Evans. Homework #6 Solutions

Spring 2014 EE 445S Real-Time Digital Signal Processing Laboratory Prof. Evans. Homework #6 Solutions Spring 2014 EE 445S Real-Time Digital Signal Processing Laboratory Prof. Evans 6.1 Modified Phase Locked Loop (PLL). Homework #6 Solutions Prolog: The received signal r(t) with carrier frequency f c passes

More information

Objectives. Presentation Outline. Digital Modulation Revision

Objectives. Presentation Outline. Digital Modulation Revision Digital Modulation Revision Professor Richard Harris Objectives To identify the key points from the lecture material presented in the Digital Modulation section of this paper. What is in the examination

More information

Lecture 10 Performance of Communication System: Bit Error Rate (BER) EE4900/EE6720 Digital Communications

Lecture 10 Performance of Communication System: Bit Error Rate (BER) EE4900/EE6720 Digital Communications EE4900/EE6720: Digital Communications 1 Lecture 10 Performance of Communication System: Bit Error Rate (BER) Block Diagrams of Communication System Digital Communication System 2 Informatio n (sound, video,

More information

Revision of Previous Six Lectures

Revision of Previous Six Lectures Revision of Previous Six Lectures Previous six lectures have concentrated on Modem, under ideal AWGN or flat fading channel condition Important issues discussed need to be revised, and they are summarised

More information

Ultra Wideband Transceiver Design

Ultra Wideband Transceiver Design Ultra Wideband Transceiver Design By: Wafula Wanjala George For: Bachelor Of Science In Electrical & Electronic Engineering University Of Nairobi SUPERVISOR: Dr. Vitalice Oduol EXAMINER: Dr. M.K. Gakuru

More information

S Transmission Methods in Telecommunication Systems (5 cr) Tutorial 4/2007 (Lectures 6 and 7)

S Transmission Methods in Telecommunication Systems (5 cr) Tutorial 4/2007 (Lectures 6 and 7) S-7.1140 Transmission Methods in Telecommunication Systems (5 cr) Tutorial 4/007 (Lectures 6 and 7) 1 1. Line Codes / Johtokoodit Sketch beneath each other line codes Manchester, Differential Manchester

More information

PAPR Reduction in 4G Cellular Network: A SLM-based IFDMA Uplink System

PAPR Reduction in 4G Cellular Network: A SLM-based IFDMA Uplink System Proceedings of the Pakistan Academy of Sciences 49 (2): 79-84 (2012) Copyright Pakistan Academy of Sciences ISSN: 0377-2969 Pakistan Academy of Sciences Original Article PAPR Reduction in 4G Cellular Network:

More information

Implementation of Digital Signal Processing: Some Background on GFSK Modulation

Implementation of Digital Signal Processing: Some Background on GFSK Modulation Implementation of Digital Signal Processing: Some Background on GFSK Modulation Sabih H. Gerez University of Twente, Department of Electrical Engineering s.h.gerez@utwente.nl Version 5 (March 9, 2016)

More information

ELT COMMUNICATION THEORY

ELT COMMUNICATION THEORY ELT 41307 COMMUNICATION THEORY Matlab Exercise #1 Sampling, Fourier transform, Spectral illustrations, and Linear filtering 1 SAMPLING The modeled signals and systems in this course are mostly analog (continuous

More information

CHAPTER 3 ADAPTIVE MODULATION TECHNIQUE WITH CFO CORRECTION FOR OFDM SYSTEMS

CHAPTER 3 ADAPTIVE MODULATION TECHNIQUE WITH CFO CORRECTION FOR OFDM SYSTEMS 44 CHAPTER 3 ADAPTIVE MODULATION TECHNIQUE WITH CFO CORRECTION FOR OFDM SYSTEMS 3.1 INTRODUCTION A unique feature of the OFDM communication scheme is that, due to the IFFT at the transmitter and the FFT

More information

TSEK02: Radio Electronics Lecture 2: Modulation (I) Ted Johansson, EKS, ISY

TSEK02: Radio Electronics Lecture 2: Modulation (I) Ted Johansson, EKS, ISY TSEK02: Radio Electronics Lecture 2: Modulation (I) Ted Johansson, EKS, ISY An Overview of Modulation Techniques: chapter 3.1 3.3.1 2 Introduction (3.1) Analog Modulation Amplitude Modulation Phase and

More information

Fractionally Spaced Equalization and Frequency Diversity Methods for Block Transmission with Cyclic Prefix

Fractionally Spaced Equalization and Frequency Diversity Methods for Block Transmission with Cyclic Prefix Fractionally Spaced Equalization and Frequency Diversity Methods for Block Transmission with Cyclic Prefix Yuki Yoshida, Kazunori Hayashi, Hideaki Sakai Department of System Science, Graduate School of

More information

Experimenting with Orthogonal Frequency-Division Multiplexing OFDM Modulation

Experimenting with Orthogonal Frequency-Division Multiplexing OFDM Modulation FUTEBOL Federated Union of Telecommunications Research Facilities for an EU-Brazil Open Laboratory Experimenting with Orthogonal Frequency-Division Multiplexing OFDM Modulation The content of these slides

More information

ELEC E7210: Communication Theory. Lecture 7: Adaptive modulation and coding

ELEC E7210: Communication Theory. Lecture 7: Adaptive modulation and coding ELEC E721: Communication Theory Lecture 7: Adaptive modulation and coding Adaptive modulation and coding (1) Change modulation and coding relative to fading AMC enable robust and spectrally efficient transmission

More information

In this exam, there is a total of 35 questions resulting in 53 possible points. TestResult = floor(sum(points)/4.86);

In this exam, there is a total of 35 questions resulting in 53 possible points. TestResult = floor(sum(points)/4.86); .... Midterm Exam: Institut für Nachrichtentechnik und Hochfrequenztechnik In this exam, there is a total of 35 questions resulting in 53 possible points. TestResult = floor(sum(points)/4.86); The four

More information

Real and Complex Modulation

Real and Complex Modulation Real and Complex Modulation TIPL 4708 Presented by Matt Guibord Prepared by Matt Guibord 1 What is modulation? Modulation is the act of changing a carrier signal s properties (amplitude, phase, frequency)

More information

ECE 630: Statistical Communication Theory

ECE 630: Statistical Communication Theory ECE 630: Statistical Communication Theory Dr. B.-P. Paris Dept. Electrical and Comp. Engineering George Mason University Last updated: January 23, 2018 2018, B.-P. Paris ECE 630: Statistical Communication

More information

Presentation Outline. Advisors: Dr. In Soo Ahn Dr. Thomas L. Stewart. Team Members: Luke Vercimak Karl Weyeneth. Karl. Luke

Presentation Outline. Advisors: Dr. In Soo Ahn Dr. Thomas L. Stewart. Team Members: Luke Vercimak Karl Weyeneth. Karl. Luke Bradley University Department of Electrical and Computer Engineering Senior Capstone Project Presentation May 2nd, 2006 Team Members: Luke Vercimak Karl Weyeneth Advisors: Dr. In Soo Ahn Dr. Thomas L.

More information

Wireless Communication

Wireless Communication Wireless Communication Systems @CS.NCTU Lecture 2: Modulation and Demodulation Reference: Chap. 5 in Goldsmith s book Instructor: Kate Ching-Ju Lin ( 林靖茹 ) 1 Modulation From Wikipedia: The process of varying

More information

Module 12 : System Degradation and Power Penalty

Module 12 : System Degradation and Power Penalty Module 12 : System Degradation and Power Penalty Lecture : System Degradation and Power Penalty Objectives In this lecture you will learn the following Degradation during Propagation Modal Noise Dispersion

More information

BER Performance with GNU Radio

BER Performance with GNU Radio BER Performance with GNU Radio Digital Modulation Digital modulation is the process of translating a digital bit stream to analog waveforms that can be sent over a frequency band In digital modulation,

More information

Department of Electronics and Communication Engineering 1

Department of Electronics and Communication Engineering 1 UNIT I SAMPLING AND QUANTIZATION Pulse Modulation 1. Explain in detail the generation of PWM and PPM signals (16) (M/J 2011) 2. Explain in detail the concept of PWM and PAM (16) (N/D 2012) 3. What is the

More information

NI USRP Lab: DQPSK Transceiver Design

NI USRP Lab: DQPSK Transceiver Design NI USRP Lab: DQPSK Transceiver Design 1 Introduction 1.1 Aims This Lab aims for you to: understand the USRP hardware and capabilities; build a DQPSK receiver using LabVIEW and the USRP. By the end of this

More information

UNIFIED DIGITAL AUDIO AND DIGITAL VIDEO BROADCASTING SYSTEM USING ORTHOGONAL FREQUENCY DIVISION MULTIPLEXING (OFDM) SYSTEM

UNIFIED DIGITAL AUDIO AND DIGITAL VIDEO BROADCASTING SYSTEM USING ORTHOGONAL FREQUENCY DIVISION MULTIPLEXING (OFDM) SYSTEM UNIFIED DIGITAL AUDIO AND DIGITAL VIDEO BROADCASTING SYSTEM USING ORTHOGONAL FREQUENCY DIVISION MULTIPLEXING (OFDM) SYSTEM 1 Drakshayini M N, 2 Dr. Arun Vikas Singh 1 drakshayini@tjohngroup.com, 2 arunsingh@tjohngroup.com

More information

Lab 2: Digital Modulations

Lab 2: Digital Modulations Lab 2: Digital Modulations Due: November 1, 2018 In this lab you will use a hardware device (RTL-SDR which has a frequency range of 25 MHz 1.75 GHz) to implement a digital receiver with Quaternary Phase

More information

Digital Modulators & Line Codes

Digital Modulators & Line Codes Digital Modulators & Line Codes Professor A. Manikas Imperial College London EE303 - Communication Systems An Overview of Fundamental Prof. A. Manikas (Imperial College) EE303: Dig. Mod. and Line Codes

More information

Experiment 1 Introduction to MATLAB and Simulink

Experiment 1 Introduction to MATLAB and Simulink Experiment 1 Introduction to MATLAB and Simulink INTRODUCTION MATLAB s Simulink is a powerful modeling tool capable of simulating complex digital communications systems under realistic conditions. It includes

More information

Nyquist, Shannon and the information carrying capacity of signals

Nyquist, Shannon and the information carrying capacity of signals Nyquist, Shannon and the information carrying capacity of signals Figure 1: The information highway There is whole science called the information theory. As far as a communications engineer is concerned,

More information

An Efficient Educational Approach for the Study of 16 QAM and Block Codes

An Efficient Educational Approach for the Study of 16 QAM and Block Codes An Efficient Educational Approach for the Study of 16 QAM and Block Codes Luciano L. Mendes and Geraldo G. R. Gomes Abstract: The main purpose of this paper is to show how some programs developed in the

More information

Lab course Analog Part of a State-of-the-Art Mobile Radio Receiver

Lab course Analog Part of a State-of-the-Art Mobile Radio Receiver Communication Technology Laboratory Wireless Communications Group Prof. Dr. A. Wittneben ETH Zurich, ETF, Sternwartstrasse 7, 8092 Zurich Tel 41 44 632 36 11 Fax 41 44 632 12 09 Lab course Analog Part

More information

Performance Analysis of Ofdm Transceiver using Gmsk Modulation Technique

Performance Analysis of Ofdm Transceiver using Gmsk Modulation Technique Performance Analysis of Ofdm Transceiver using Gmsk Modulation Technique Gunjan Negi Student, ECE Department GRD Institute of Management and Technology Dehradun, India negigunjan10@gmail.com Anuj Saxena

More information

EE 435/535: Error Correcting Codes Project 1, Fall 2009: Extended Hamming Code. 1 Introduction. 2 Extended Hamming Code: Encoding. 1.

EE 435/535: Error Correcting Codes Project 1, Fall 2009: Extended Hamming Code. 1 Introduction. 2 Extended Hamming Code: Encoding. 1. EE 435/535: Error Correcting Codes Project 1, Fall 2009: Extended Hamming Code Project #1 is due on Tuesday, October 6, 2009, in class. You may turn the project report in early. Late projects are accepted

More information

Digital Filters in 16-QAM Communication. By: Eric Palmgren Fabio Ussher Samuel Whisler Joel Yin

Digital Filters in 16-QAM Communication. By: Eric Palmgren Fabio Ussher Samuel Whisler Joel Yin Digital Filters in 16-QAM Communication By: Eric Palmgren Fabio Ussher Samuel Whisler Joel Yin Digital Filters in 16-QAM Communication By: Eric Palmgren Fabio Ussher Samuel Whisler Joel Yin Online:

More information

Statistical Communication Theory

Statistical Communication Theory Statistical Communication Theory Mark Reed 1 1 National ICT Australia, Australian National University 21st February 26 Topic Formal Description of course:this course provides a detailed study of fundamental

More information

Receiver Designs for the Radio Channel

Receiver Designs for the Radio Channel Receiver Designs for the Radio Channel COS 463: Wireless Networks Lecture 15 Kyle Jamieson [Parts adapted from C. Sodini, W. Ozan, J. Tan] Today 1. Delay Spread and Frequency-Selective Fading 2. Time-Domain

More information

QUESTION BANK SUBJECT: DIGITAL COMMUNICATION (15EC61)

QUESTION BANK SUBJECT: DIGITAL COMMUNICATION (15EC61) QUESTION BANK SUBJECT: DIGITAL COMMUNICATION (15EC61) Module 1 1. Explain Digital communication system with a neat block diagram. 2. What are the differences between digital and analog communication systems?

More information

ON SYMBOL TIMING RECOVERY IN ALL-DIGITAL RECEIVERS

ON SYMBOL TIMING RECOVERY IN ALL-DIGITAL RECEIVERS ON SYMBOL TIMING RECOVERY IN ALL-DIGITAL RECEIVERS 1 Ali A. Ghrayeb New Mexico State University, Box 30001, Dept 3-O, Las Cruces, NM, 88003 (e-mail: aghrayeb@nmsu.edu) ABSTRACT Sandia National Laboratories

More information

Outline Chapter 3: Principles of Digital Communications

Outline Chapter 3: Principles of Digital Communications Outline Chapter 3: Principles of Digital Communications Structure of a Data Transmission System Up- and Down-Conversion Lowpass-to-Bandpass Conversion Baseband Presentation of Communication System Basic

More information

1 ICT Laboratory Overview - CIT Master

1 ICT Laboratory Overview - CIT Master 1 ICT Laboratory Overview - CIT Master 1.1 Introduction The ANT part of the ICT laboratory held in the winter term is meant to be solved in groups of two in an independent fashion with minimal help from

More information

Digital Communication Systems Third year communications Midterm exam (15 points)

Digital Communication Systems Third year communications Midterm exam (15 points) Name: Section: BN: Digital Communication Systems Third year communications Midterm exam (15 points) May 2011 Time: 1.5 hours 1- Determine if the following sentences are true of false (correct answer 0.5

More information

Outline. EECS 3213 Fall Sebastian Magierowski York University. Review Passband Modulation. Constellations ASK, FSK, PSK.

Outline. EECS 3213 Fall Sebastian Magierowski York University. Review Passband Modulation. Constellations ASK, FSK, PSK. EECS 3213 Fall 2014 L12: Modulation Sebastian Magierowski York University 1 Outline Review Passband Modulation ASK, FSK, PSK Constellations 2 1 Underlying Idea Attempting to send a sequence of digits through

More information

d[m] = [m]+ 1 2 [m 2]

d[m] = [m]+ 1 2 [m 2] DIGITAL COMMUNICATIONS PART A (Time: 60 minutes. Points 4/0) Last Name(s):........................................................ First (Middle) Name:.................................................

More information

DIGITAL COMMUNICATIONS SYSTEMS. MSc in Electronic Technologies and Communications

DIGITAL COMMUNICATIONS SYSTEMS. MSc in Electronic Technologies and Communications DIGITAL COMMUNICATIONS SYSTEMS MSc in Electronic Technologies and Communications Bandpass binary signalling The common techniques of bandpass binary signalling are: - On-off keying (OOK), also known as

More information

Objectives. Presentation Outline. Digital Modulation Lecture 03

Objectives. Presentation Outline. Digital Modulation Lecture 03 Digital Modulation Lecture 03 Inter-Symbol Interference Power Spectral Density Richard Harris Objectives To be able to discuss Inter-Symbol Interference (ISI), its causes and possible remedies. To be able

More information

Principles of Baseband Digital Data Transmission

Principles of Baseband Digital Data Transmission Principles of Baseband Digital Data Transmission Prof. Wangrok Oh Dept. of Information Communications Eng. Chungnam National University Prof. Wangrok Oh(CNU) / 3 Overview Baseband Digital Data Transmission

More information

UNIVERSITY OF WARWICK

UNIVERSITY OF WARWICK UNIVERSITY OF WARWICK School of Engineering ES905 MSc Signal Processing Module (2010) AM SIGNALS AND FILTERING EXERCISE Deadline: This is NOT for credit. It is best done before the first assignment. You

More information

Lecture 3: Wireless Physical Layer: Modulation Techniques. Mythili Vutukuru CS 653 Spring 2014 Jan 13, Monday

Lecture 3: Wireless Physical Layer: Modulation Techniques. Mythili Vutukuru CS 653 Spring 2014 Jan 13, Monday Lecture 3: Wireless Physical Layer: Modulation Techniques Mythili Vutukuru CS 653 Spring 2014 Jan 13, Monday Modulation We saw a simple example of amplitude modulation in the last lecture Modulation how

More information

Measuring Modulations

Measuring Modulations I N S T I T U T E O F C O M M U N I C A T I O N E N G I N E E R I N G Telecommunications Laboratory Measuring Modulations laboratory guide Table of Contents 2 Measurement Tasks...3 2.1 Starting up the

More information

Revision of Previous Six Lectures

Revision of Previous Six Lectures Revision of Previous Six Lectures Previous six lectures have concentrated on Modem, under ideal AWGN or flat fading channel condition multiplexing multiple access CODEC MODEM Wireless Channel Important

More information

Performance Evaluation of Wireless Communication System Employing DWT-OFDM using Simulink Model

Performance Evaluation of Wireless Communication System Employing DWT-OFDM using Simulink Model Performance Evaluation of Wireless Communication System Employing DWT-OFDM using Simulink Model M. Prem Anand 1 Rudrashish Roy 2 1 Assistant Professor 2 M.E Student 1,2 Department of Electronics & Communication

More information

Performance Evaluation Of Digital Modulation Techniques In Awgn Communication Channel

Performance Evaluation Of Digital Modulation Techniques In Awgn Communication Channel Performance Evaluation Of Digital Modulation Techniques In Awgn Communication Channel Oyetunji S. A 1 and Akinninranye A. A 2 1 Federal University of Technology Akure, Nigeria 2 MTN Nigeria Abstract The

More information

Multiple Input Multiple Output (MIMO) Operation Principles

Multiple Input Multiple Output (MIMO) Operation Principles Afriyie Abraham Kwabena Multiple Input Multiple Output (MIMO) Operation Principles Helsinki Metropolia University of Applied Sciences Bachlor of Engineering Information Technology Thesis June 0 Abstract

More information

IEEE pc-00/11. IEEE Broadband Wireless Access Working Group <http://ieee802.org/16>

IEEE pc-00/11. IEEE Broadband Wireless Access Working Group <http://ieee802.org/16> Project Title Date Submitted IEEE 802.16 Broadband Wireless Access Working Group A Brief Examination of CQPSK for CPE PHY Modulation 2000-02-17 Source Eric Jacobsen Intel 5000 W.

More information

Communication Engineering Term Project ABSTRACT

Communication Engineering Term Project ABSTRACT Communication Engineering erm Project (Simulation of 16QAM) School of information & Communications, 20141013 Dooho Kim ABSRAC A 16-QAM model for term project of conmmunication engineering is presented.

More information

STUFF HAPPENS. A Naive/Ideal Communication System Flat Fading What if... idealized system. 9: Stuff Happens

STUFF HAPPENS. A Naive/Ideal Communication System Flat Fading What if... idealized system. 9: Stuff Happens STUFF HAPPENS A Naive/Ideal Communication System Flat Fading What if... idealized system Software Receiver Design Johnson/Sethares/Klein / 5 A Naive/Ideal Communication System With a perfect (i.e. gain

More information

Mobile Radio Systems OPAM: Understanding OFDM and Spread Spectrum

Mobile Radio Systems OPAM: Understanding OFDM and Spread Spectrum Mobile Radio Systems OPAM: Understanding OFDM and Spread Spectrum Klaus Witrisal witrisal@tugraz.at Signal Processing and Speech Communication Laboratory www.spsc.tugraz.at Graz University of Technology

More information

Adoption of this document as basis for broadband wireless access PHY

Adoption of this document as basis for broadband wireless access PHY Project Title Date Submitted IEEE 802.16 Broadband Wireless Access Working Group Proposal on modulation methods for PHY of FWA 1999-10-29 Source Jay Bao and Partha De Mitsubishi Electric ITA 571 Central

More information

Channel Estimation and Signal Detection for Multi-Carrier CDMA Systems with Pulse-Shaping Filter

Channel Estimation and Signal Detection for Multi-Carrier CDMA Systems with Pulse-Shaping Filter Channel Estimation and Signal Detection for MultiCarrier CDMA Systems with PulseShaping Filter 1 Mohammad Jaber Borran, Prabodh Varshney, Hannu Vilpponen, and Panayiotis Papadimitriou Nokia Mobile Phones,

More information

Using Raised Cosine Filter to Reduce Inter Symbol Interference in OFDM with BPSK Technique

Using Raised Cosine Filter to Reduce Inter Symbol Interference in OFDM with BPSK Technique Using Raised Cosine Filter to Reduce Inter Symbol Interference in OFDM with BPSK Technique Khalid Aslam 1,*, Bodiuzzaman Molla 2, Md. Jashim uddin 3,Prof. Wlodek Kulesza 4 1 MSc EE Manager / Kundekonsulent

More information

Correlation, Interference. Kalle Ruttik Department of Communications and Networking School of Electrical Engineering Aalto University

Correlation, Interference. Kalle Ruttik Department of Communications and Networking School of Electrical Engineering Aalto University Correlation, Interference Kalle Ruttik Department of Communications and Networking School of Electrical Engineering Aalto University Correlation Correlation Digital communication uses extensively signals

More information

3/26/18. Lecture 3 EITN STRUCTURE OF A WIRELESS COMMUNICATION LINK

3/26/18. Lecture 3 EITN STRUCTURE OF A WIRELESS COMMUNICATION LINK Lecture 3 EITN75 208 STRUCTURE OF A WIRELESS COMMUNICATION LINK 2 A simple structure Speech Data A/D Speech encoder Encrypt. Chann. encoding Modulation Key Speech D/A Speech decoder Decrypt. Chann. decoding

More information

ECE 3500: Fundamentals of Signals and Systems (Fall 2014) Lab 4: Binary Phase-Shift Keying Modulation and Demodulation

ECE 3500: Fundamentals of Signals and Systems (Fall 2014) Lab 4: Binary Phase-Shift Keying Modulation and Demodulation ECE 3500: Fundamentals of Signals and Systems (Fall 2014) Lab 4: Binary Phase-Shift Keying Modulation and Demodulation Files necessary to complete this assignment: none Deliverables Due: Before your assigned

More information

(Refer Slide Time: 01:45)

(Refer Slide Time: 01:45) Digital Communication Professor Surendra Prasad Department of Electrical Engineering Indian Institute of Technology, Delhi Module 01 Lecture 21 Passband Modulations for Bandlimited Channels In our discussion

More information

4x4 Time-Domain MIMO encoder with OFDM Scheme in WIMAX Context

4x4 Time-Domain MIMO encoder with OFDM Scheme in WIMAX Context 4x4 Time-Domain MIMO encoder with OFDM Scheme in WIMAX Context Mohamed.Messaoudi 1, Majdi.Benzarti 2, Salem.Hasnaoui 3 Al-Manar University, SYSCOM Laboratory / ENIT, Tunisia 1 messaoudi.jmohamed@gmail.com,

More information

Analysis of Interference & BER with Simulation Concept for MC-CDMA

Analysis of Interference & BER with Simulation Concept for MC-CDMA IOSR Journal of Electronics and Communication Engineering (IOSR-JECE) e-issn: 2278-2834,p- ISSN: 2278-8735.Volume 9, Issue 4, Ver. IV (Jul - Aug. 2014), PP 46-51 Analysis of Interference & BER with Simulation

More information

WIRELESS COMMUNICATION TECHNOLOGIES (16:332:546) LECTURE 5 SMALL SCALE FADING

WIRELESS COMMUNICATION TECHNOLOGIES (16:332:546) LECTURE 5 SMALL SCALE FADING WIRELESS COMMUNICATION TECHNOLOGIES (16:332:546) LECTURE 5 SMALL SCALE FADING Instructor: Dr. Narayan Mandayam Slides: SabarishVivek Sarathy A QUICK RECAP Why is there poor signal reception in urban clutters?

More information

BER Analysis for MC-CDMA

BER Analysis for MC-CDMA BER Analysis for MC-CDMA Nisha Yadav 1, Vikash Yadav 2 1,2 Institute of Technology and Sciences (Bhiwani), Haryana, India Abstract: As demand for higher data rates is continuously rising, there is always

More information

System to be Simulated

System to be Simulated System to be Simulated N(t) Sampler, rate f s b n s(t) R(t) R[n] p(t) h(t) + Π Ts (t) to DSP δ(t nt ) A Figure: Baseband Equivalent System to be Simulated. 2009, B.-P. Paris Wireless Communications 93

More information

EE303: Communication Systems

EE303: Communication Systems EE303: Communication Systems Professor A. Manikas Chair of Communications and Array Processing Imperial College London An Overview of Fundamentals: Channels, Criteria and Limits Prof. A. Manikas (Imperial

More information