7 EC333 Compressed
7 EC333 Compressed
THIRUVANANTHAPURUM
2019
DEPARTMENT OF ELECTRONICS AND COMMUNICATION ENGINEERING
THIRUVANANTHAPURAM
3 Time and Frequency Response of LTI systems (First and second order). 10
EXPERIMENT NO 01
GENERATION OF WAVEFORMS
AIM
THEORY
In signal processing experiments, we need the help of some fundamental signals such as sine
wave, square wave, ramp wave, unit step, unit impulse etc.
A digital signal can be either a deterministic signal that can be predicted with certainity, or a
random signal that is unpredictable. Due to ease in signal generation and need for predictability,
deterministic signal can be used for system simulation studies. Standard forms of some
deterministic signals that are frequently used in DSP are discussed below:
1. Impulse: The simplest signal is the unit impulse signal which is defined as,
δ (n) = 1 for n = 0
= 0 for n ≠ 0
2. Step: The general form of step function is,
u (n) = 1 for n ≥ 0
= 0 for n< 0
3. Exponential: The decaying exponential is a basic signal in DSP whose general form is,
x (n) = a n for all n.
4. Ramp: This signal is given by,
r (n) = n for n ≥ 0
= 0 for n < 0
5. Sine: A sinusoidal sequence is defined as,
x(n) = sin(n).
1
A continuous time signal is defined for all values of time t. Standard forms of some basic
continuous time signals frequently used in DSP are discussed below:
1. Impulse: An impulse signal is given by,
-∞∫∞δ (t) =1
= 0 for t ≠ 0
2. Sine: A sinusoidal sequence is defined as,
x(t) = sin(t)
3. Unit step signal: The general form of step signal is,
u (t) = A for t ≥ 0
= 0 for t< 0
Where, A is the amplitude. If A=1, then it is a unit step signal.
4. Ramp: Ramp signal is given by,
r(t) = t for t ≥ 0
= 0 for t< 0
5. Exponential : Exponential signal is given by
x(t)=eat , a>0 for growing exponential, a<0 for decaying exponential
INSTRUCTIONS
The MATLAB program to generate continuous and discrete waveforms were executed and
obtained output waveforms.
EXPERIMENT NO 02
AIM
THEORY
Sampling Theorem: A band limited signal can be reconstructed exactly if it is sampled at a rate
atleast twice the maximum frequency component in it. Figure 1 shows the spectrum of a signal
g(t) that is band limited.
The maximum frequency component of g(t) is fm. To recover the signal g(t) exactly from its
samples it has to be sampled at a rate fs=2fm. The minimum required sampling rate fs = 2fm is
called Nyquist rate.
INSTRUCTIONS
1. Make the program interactive with the user to accept signal frequency and sampling frequency
2. Plot at least one complete cycle of the signal to be sampled. Choose signal frequency as your lab
team number in Hz.
3. Choose three different sampling (undersampling and oversampling) frequencies and plot the
sampled sequence on the same time scale as the original continuous signal.
4. Choose an appropriate reconstruction filter and plot its impulse response.
5. Plot the reconstructed signal on the same time scale.
6. Parameters for simulation is selected based on the batch number (N)
The MATLAB program to verify the sampling theory was executed and output waveform for
fs>>signal frequency and fs<signal frequency is executed and the theorem is verified.
EXPERIMENT NO 03
AIM
Write a MATLAB program to obtain the time and frequency response of an LTI system.
THEORY
Linear Time Systems (LTI Systems) are a class of systems used in DSP that are both linear and
time invariant. Linear systems are systems whose output for a linear combination of inputs are
the same as a linear combination of individual responses to those inputs. The time invariant
systems are systems where the output does not depend on when an input was applied. These
properties make LTI systems easy to represent and understand graphically.
INSTRUCTIONS
1. Define a digital filter frequency response using freqz() function, given the transfer
function coefficients. eg: b = [1,-1]; a = [0.9,-2,1]; [h,w] =
freqz(a,b);
2. Plot its magnitude and phase response in dB and degrees respectively
SAMPLES OF EXPECTED OUTPUT
RESULT
The MATLAB program to obtain the time and frequency response of an LTI system is executed
and output is obtained.
EXPERIMENT NO 04
LINEAR CONVOLUTION , CIRCULAR CONVOLUTION
AIM
THEORY
Convolution is used to find the output response of a digital system. The linear convolution of two
continuous time signals x[n] and h[n] is defined by y[n] = x[n] * h[n]. The length of the output
sequence y[n]= length of x[n]+length of h[n]-1.
Circular Convolution of two sequences x[n] and y[n], each of length N is given by ,
p[n] = x[n]©y[n].
If the length of sequence is not equal, zero padding is done to get the maximum length among
the two. The resulting convolved signal would be zero outside the range n= 0,1,...,N-1.
In order to find the circular convolution of two given sequences without using inbuilt function,
we make use of the circular convolution property of DFT.
If X(k) = DFT [x(n)], Y(k) = DFT[y(n)] then convolution property states that,
1. Interactively accept two input sequences from the user and perform linear convolution by
user defined and builtin functions and verify the result
2. Interactively accept two input sequences from the user and perform circular convolution
by user defined and builtin functions and verify the result
3. Define a user defined function that perform linear convolution using circular convolution
and then verify the result.
a) Linear convolution
b) Circular convolution
RESULT
a) The MATLAB program to find the linear convolution of two input sequences is executed
and output is verified using inbuilt function.
b) The MATLAB program to find the circular convolution of two input sequences is
executed and output is verified using inbuilt function.
c) The MATLAB program to find the linear convolution using circular convolution of two
input sequences is executed and output is verified using inbuilt function.
EXPERIMENT NO 05
AIM
THEORY
Discrete Fourier Transform is the transformation used to represent the finite duration
frequencies. DFT of a discrete sequence x(n) is obtained by performing sampling operations in
both time domain and frequency domain. It is the frequency domain representation of a discrete
digital signal.
The DFT of a sequence x (n) of length N is given by the following equation,
{ }
N−1 − j2 πkn
X(k) = ∑ x ( n) e N
; 0 ≤ k ≤ N −1
n=0
IDFT performs the reverse operation of DFT, to obtain the time domain sequence x(n) from
frequency domain sequence X(k). IDFT of the sequence is given as,
1
x(n) = N
INSTRUCTIONS
N= 3
Sequence=[1 2 3]
RESULT
The MATLAB program to find DFT and IDFT of input sequence is executed and output is
obtained.
EXPERIMENT NO 06
LINEAR CONVOLUTION USING DFT (OVERLAP-ADD & OVERLAP-
SAVE METHODS)
AIM
To simulate linear convolution of two signals using overlap add and overlap save methods.
THEORY
Generally in discrete-time processing we talk about linearly convolving a sequence with a FIR
filter. In contrast, the FFT performs circular convolution with a filter of equal or lesser length. In
computing the DFT or FFT we often have to make linear convolution behave like circular
convolution or vice versa. Two methods that make linear convolution look like circular
convolution are overlap-add and overlap-save.
i. Overlap-Add Method
This procedure cuts the signal up into equal length segments with no overlap. Then it zero-pads
the segments and takes the DFT of the segments. Part of the convolution result corresponds to
the circular convolution. The tails that do not correspond to the circular convolution are added to
the adjoining tail of the previous and subsequent sequence. This addition results in the aliasing
that occurs in circular convolution.
This procedure cuts the signal up into equal length segments with some overlap. Then it takes the
DFT of the segments and saves the parts of the convolution that correspond to the circular
convolution. Because there are overlapping sections, it is like the input is copied therefore there
is not lost information in throwing away parts of the linear convolution.
INSTRUCTIONS
1. Interactively accept input sequence and impulse sequence from the user. Also accept the
block length of processing
2. Perform zero padding followed by linear convolution using inbuilt functions fft() and
ifft() for overlap add method
3. Repeat the same using overlap save algorithms
4. Plot the sequences in each case.
Overlap-Save
The linear convolution of two signals performed using overlap add and overlap save methods.
EXPERIMENT NO 07
AIM
Write a MATLAB program to find the DCT and IDCT for the given input.
THEORY
A Discrete Cosine Transform (DCT) expresses a finite sequence of data points in terms of a
sum of cosine functions oscillating at different frequencies. The use of cosine rather than sine
functions is critical for compression, since it turns out that fewer cosine functions are needed to
approximate a typical signal, whereas for differential equations the cosines express a particular
choice of boundary conditions. In particular, a DCT is a Fourier-related transform similar to
the discrete Fourier transform (DFT), but using only real numbers.
The IDCT function is the inverse of the DCT function — The IDCT reconstructs a sequence
from its discrete cosine transform (DCT) coefficients.
N −1
x(n) = ∑
k =0
( c [ k2] ) X [ k ]
c cos((2n+1))πk/N)
where, n = 0, 1, 2, …, N-1
Xc
is the DCT result
=2 for k=1,2,3,……,N-1
INSTRUCTIONS
1. Accept a sequence form the user.
2. Without using inbuilt functions, write a program to find the DCT of the input sequence
3. Using the DCT output, perform IDCT without using built in functions
4. Plot all input and output sequences
RESULT
The MATLAB program to find the DCT and IDCT for the given input was executed and output
obtained correctly.
EXPERIMENT NO 08
AIM
Write a MATLAB program to find the FFT and IFFT of the given input.
THEORY
The most common tools used to perform Fourier analysis and synthesis are called the fast
Fourier transform (FFT) and the inverse fast Fourier transform (IFFT). The FFT and IFFT are
optimized (very fast) computer-based algorithms that perform a generalized mathematical
process called the discrete Fourier transform (DFT). The DFT is the actual mathematical
transformation that the data go through when converted from one domain to another (time to
frequency). Basically, the DFT is just a slow version of the FFT.
INSTRUCTIONS
RESULT
The MATLAB program to find the FFT and IFFT of the given input sequence
EXPERIMENT NO 09
AIM
THEORY
The Filter Design and Analysis Tool (FDATool) is a powerful user interface for designing and
analyzing filters quickly. FDATool enables you to design digital FIR or IIR filters by setting filter
specifications, by importing filters from your MATLAB workspace, or by adding, moving or
deleting poles and zeros. FDATool also provides tools for analyzing filters, such as magnitude
and phase response and pole-zero plots. FDATool seamlessly integrates additional functionality
from other MathWorks products.
Use FDATOOL in matlab.
If you type
>>fdatool
in command window, FDAtool will be opened. There you can select FIR or IIR filter, order of
filter and cutoff frequency of a filter (either HPF, LPF or BPF). That code will automatically
generate .m file for you.
GETTING STARTED:
>> fdatool
A Tip of the Day dialog displays with suggestions for using FDATool. Then, the GUI diplays
with a default filter.
The GUI has three main regions:
1.The Current Filter Information region
2.The Filter Display region and
3.The Design panel
The upper half of the GUI displays information on filter specifications and responses for the
current filter. The Current Filter Information region, in the upper left, displays filter properties,
namely the filter structure, order, number of sections used and whether the filter is stable or not.
It also provides access to the Filter manager for working with multiple filters.
The Filter Display region, in the upper right, displays various filter responses, such as, magnitude
response, group delay and filter coefficients.The lower half of the GUI is the interactive portion
of FDATool. The Design Panel, in the lower half is where you define your filter specifications. It
controls what is displayed in the other two upper regions. Other panels can be displayed in the
lower half by using the sidebar buttons.
DESIGNING FILTER:
IIR FILTER
We will design a butterworth low pass filter with following specifications:
Pass band frequency: 4000
Stop band frequency: 8000
Pass band ripple: .5
Stop band ripple: 40
Sampling Frequency: 80000
1. Select Lowpassfrom the dropdown menu under Response Type and BUTTERWORTH
under IIR Design Method. In general, when you change the Response Type or Design Method,
the filter parameters and Filter Display region update automatically.
2. Select Minimum order in the Filter Order.
3. Select Hz in the Units pull down menu in the Frequency Specifications area. Then input
sampling frequency,Pass band frequency and stop band frequency.
4. Select Dbin the units pull down menu in the Magnitude Specifications area.Enter0.5 for A
passand 40 for Astopin the Magnitude Specifications area.
5. After setting the design specifications, click the Design Filter button at the bottom of the GUI
to design the filter.
The magnitude response of the filter is displayed in the Filter Analysis area after the coefficients
are computed.
Viewing other Analyses:
Once you have designed the filter, you can view the following filter analyses in the display
window by clicking any of the buttons on the toolbar:
FIR FILTER
We will design a FIR low pass filter using hanning window with following specifications:
Sampling Frequency: 80000
Cut-off Frequency : 4000
To implement this design, we will use the following specifications:
1. Select Low pass from the dropdown menu under Response Type and Window under FIR
Design Method. In general, when you change the Response Type or Design Method, the filter
parameters and Filter Display region update automatically.
2. Enter 10 in Specify order under the Filter Order.
3. Select Hann in Window.
4. Select Hz in the Units pull down menu in the Frequency Specifications area. Then input
sampling frequency and cut-off frequency.
5. After setting the design specifications, click the Design Filter button at the bottom of the GUI
to design the filter.
The magnitude response of the filter is displayed in the Filter Analysis area after the coefficients
are computed.
RESULT:
Designed FIR and IIR filter Using Filter Design Tool.
EXPERIMENT NO 10
AIM
To design and implement a finite impulse response filter of linear phase characteristics by
window method.
THEORY
N−1 N−1
ω R ( n )=1 for − ≤ n≤ 0 otherwise
2 2
In the design of FIR filters using any window technique, the order can be calculated using the
formula given by
−20 log ( √ δ p δ s )
N= −13
( f s − f p)
14.6
Fs
δp fp
Where is the pass band ripple, is the stop band ripple, is the pass band frequency,
fs Fs
is the stop band frequency and is the sampling frequency.
0.46 cos 2 π n N −1 N −1
ω H ( n )=0.54 + for − ≤n≤ 0, otherwise
N −1 2 2
The hanning window sequence can be obtained by substituting α=0.5 in the raised cosine
window function. The sequence is obtained as
INSTRUCTIONS
1. Interactively accept the filter type and window type from th user. Use questdlg()
and switch..case() functions
2. Interactively accept the order, cutoff frequency and sampling frequency from the user
Designed and implemented a finite impulse response filter of linear phase characteristics by
window method.
EXPERIMENT NO: 11
AIM
Write a MATLAB program to design an IIR Filter(Butterworth and Chebychev).
THEORY
The Butterworth filter is a type of signal processing filter designed to have as
flat a frequency response as possible in the pass band so that it is also
termed a maximally flat magnitude filter. The frequency response of the
Butterworth filter is maximally flat (has no ripples) in the passband and rolls
off towards zero in the stopband. When viewed on a logarithmic Bode plot
the response slopes off linearly towards negative infinity. A first-order filter's
response rolls off at −6 dB per octave (−20 dB per decade) (all first-order
lowpass filters have the same normalized frequency response). A second-
order filter decreases at −12 dB per octave, a third-order at −18 dB and so
on. Butterworth filters have a monotonically changing magnitude function
with ω, unlike other filter types that have non-monotonic ripple in the
passband and/or the stopband.
Chebyshevfilters are analog or digital filters having a steeper roll-off and more pass band ripple
(type I) or stop band ripple (type II) than Butterworth filters. Chebyshev filters have the property
that they minimize the error between the idealized and the actual filter characteristic over the
range of the filter, but with ripples in the passband.Because of the passband ripple inherent in
Chebyshev filters, filters which have a smoother response in the passband but a more irregular
response in the stopband are preferred for some applications.
These are the most common Chebyshev filters. The gain (or amplitude) response as a function of
Whereε is the ripple factor, ω0 is the cutoff frequency and Tn() is a Chebyshev polynomial of the
nth order.
INSTRUCTIONS
1. Accept the butterworth filter design parameters for the user (Pass band and stop
band cut-off frequencies, and attenuations)
2. For each type of lowpass, bandpass, high pass filter, find the filter order and
implement the filter design using inbuilt functions
3. Repeat the same for Chebyshev filter design
4. Plot filter magnitude and phase response
BUTTERWORTH
a) Low pass
n =8
wn = 0.1151
n2 = 5
wn2 = 0.1000
N = 512
b)High pass
The pass band frequency wp =2000
The stop band frequency ws = 3500
The pass band attenuation rp = 0.2
The stop band attenuation rs = 40
The sampling frequency fs = 80000
n =8
wn = 0.1151
n2 = 5
wn2 = 0.1000
N = 512
c) Bandpass
CHEBYSHEV
a)Lowpass
The passband attenuation=2
AIM
a) To generate amplitude modulated wave with and without using standard Matlab functions
and demodulate the AM wave obtained..
b) To generate frequency modulated wave with and without using standard Matlab
functions. Also demodulate the frequency modulated wave.
c) To generate PWM modulated wave .
THEORY
a) Amplitude Modulation
The process by which the amplitude of a relatively high frequency wave called the carrier wave
is changed in accordance with the instantaneous value of amplitude of a low frequency
electromagnetic wave called the modulating wave is known as amplitude modulation. If E c cos
wc Em wm
t denotes the carrier signal and em(t)= cos t denotes the message signal, then
wc
AM=Ec[1 + Ka*em(t)] cos t
Ec
Where,m is the modulation index; is the maximum amplitude of the carrier; c and m are the
b) Frequency Modulation
The process by which the frequency of the carrier wave is changed in accordance with the
instantaneous value of the modulating wave is known as frequency modulation.Frequency
modulated wave can be expressed as
k f ∗ Em
FM=
Ec
sin[ w c t+ ( wm ) ∗ sin wm t )]
Ec kf wc , wm
Where is the carrier amplitude; is the frequency conversion factor. are the
INSTRUCTIONS
1. Interactively accept amplitude and frequencies of the message and carrier signal along
with the modulation index. (Sinusoidal)
2. Implement amplitude modulation, Frequency modulation and PWM.
3. Plot all the input and output sequences on same time scale for each type of modulation.
Make sure to plot 2 cycles of message signal.
SAMPLES OF EXPECTED OUTPUT
a) Amplitude modulation
b) Frequency Modulation
c) PWM
RESULT
a) The amplitude modulated wave was created with and without using Matlab functions and
was demodulated.
b) The frequency modulated wave was created with and without using Matlab functions and
was demodulated.
c) The PWM wave was created.
EXPERIMENT NO 13
AIM
To generate a DTMF signal using matlab code.
THEORY
The DTMF telephone keypad is laid out as a matrix of push buttons in which each row
represents the low frequency component and each column represents the high frequency
component of the DTMF signal. The commonly used keypad has four rows and three columns,
but a fourth column is present for some applications. Pressing a key sends a combination of the
row and column frequencies. For example, the 1 key produces a superimposition of a 697 Hz low
tone and a 1209 Hz high tone. The tones are decoded by the switching center to determine the
keys pressed by the user.
DTMF was originally decoded by tuned filter banks. Now,digital signal processing became the
predominant technology for decoding. DTMF decoding algorithms typically use the Goertzel
algorithm.
INSTRUCTIONS
RESULT
EXPERIMENT NO 14
To study and simulate sampling rate conversion using matlab (decimation, interpolation &
rational factor).
THEORY
The process of converting the sampling rate of a signal from one rate to another is called
sampling rate conversion (SRC). This technique is encountered in many application areas such
as:
Digital audio
Communication systems
Speech processing
Antenna systems
Radar systems
Sampling rate may be changed upward or downward. Increasing the sampling rate is called
interpolation and decreasing the sampling rate is called decimation. Reducing the sampling rate
by a factor of M is achieved by discarding every M-1 samples or equivalently keeping every M th
sample.
Increasing the sampling rate by a factor of L(Interpolation by factor L ) is achieved by inserting
L-1 zeros into the output stream after every sample from the input stream of samples.
INSTRUCTIONS
1. Based on the frequency and amplitude choice of user, generate a discrete sinusoid and
display at least 3 cycles
2. Accept upsampling and downsampling rate from user.
3. Apply these functions and display the effects of sampling rate conversion
RESULT
Studied sampling rate conversion using matlab (decimation, interpolation & rational factor).
EXPERIMENT NO 15
AIM
THEORY
Filtering is a class of signal processing, the defining feature of filters being the complete or
partial suppression of some aspect of the signal. Most often, this means removing
some frequencies or frequency bands. However, filters do not exclusively act in the frequency
domain; especially in the field of image processing many other targets for filtering exist.
Correlations can be removed for certain frequency components and not for others without having
to act in the frequency domain.
INSTRUCTIONS
3. Using a filter eg: hpfilter(), remove the noise and display the output
OUTPUT
Enter frequency : 10
Enter SNR : 0.1
RESULT
Filtered noisy signal using matlab.
EXPERIMENT NO 16
AIM
To implement the algorithms in audio signal processing for delay,reverb and flange.
THEORY
• Sounds reflected of walls – In a cave or large room we here an echo and also reverberation
takes place – this is a different effect
If walls are closer together repeated reflections can appear as parallel boundaries and we hear a
modification of sound colour instead.
We build basic delay structures out of some very basic FIR and IIR filters
• The delayed (processed) signal is added to the input signal some amplitude gain, g
H(z)=1+gz-M
• The input signal circulates in delay line (delay time τ ) that is fed back to the input.
H(z)=c/(1-gz-M)
FLANGE
Reverb/Spatial Effects
The final set of effects we look at are effects that change to spatial localization of sound.
Reverberation (reverb for short) is probably one of the most heavily used effects in music.
Reverberation is the result of the many reflections of a sound that occur in a room.
• From any sound source, say a speaker of your stereo, there is a direct path that the sounds
covers to reach our ears.
• Sound waves can also take a slightly longer path by reflecting off a wall or the ceiling, before
arriving at your ears.
Reverberation
RESULT
Implemented the algorithms in audio signal processing for delay, reverb and flange.
EXPERIMENT NO 17
IMPLEMENTATION OF SIMPLE ALGORITHMS IN IMAGE
PROCESSING
AIM
To implement simple algorithms in image processing ie, filtering, denoising, detection.
THEORY
FILTERING:
The Canny edge detector is an edge detection operator that uses a multi- stage algorithm to detect
a wide range of edges in images. It was developed by John F.
Canny in 1986. Canny also produced a computational theory of edge detection explaining
why the technique works.
The Process of Canny edge detection algorithm can be broken down to 5 different steps:
a. Apply Gaussian filter to smooth the image in order to remove the noise
b. Find the intensity gradients of the image
c. Apply non-maximum suppression to get rid of spurious response to edge
detection
d. Apply double threshold to determine potential edges
e. Track edges by hypothesis: Finalize the detection of edges by suppressing
all the other edges that are weak and not connected to strong edges.
DENOISING:
Digital images are prone to various types of noise. Noise is the result of errors in the image
acquisition process that result in pixel values that do not reflect the true intensities of the real
scene. There are several ways that noise can be introduced into an image, depending on how the
image is created. For example:
1. If the image is scanned from a photograph made on film, the film grain is a source
of noise. Noise can also be the result of damage to the film, or be introduced by
the scanner itself.
2. If the image is acquired directly in a digital format, the mechanism for gathering
the data (such as a CCD detector) can introduce noise.
3. Electronic transmission of image data can introduce noise.
We can remove noise using various filtering techniques, for example, linear filtering, average
filtering,median filtering.
DETECTION:
Filtering is a technique for modifying or enhancing an image. Mask or filters will be defined.
The general process of convolution and correlation will be introduced via an example. Also
smoothing linear filters such as box and weighted average filters will be introduced. In statistic
and image processing, to smooth a data set is to create an approximating function that attempts to
capture important patterns in the data, while leaving out noise or other fine-scale structures/rapid
phenomena. In smoothing, the data points of a signal are modified so individual points
(presumably because of noise) are reduced, and points that are lower than the adjacent points are
increased leading to a smoother signal. Smoothing may be used in two important ways that can
aid in data analysis by being able to extract more information from the data as long as the
assumption of smoothing is reasonable by being able to provide analyses that are both flexible
and robust. Different algorithms are used in smoothing.
INSTRUCTIONS
1. Using inbuilt image processing functions perform denoising, edge detection and filtering
on Images
SAMPLES OF EXPECTED OUTPUT
DENOISING
FILTERING
DETECTION
RESULT
Implemented simple algorithms in image signal processing ie., denoising, filtering and
averaging.
Part B
EXPERIMENT NO 01
AIM
THEORY
DSK 6713 is a DSP starter kit based on TMS320C6713 DSP processor. It has 32 bit stereo code
TLV 320AIC23 supporting built in A/D and D/A conversion. It has 16 MB external SD RAM. It
has a JTAG interface for host computer interface.
FEATURES
Voltage Regulator
PROCEDURE
Turn ON power
Setup Code composer Studio 3.1->Select C6713 DSK -> save and quit
2)To Create a new project
Location c:\mydsp
Target – TMS320C67xx
Click Finish
File->New->source file
1) c6713dskinit.c
2) Vectors_intr.asm
3) c6713dsk.cmd
Project->BuildOptions->Compiler
Click OK
Project->BuildOptions->linker
(Install_dir)\c6000\dsk6713\lib"
Click Ok
Debug-> Connect
File->Load Program
Debug->Run->Free
16) To stop
Debug ->Stop
RESULT
AIM
PROCEDURE
The procedure is same for all the experiments, only the source code changes for the wave
generation.
Turn ON power
Setup Code composer Studio 3.1->Select C6713 DSK -> save and quit
Location c:\mydsp
Click Finish
File->New->source file
1) c6713dskinit.c
2) Vectors_intr.asm
3) c6713dsk.cmd
Project->BuildOptions->Compiler
Click OK
Project->BuildOptions->linker
(Install_dir)\c6000\dsk6713\lib"
Note: In above configuration change myprog1.map by your projectname.map
Click Ok
Debug-> Connect
File->Load Program
Debug->Run->Free
16) To stop
Debug ->Stop
RESULT
AIM
PROCEDURE
The procedure is same as given in the experiment no.01. Write C language code for linear and
circular convolution and load it to the kit as explained in the procedure..
RESULT
97
EXPERIMENT NO 04
AIM
To implement a Real Time FIR Filterby inputting a signal from the signal generator.
PROCEDURE
Start Matlab and on command prompt type fdatool (filter design and analysis tool)
fdatool
Numerator H
Numerator Length N
Quit Matlab
4) Edit lpcof.h
101
Remove #include “tmtypes.h”
#define N 5
RESULT
102
EXPERIMENT NO 05
AIM
To implement a Real Time IIR Filterby inputting a signal from the signal generator.
PROCEDURE
Edit cof.h as
103
{-3196, 13135}, //b11,b12 for 1st stage
{16350, 31943},
{600,500}, {600,400}
RESULT
104
EXPERIMENT NO 06
AIM
PROCEDURE
Turn ON power
Setup Code composer Studio 3.1->Select C6713 DSK -> save and quit
Location c:\mydsp
Target – TMS320C67xx
105
Click Finish
File->New->source file
(To observe the effect of aliasing introduced due to choice of incorrect sampling
frequency may be demonstrated using a lower value of the same).
106
Go to C:\CCStudio_v3.1\C6000\cgtools\lib\ and select rts6700.lib
1) c6713dskinit.c
2) Vectors_intr.asm
3) c6713dsk.cmd
Project->BuildOptions->Compiler
Click OK
Project->BuildOptions->linker
107
(Install_dir)\c6000\dsk6713\lib"
Click Ok
Debug-> Connect
File->Load Program
Debug->Run->Free
16) To stop
Debug ->Stop
RESULT
Analog signal sampling is done and studied aliasing using DSP kit.
108
109