SlideShare ist ein Scribd-Unternehmen logo
1 von 9
Downloaden Sie, um offline zu lesen
FPGA DESIGN USING MATLAB
Our online Tutors are available 24*7 to provide Help with FPGA Design Homework/Assignment
or a long term Graduate/Undergraduate FPGA Design Project. Our Tutors being experienced
and proficient in FPGA Design ensure to provide high quality FPGA Design Homework Help.
Upload your FPGA Design Assignment at ‘Submit Your Assignment’ button or email it
to info@assignmentpedia.com. You can use our ‘Live Chat’ option to schedule an Online
Tutoring session with our FPGA Design Tutors.
SCAN RADAR USING A UNIFORM RECTANGULAR ARRAY
This example simulates a phased array radar that periodically scans a predefined surveillance
region. A 900-element rectangular array is used in this monostatic radar. Steps are introduced
to derive the radar parameters according to specifications. After synthesizing the received
pulses, detection and range estimation are performed. Finally, Doppler estimation is used to
obtain the speed of each target.
pd = 0.9; % Probability of detection
pfa = 1e-6; % Probability of false alarm
max_range = 5000; % Maximum unambiguous range
tgt_rcs = 1; % Required target radar cross section
int_pulsenum = 10; % Number of pulses to integrate
Load the radar system and retrieve system parameters.
load basicmonostaticradardemodata;
fc = hradiator.OperatingFrequency; % Operating frequency (Hz)
v = hradiator.PropagationSpeed; % Wave propagation speed (m/s)
lambda = v/fc; % Wavelength (m)
fs = hwav.SampleRate; % Sampling frequency (Hz)
prf = hwav.PRF; % Pulse repetition frequency (Hz)
Next, we define a 30-by-30 uniform rectangular array.
wsURA = warning('off', 'phased:system:array:SizeConventionWarning');
harray = phased.URA('Element',hant,...
'Size',[30 30],'ElementSpacing',[lambda/2, lambda/2]);
% Configure the antenna elements such that they only transmit forward
harray.Element.BackBaffled = true;
% Visualize the response pattern.
plotResponse(harray,fc,physconst('LightSpeed'),...
'RespCut','3D','Format','Polar');
Associate the array with the radiator and collector.
hradiator.Sensor = harray;
hcollector.Sensor = harray;
% We need to set the WeightsInputPort property to true to enable it to
% accept transmit beamforming weights
hradiator.WeightsInputPort = true;
Now we need to recalculate the transmit power. The original transmit power was calculated
based on a single antenna. For a 900-element array, the power required for each element is
much less.
% Calculate the array gain
hag = phased.ArrayGain('SensorArray',harray,'PropagationSpeed',v);
ag = step(hag,fc,[0;0]);
% Use the radar equation to calculate the peak power
snr_min = albersheim(pd, pfa, int_pulsenum);
peak_power = radareqpow(lambda,max_range,snr_min,hwav.PulseWidth,...
'RCS',tgt_rcs,'Gain',htx.Gain + ag)
peak_power =
0.0065
The new peak power is 0.0065 Watts.
% Set the peak power of the transmitter
htx.PeakPower = peak_power;
We also need to design the scanning schedule of the phased array. To simplify the example, we
only search in the azimuth dimension. We require the radar to search from 45 degrees to -45
degrees in azimuth. The revisit time should be less than 1 second, meaning that the radar
should revisit the same azimuth angle within 1 second.
initialAz = 45; endAz = -45;
volumnAz = initialAz - endAz;
To determine the required number of scans, we need to know the beamwidth of the array
response. We use an empirical formula to estimate the 3-dB beamwidth.
where is the array gain and is the 3-dB beamwidth.
% Calculate 3-dB beamwidth
theta = radtodeg(sqrt(4*pi/db2pow(ag)))
theta =
6.7703
The 3-dB beamwidth is 6.77 degrees. To allow for some beam overlap in space, we choose the
scan step to be 6 degrees.
scanstep = -6;
scangrid = initialAz+scanstep/2:scanstep:endAz;
numscans = length(scangrid);
pulsenum = int_pulsenum*numscans;
% Calculate revisit time
revisitTime = pulsenum/prf
revisitTime =
0.0050
The resulting revisit time is 0.005 second, well below the prescribed upper limit of 1 second.
Target Definition
We want to simulate the pulse returns from two non-fluctuating targets, both at 0 degrees
elevation. The first target is approaching to the radar, while the second target is moving away
from the radar.
htarget{1} = phased.RadarTarget(...
'MeanRCS',1.6,...
'OperatingFrequency',fc);
htargetplatform{1} = phased.Platform(...
'InitialPosition',[3532.63; 800; 0],...
'Velocity',[-100; 50; 0]);
% Calculate the range, angle, and speed of the first target
[tgt1_rng,tgt1_ang] = rangeangle(htargetplatform{1}.InitialPosition,...
hantplatform.InitialPosition);
tgt1_speed = radialspeed(htargetplatform{1}.InitialPosition,...
htargetplatform{1}.Velocity,hantplatform.InitialPosition);
htarget{2} = phased.RadarTarget(...
'MeanRCS',1.2,...
'OperatingFrequency',fc);
htargetplatform{2} = phased.Platform(...
'InitialPosition',[2000.66; 0; 0],...
'Velocity',[60; 80; 0]);
% Calculate the range, angle, and speed of the second target
[tgt2_rng,tgt2_ang] = rangeangle(htargetplatform{2}.InitialPosition,...
hantplatform.InitialPosition);
tgt2_speed = radialspeed(htargetplatform{2}.InitialPosition,...
htargetplatform{2}.Velocity,hantplatform.InitialPosition);
numtargets = length(htarget);
Pulse Synthesis
Now that all subsystems are defined, we can proceed to simulate the received signals. The total
simulation time corresponds to one pass through the surveillance region. Because the reflected
signals are received by an array, we use a beamformer pointing to the steering direction to
obtain the combined signal.
% Create the steering vector for transmit beamforming
hsv = phased.SteeringVector('SensorArray',harray,'PropagationSpeed',v);
% Create the receiving beamformer
hbf = phased.PhaseShiftBeamformer('SensorArray',harray,...
'OperatingFrequency',fc,'PropagationSpeed',v,...
'DirectionSource','Input port');
% Define propagation channel for each target
for n = numtargets:-1:1
htargetchannel{n} = phased.FreeSpace(...
'SampleRate',fs,...
'TwoWayPropagation',true,...
'OperatingFrequency',fc);
end
fast_time_grid = unigrid(0, 1/fs, 1/prf, '[)');
rx_pulses = zeros(numel(fast_time_grid),pulsenum); % Pre-allocate
tgt_ang = zeros(2,numtargets); % Target angle
for m = 1:pulsenum
x = step(hwav); % Generate pulse
[s, tx_status] = step(htx,x); % Transmit pulse
[ant_pos,ant_vel] = step(hantplatform,1/prf);% Update antenna position
% Calculate the steering vector
scanid = floor((m-1)/int_pulsenum) + 1;
sv = step(hsv,fc,scangrid(scanid));
w = conj(sv);
rsig = zeros(length(s),numtargets);
for n = numtargets:-1:1 % For each target
[tgt_pos,tgt_vel] = step(...
htargetplatform{n},1/prf); % Update target position
[~,tgt_ang(:,n)] = rangeangle(tgt_pos,...% Calculate range/angle
ant_pos);
tsig = step(hradiator,s,tgt_ang(:,n),w); % Radiate toward target
tsig = step(htargetchannel{n},... % Propagate pulse
tsig,ant_pos,tgt_pos,ant_vel,tgt_vel);
rsig(:,n) = step(htarget{n},tsig); % Reflect off target
end
rsig = step(hcollector,rsig,tgt_ang); % Collect all echoes
rsig = step(hrx,rsig,~(tx_status>0)); % Receive signal
rsig = step(hbf,rsig,[scangrid(scanid);0]); % Beamforming
rx_pulses(:,m) = rsig; % Form data matrix
end
Matched Filter
To process the received signal, we first pass it through a matched filter, then integrate all pulses
for each scan angle.
% Matched filtering
matchingcoeff = getMatchedFilter(hwav);
hmf = phased.MatchedFilter(...
'Coefficients',matchingcoeff,...
'GainOutputPort',true);
[mf_pulses, mfgain] = step(hmf,rx_pulses);
mf_pulses = reshape(mf_pulses,[],int_pulsenum,numscans);
matchingdelay = size(matchingcoeff,1)-1;
sz_mfpulses = size(mf_pulses);
mf_pulses = [mf_pulses(matchingdelay+1:end) zeros(1,matchingdelay)];
mf_pulses = reshape(mf_pulses,sz_mfpulses);
% Pulse integration
int_pulses = pulsint(mf_pulses,'noncoherent');
int_pulses = squeeze(int_pulses);
% Visualize
r = v*fast_time_grid/2;
X = r'*cosd(scangrid); Y = r'*sind(scangrid);
clf;
pcolor(X,Y,pow2db(abs(int_pulses).^2));
axis equal tight
shading interp
set(gca,'Visible','off');
text(-800,0,'Array');
text((max(r)+10)*cosd(initialAz),(max(r)+10)*sind(initialAz),...
[num2str(initialAz) '^o']);
text((max(r)+10)*cosd(endAz),(max(r)+10)*sind(endAz),...
[num2str(endAz) '^o']);
text((max(r)+10)*cosd(0),(max(r)+10)*sind(0),[num2str(0) '^o']);
colorbar;
From the scan map, we can clearly see two peaks. The close one is at around 0 degrees
azimuth, the remote one at around 10 degrees in azimuth.
Detection and Range Estimation
To obtain an accurate estimation of the target parameters, we apply threshold detection on the
scan map. First we need to compensate for signal power loss due to range by applying time
varying gains to the received signal.
range_gates = v*fast_time_grid/2;
htvg = phased.TimeVaryingGain(...
'RangeLoss',2*fspl(range_gates,lambda),...
'ReferenceLoss',2*fspl(max(range_gates),lambda));
tvg_pulses = step(htvg,mf_pulses);
% Pulse integration
int_pulses = pulsint(tvg_pulses,'noncoherent');
int_pulses = squeeze(int_pulses);
% Calculate the detection threshold
npower = noisepow(hrx.NoiseBandwidth,...
hrx.NoiseFigure,hrx.ReferenceTemperature);
threshold = npower * db2pow(npwgnthresh(pfa,int_pulsenum,'noncoherent'));
% Increase the threshold by the matched filter processing gain
threshold = threshold * db2pow(mfgain);
We now visualize the detection process. To better represent the data, we only plot range
samples beyond 50.
N = 51;
clf;
surf(X(N:end,:),Y(N:end,:),...
pow2db(abs(int_pulses(N:end,:)).^2));
hold on;
mesh(X(N:end,:),Y(N:end,:),...
pow2db(threshold*ones(size(X(N:end,:)))),'FaceAlpha',0.8);
view(0,56);
set(gca,'Visible','Off');
There are two peaks visible above the detection threshold, corresponding to the two targets we
defined earlier. We can find the locations of these peaks and estimate the range and angle of
each target.
[I,J] = find(abs(int_pulses).^2 > threshold);
est_range = range_gates(I); % Estimated range
est_angle = scangrid(J); % Estimated direction
Doppler Estimation
Next, we want to estimate the Doppler speed of each target. For details on Doppler estimation,
refer to the example Doppler Estimation.
for m = 2:-1:1
[p, f] = periodogram(mf_pulses(I(m),:,J(m)),[],256,prf, ...
'power','centered');
speed_vec = dop2speed(f,lambda)/2;
spectrum_data = p/max(p);
[~,dop_detect1] = findpeaks(pow2db(spectrum_data),'MinPeakHeight',-5);
sp(m) = speed_vec(dop_detect1);
end
warning(wsURA);
Finally, we have estimated all the parameters of both detected targets. Below is a comparison of
the estimated and true parameter values.
------------------------------------------------------------------------
Estimated (true) target parameters
------------------------------------------------------------------------
Range (m) Azimuth (deg) Speed (m/s)
Target 1: 3625.00 (3622.08) 12.00 (12.76) 86.01 (86.49)
Target 2: 2025.00 (2000.66) 0.00 (0.00) -59.68 (-60.00)
Summary
In this example, we showed how to simulate a phased array radar to scan a predefined
surveillance region. We illustrated how to design the scanning schedule. A conventional
beamformer was used to process the received multi-channel signal. The range, angle, and
Doppler information of each target are extracted from the reflected pulses. This information can
be used in further tasks such as high resolution direction-of-arrival estimation, or target tracking.
visit us at www.assignmentpedia.com or email us at info@assignmentpedia.com or call us at +1 520 8371215

Weitere ähnliche Inhalte

Ähnlich wie Fpga Design Project

Fast Fourier Transform (FFT) of Time Series in Kafka Streams
Fast Fourier Transform (FFT) of Time Series in Kafka StreamsFast Fourier Transform (FFT) of Time Series in Kafka Streams
Fast Fourier Transform (FFT) of Time Series in Kafka StreamsHostedbyConfluent
 
Sequential radar tracking
Sequential radar trackingSequential radar tracking
Sequential radar trackingAssignmentpedia
 
A Robust UART Architecture Based on Recursive Running Sum Filter for Better N...
A Robust UART Architecture Based on Recursive Running Sum Filter for Better N...A Robust UART Architecture Based on Recursive Running Sum Filter for Better N...
A Robust UART Architecture Based on Recursive Running Sum Filter for Better N...Kevin Mathew
 
Locks? We Don't Need No Stinkin' Locks - Michael Barker
Locks? We Don't Need No Stinkin' Locks - Michael BarkerLocks? We Don't Need No Stinkin' Locks - Michael Barker
Locks? We Don't Need No Stinkin' Locks - Michael BarkerJAX London
 
Lock? We don't need no stinkin' locks!
Lock? We don't need no stinkin' locks!Lock? We don't need no stinkin' locks!
Lock? We don't need no stinkin' locks!Michael Barker
 
Router Queue Simulation in C++ in MMNN and MM1 conditions
Router Queue Simulation in C++ in MMNN and MM1 conditionsRouter Queue Simulation in C++ in MMNN and MM1 conditions
Router Queue Simulation in C++ in MMNN and MM1 conditionsMorteza Mahdilar
 
CODING IN ARDUINO
CODING IN ARDUINOCODING IN ARDUINO
CODING IN ARDUINOS Ayub
 
Arduino Lecture 3 - Interactive Media CS4062 Semester 2 2009
Arduino Lecture 3 - Interactive Media CS4062 Semester 2 2009Arduino Lecture 3 - Interactive Media CS4062 Semester 2 2009
Arduino Lecture 3 - Interactive Media CS4062 Semester 2 2009Eoin Brazil
 
Arduino Lecture 3 - Interactive Media CS4062 Semester 2 2009
Arduino Lecture 3 - Interactive Media CS4062 Semester 2 2009Arduino Lecture 3 - Interactive Media CS4062 Semester 2 2009
Arduino Lecture 3 - Interactive Media CS4062 Semester 2 2009Eoin Brazil
 
I need help understanding the Pan Tompkins algorythm, and Id also .pdf
I need help understanding the Pan Tompkins algorythm, and Id also .pdfI need help understanding the Pan Tompkins algorythm, and Id also .pdf
I need help understanding the Pan Tompkins algorythm, and Id also .pdfeyewatchsystems
 
Temperature Sensor with LED matrix Display BY ►iRFAN QADOOS◄ 9
Temperature Sensor with LED matrix Display BY ►iRFAN QADOOS◄ 9Temperature Sensor with LED matrix Display BY ►iRFAN QADOOS◄ 9
Temperature Sensor with LED matrix Display BY ►iRFAN QADOOS◄ 9Irfan Qadoos
 
Mat lab for bplc
Mat lab for bplcMat lab for bplc
Mat lab for bplcwendye13
 
Write a Matlab code (a computerized program) for calculating plane st.docx
 Write a Matlab code (a computerized program) for calculating plane st.docx Write a Matlab code (a computerized program) for calculating plane st.docx
Write a Matlab code (a computerized program) for calculating plane st.docxajoy21
 
Minimizing Hidden Node Problem in Vehicular Ad-hoc Network (VANET)
Minimizing Hidden Node Problem in Vehicular Ad-hoc Network (VANET)Minimizing Hidden Node Problem in Vehicular Ad-hoc Network (VANET)
Minimizing Hidden Node Problem in Vehicular Ad-hoc Network (VANET)Sanjiv Pradhan
 

Ähnlich wie Fpga Design Project (20)

Design Of 10 gbps
Design Of 10 gbpsDesign Of 10 gbps
Design Of 10 gbps
 
Fast Fourier Transform (FFT) of Time Series in Kafka Streams
Fast Fourier Transform (FFT) of Time Series in Kafka StreamsFast Fourier Transform (FFT) of Time Series in Kafka Streams
Fast Fourier Transform (FFT) of Time Series in Kafka Streams
 
Sequential radar tracking
Sequential radar trackingSequential radar tracking
Sequential radar tracking
 
Arduino Programming
Arduino ProgrammingArduino Programming
Arduino Programming
 
A Robust UART Architecture Based on Recursive Running Sum Filter for Better N...
A Robust UART Architecture Based on Recursive Running Sum Filter for Better N...A Robust UART Architecture Based on Recursive Running Sum Filter for Better N...
A Robust UART Architecture Based on Recursive Running Sum Filter for Better N...
 
Locks? We Don't Need No Stinkin' Locks - Michael Barker
Locks? We Don't Need No Stinkin' Locks - Michael BarkerLocks? We Don't Need No Stinkin' Locks - Michael Barker
Locks? We Don't Need No Stinkin' Locks - Michael Barker
 
Lock? We don't need no stinkin' locks!
Lock? We don't need no stinkin' locks!Lock? We don't need no stinkin' locks!
Lock? We don't need no stinkin' locks!
 
Coding matlab
Coding matlabCoding matlab
Coding matlab
 
Coding matlab
Coding matlabCoding matlab
Coding matlab
 
Router Queue Simulation in C++ in MMNN and MM1 conditions
Router Queue Simulation in C++ in MMNN and MM1 conditionsRouter Queue Simulation in C++ in MMNN and MM1 conditions
Router Queue Simulation in C++ in MMNN and MM1 conditions
 
CODING IN ARDUINO
CODING IN ARDUINOCODING IN ARDUINO
CODING IN ARDUINO
 
Arduino Lecture 3 - Interactive Media CS4062 Semester 2 2009
Arduino Lecture 3 - Interactive Media CS4062 Semester 2 2009Arduino Lecture 3 - Interactive Media CS4062 Semester 2 2009
Arduino Lecture 3 - Interactive Media CS4062 Semester 2 2009
 
Arduino Lecture 3 - Interactive Media CS4062 Semester 2 2009
Arduino Lecture 3 - Interactive Media CS4062 Semester 2 2009Arduino Lecture 3 - Interactive Media CS4062 Semester 2 2009
Arduino Lecture 3 - Interactive Media CS4062 Semester 2 2009
 
I need help understanding the Pan Tompkins algorythm, and Id also .pdf
I need help understanding the Pan Tompkins algorythm, and Id also .pdfI need help understanding the Pan Tompkins algorythm, and Id also .pdf
I need help understanding the Pan Tompkins algorythm, and Id also .pdf
 
Temperature Sensor with LED matrix Display BY ►iRFAN QADOOS◄ 9
Temperature Sensor with LED matrix Display BY ►iRFAN QADOOS◄ 9Temperature Sensor with LED matrix Display BY ►iRFAN QADOOS◄ 9
Temperature Sensor with LED matrix Display BY ►iRFAN QADOOS◄ 9
 
EEL316: ASK
EEL316: ASKEEL316: ASK
EEL316: ASK
 
Mat lab for bplc
Mat lab for bplcMat lab for bplc
Mat lab for bplc
 
Write a Matlab code (a computerized program) for calculating plane st.docx
 Write a Matlab code (a computerized program) for calculating plane st.docx Write a Matlab code (a computerized program) for calculating plane st.docx
Write a Matlab code (a computerized program) for calculating plane st.docx
 
Arvindsujeeth scaladays12
Arvindsujeeth scaladays12Arvindsujeeth scaladays12
Arvindsujeeth scaladays12
 
Minimizing Hidden Node Problem in Vehicular Ad-hoc Network (VANET)
Minimizing Hidden Node Problem in Vehicular Ad-hoc Network (VANET)Minimizing Hidden Node Problem in Vehicular Ad-hoc Network (VANET)
Minimizing Hidden Node Problem in Vehicular Ad-hoc Network (VANET)
 

Mehr von Assignmentpedia

Transmitter side components
Transmitter side componentsTransmitter side components
Transmitter side componentsAssignmentpedia
 
Single object range detection
Single object range detectionSingle object range detection
Single object range detectionAssignmentpedia
 
Radar application project help
Radar application project helpRadar application project help
Radar application project helpAssignmentpedia
 
Parallel computing homework help
Parallel computing homework helpParallel computing homework help
Parallel computing homework helpAssignmentpedia
 
Network costing analysis
Network costing analysisNetwork costing analysis
Network costing analysisAssignmentpedia
 
Matlab simulation project
Matlab simulation projectMatlab simulation project
Matlab simulation projectAssignmentpedia
 
Matlab programming project
Matlab programming projectMatlab programming project
Matlab programming projectAssignmentpedia
 
Image processing project using matlab
Image processing project using matlabImage processing project using matlab
Image processing project using matlabAssignmentpedia
 
Computer Networks Homework Help
Computer Networks Homework HelpComputer Networks Homework Help
Computer Networks Homework HelpAssignmentpedia
 
Theory of computation homework help
Theory of computation homework helpTheory of computation homework help
Theory of computation homework helpAssignmentpedia
 
Help With Digital Communication Project
Help With  Digital Communication ProjectHelp With  Digital Communication Project
Help With Digital Communication ProjectAssignmentpedia
 
Filter Implementation And Evaluation Project
Filter Implementation And Evaluation ProjectFilter Implementation And Evaluation Project
Filter Implementation And Evaluation ProjectAssignmentpedia
 
Distributed Radar Tracking Simulation Project
Distributed Radar Tracking Simulation ProjectDistributed Radar Tracking Simulation Project
Distributed Radar Tracking Simulation ProjectAssignmentpedia
 
Distributed Radar Tracking Simulation Project
Distributed Radar Tracking Simulation ProjectDistributed Radar Tracking Simulation Project
Distributed Radar Tracking Simulation ProjectAssignmentpedia
 
Digital Signal Processing
Digital Signal ProcessingDigital Signal Processing
Digital Signal ProcessingAssignmentpedia
 

Mehr von Assignmentpedia (20)

Transmitter side components
Transmitter side componentsTransmitter side components
Transmitter side components
 
Single object range detection
Single object range detectionSingle object range detection
Single object range detection
 
Resolution project
Resolution projectResolution project
Resolution project
 
Radar application project help
Radar application project helpRadar application project help
Radar application project help
 
Parallel computing homework help
Parallel computing homework helpParallel computing homework help
Parallel computing homework help
 
Network costing analysis
Network costing analysisNetwork costing analysis
Network costing analysis
 
Matlab simulation project
Matlab simulation projectMatlab simulation project
Matlab simulation project
 
Matlab programming project
Matlab programming projectMatlab programming project
Matlab programming project
 
Links design
Links designLinks design
Links design
 
Image processing project using matlab
Image processing project using matlabImage processing project using matlab
Image processing project using matlab
 
Transmitter subsystem
Transmitter subsystemTransmitter subsystem
Transmitter subsystem
 
Computer Networks Homework Help
Computer Networks Homework HelpComputer Networks Homework Help
Computer Networks Homework Help
 
Theory of computation homework help
Theory of computation homework helpTheory of computation homework help
Theory of computation homework help
 
Radar Spectral Analysis
Radar Spectral AnalysisRadar Spectral Analysis
Radar Spectral Analysis
 
Pi Controller
Pi ControllerPi Controller
Pi Controller
 
Help With Digital Communication Project
Help With  Digital Communication ProjectHelp With  Digital Communication Project
Help With Digital Communication Project
 
Filter Implementation And Evaluation Project
Filter Implementation And Evaluation ProjectFilter Implementation And Evaluation Project
Filter Implementation And Evaluation Project
 
Distributed Radar Tracking Simulation Project
Distributed Radar Tracking Simulation ProjectDistributed Radar Tracking Simulation Project
Distributed Radar Tracking Simulation Project
 
Distributed Radar Tracking Simulation Project
Distributed Radar Tracking Simulation ProjectDistributed Radar Tracking Simulation Project
Distributed Radar Tracking Simulation Project
 
Digital Signal Processing
Digital Signal ProcessingDigital Signal Processing
Digital Signal Processing
 

Kürzlich hochgeladen

4.16.24 Poverty and Precarity--Desmond.pptx
4.16.24 Poverty and Precarity--Desmond.pptx4.16.24 Poverty and Precarity--Desmond.pptx
4.16.24 Poverty and Precarity--Desmond.pptxmary850239
 
Influencing policy (training slides from Fast Track Impact)
Influencing policy (training slides from Fast Track Impact)Influencing policy (training slides from Fast Track Impact)
Influencing policy (training slides from Fast Track Impact)Mark Reed
 
Karra SKD Conference Presentation Revised.pptx
Karra SKD Conference Presentation Revised.pptxKarra SKD Conference Presentation Revised.pptx
Karra SKD Conference Presentation Revised.pptxAshokKarra1
 
How to Add Barcode on PDF Report in Odoo 17
How to Add Barcode on PDF Report in Odoo 17How to Add Barcode on PDF Report in Odoo 17
How to Add Barcode on PDF Report in Odoo 17Celine George
 
How to do quick user assign in kanban in Odoo 17 ERP
How to do quick user assign in kanban in Odoo 17 ERPHow to do quick user assign in kanban in Odoo 17 ERP
How to do quick user assign in kanban in Odoo 17 ERPCeline George
 
USPS® Forced Meter Migration - How to Know if Your Postage Meter Will Soon be...
USPS® Forced Meter Migration - How to Know if Your Postage Meter Will Soon be...USPS® Forced Meter Migration - How to Know if Your Postage Meter Will Soon be...
USPS® Forced Meter Migration - How to Know if Your Postage Meter Will Soon be...Postal Advocate Inc.
 
Grade 9 Quarter 4 Dll Grade 9 Quarter 4 DLL.pdf
Grade 9 Quarter 4 Dll Grade 9 Quarter 4 DLL.pdfGrade 9 Quarter 4 Dll Grade 9 Quarter 4 DLL.pdf
Grade 9 Quarter 4 Dll Grade 9 Quarter 4 DLL.pdfJemuel Francisco
 
ISYU TUNGKOL SA SEKSWLADIDA (ISSUE ABOUT SEXUALITY
ISYU TUNGKOL SA SEKSWLADIDA (ISSUE ABOUT SEXUALITYISYU TUNGKOL SA SEKSWLADIDA (ISSUE ABOUT SEXUALITY
ISYU TUNGKOL SA SEKSWLADIDA (ISSUE ABOUT SEXUALITYKayeClaireEstoconing
 
What is Model Inheritance in Odoo 17 ERP
What is Model Inheritance in Odoo 17 ERPWhat is Model Inheritance in Odoo 17 ERP
What is Model Inheritance in Odoo 17 ERPCeline George
 
Daily Lesson Plan in Mathematics Quarter 4
Daily Lesson Plan in Mathematics Quarter 4Daily Lesson Plan in Mathematics Quarter 4
Daily Lesson Plan in Mathematics Quarter 4JOYLYNSAMANIEGO
 
Music 9 - 4th quarter - Vocal Music of the Romantic Period.pptx
Music 9 - 4th quarter - Vocal Music of the Romantic Period.pptxMusic 9 - 4th quarter - Vocal Music of the Romantic Period.pptx
Music 9 - 4th quarter - Vocal Music of the Romantic Period.pptxleah joy valeriano
 
ANG SEKTOR NG agrikultura.pptx QUARTER 4
ANG SEKTOR NG agrikultura.pptx QUARTER 4ANG SEKTOR NG agrikultura.pptx QUARTER 4
ANG SEKTOR NG agrikultura.pptx QUARTER 4MiaBumagat1
 
Student Profile Sample - We help schools to connect the data they have, with ...
Student Profile Sample - We help schools to connect the data they have, with ...Student Profile Sample - We help schools to connect the data they have, with ...
Student Profile Sample - We help schools to connect the data they have, with ...Seán Kennedy
 
Virtual-Orientation-on-the-Administration-of-NATG12-NATG6-and-ELLNA.pdf
Virtual-Orientation-on-the-Administration-of-NATG12-NATG6-and-ELLNA.pdfVirtual-Orientation-on-the-Administration-of-NATG12-NATG6-and-ELLNA.pdf
Virtual-Orientation-on-the-Administration-of-NATG12-NATG6-and-ELLNA.pdfErwinPantujan2
 
4.18.24 Movement Legacies, Reflection, and Review.pptx
4.18.24 Movement Legacies, Reflection, and Review.pptx4.18.24 Movement Legacies, Reflection, and Review.pptx
4.18.24 Movement Legacies, Reflection, and Review.pptxmary850239
 
Food processing presentation for bsc agriculture hons
Food processing presentation for bsc agriculture honsFood processing presentation for bsc agriculture hons
Food processing presentation for bsc agriculture honsManeerUddin
 
Incoming and Outgoing Shipments in 3 STEPS Using Odoo 17
Incoming and Outgoing Shipments in 3 STEPS Using Odoo 17Incoming and Outgoing Shipments in 3 STEPS Using Odoo 17
Incoming and Outgoing Shipments in 3 STEPS Using Odoo 17Celine George
 
Visit to a blind student's school🧑‍🦯🧑‍🦯(community medicine)
Visit to a blind student's school🧑‍🦯🧑‍🦯(community medicine)Visit to a blind student's school🧑‍🦯🧑‍🦯(community medicine)
Visit to a blind student's school🧑‍🦯🧑‍🦯(community medicine)lakshayb543
 
ENGLISH 7_Q4_LESSON 2_ Employing a Variety of Strategies for Effective Interp...
ENGLISH 7_Q4_LESSON 2_ Employing a Variety of Strategies for Effective Interp...ENGLISH 7_Q4_LESSON 2_ Employing a Variety of Strategies for Effective Interp...
ENGLISH 7_Q4_LESSON 2_ Employing a Variety of Strategies for Effective Interp...JhezDiaz1
 

Kürzlich hochgeladen (20)

4.16.24 Poverty and Precarity--Desmond.pptx
4.16.24 Poverty and Precarity--Desmond.pptx4.16.24 Poverty and Precarity--Desmond.pptx
4.16.24 Poverty and Precarity--Desmond.pptx
 
Influencing policy (training slides from Fast Track Impact)
Influencing policy (training slides from Fast Track Impact)Influencing policy (training slides from Fast Track Impact)
Influencing policy (training slides from Fast Track Impact)
 
Karra SKD Conference Presentation Revised.pptx
Karra SKD Conference Presentation Revised.pptxKarra SKD Conference Presentation Revised.pptx
Karra SKD Conference Presentation Revised.pptx
 
How to Add Barcode on PDF Report in Odoo 17
How to Add Barcode on PDF Report in Odoo 17How to Add Barcode on PDF Report in Odoo 17
How to Add Barcode on PDF Report in Odoo 17
 
How to do quick user assign in kanban in Odoo 17 ERP
How to do quick user assign in kanban in Odoo 17 ERPHow to do quick user assign in kanban in Odoo 17 ERP
How to do quick user assign in kanban in Odoo 17 ERP
 
USPS® Forced Meter Migration - How to Know if Your Postage Meter Will Soon be...
USPS® Forced Meter Migration - How to Know if Your Postage Meter Will Soon be...USPS® Forced Meter Migration - How to Know if Your Postage Meter Will Soon be...
USPS® Forced Meter Migration - How to Know if Your Postage Meter Will Soon be...
 
Grade 9 Quarter 4 Dll Grade 9 Quarter 4 DLL.pdf
Grade 9 Quarter 4 Dll Grade 9 Quarter 4 DLL.pdfGrade 9 Quarter 4 Dll Grade 9 Quarter 4 DLL.pdf
Grade 9 Quarter 4 Dll Grade 9 Quarter 4 DLL.pdf
 
ISYU TUNGKOL SA SEKSWLADIDA (ISSUE ABOUT SEXUALITY
ISYU TUNGKOL SA SEKSWLADIDA (ISSUE ABOUT SEXUALITYISYU TUNGKOL SA SEKSWLADIDA (ISSUE ABOUT SEXUALITY
ISYU TUNGKOL SA SEKSWLADIDA (ISSUE ABOUT SEXUALITY
 
YOUVE_GOT_EMAIL_PRELIMS_EL_DORADO_2024.pptx
YOUVE_GOT_EMAIL_PRELIMS_EL_DORADO_2024.pptxYOUVE_GOT_EMAIL_PRELIMS_EL_DORADO_2024.pptx
YOUVE_GOT_EMAIL_PRELIMS_EL_DORADO_2024.pptx
 
What is Model Inheritance in Odoo 17 ERP
What is Model Inheritance in Odoo 17 ERPWhat is Model Inheritance in Odoo 17 ERP
What is Model Inheritance in Odoo 17 ERP
 
Daily Lesson Plan in Mathematics Quarter 4
Daily Lesson Plan in Mathematics Quarter 4Daily Lesson Plan in Mathematics Quarter 4
Daily Lesson Plan in Mathematics Quarter 4
 
Music 9 - 4th quarter - Vocal Music of the Romantic Period.pptx
Music 9 - 4th quarter - Vocal Music of the Romantic Period.pptxMusic 9 - 4th quarter - Vocal Music of the Romantic Period.pptx
Music 9 - 4th quarter - Vocal Music of the Romantic Period.pptx
 
ANG SEKTOR NG agrikultura.pptx QUARTER 4
ANG SEKTOR NG agrikultura.pptx QUARTER 4ANG SEKTOR NG agrikultura.pptx QUARTER 4
ANG SEKTOR NG agrikultura.pptx QUARTER 4
 
Student Profile Sample - We help schools to connect the data they have, with ...
Student Profile Sample - We help schools to connect the data they have, with ...Student Profile Sample - We help schools to connect the data they have, with ...
Student Profile Sample - We help schools to connect the data they have, with ...
 
Virtual-Orientation-on-the-Administration-of-NATG12-NATG6-and-ELLNA.pdf
Virtual-Orientation-on-the-Administration-of-NATG12-NATG6-and-ELLNA.pdfVirtual-Orientation-on-the-Administration-of-NATG12-NATG6-and-ELLNA.pdf
Virtual-Orientation-on-the-Administration-of-NATG12-NATG6-and-ELLNA.pdf
 
4.18.24 Movement Legacies, Reflection, and Review.pptx
4.18.24 Movement Legacies, Reflection, and Review.pptx4.18.24 Movement Legacies, Reflection, and Review.pptx
4.18.24 Movement Legacies, Reflection, and Review.pptx
 
Food processing presentation for bsc agriculture hons
Food processing presentation for bsc agriculture honsFood processing presentation for bsc agriculture hons
Food processing presentation for bsc agriculture hons
 
Incoming and Outgoing Shipments in 3 STEPS Using Odoo 17
Incoming and Outgoing Shipments in 3 STEPS Using Odoo 17Incoming and Outgoing Shipments in 3 STEPS Using Odoo 17
Incoming and Outgoing Shipments in 3 STEPS Using Odoo 17
 
Visit to a blind student's school🧑‍🦯🧑‍🦯(community medicine)
Visit to a blind student's school🧑‍🦯🧑‍🦯(community medicine)Visit to a blind student's school🧑‍🦯🧑‍🦯(community medicine)
Visit to a blind student's school🧑‍🦯🧑‍🦯(community medicine)
 
ENGLISH 7_Q4_LESSON 2_ Employing a Variety of Strategies for Effective Interp...
ENGLISH 7_Q4_LESSON 2_ Employing a Variety of Strategies for Effective Interp...ENGLISH 7_Q4_LESSON 2_ Employing a Variety of Strategies for Effective Interp...
ENGLISH 7_Q4_LESSON 2_ Employing a Variety of Strategies for Effective Interp...
 

Fpga Design Project

  • 1. FPGA DESIGN USING MATLAB Our online Tutors are available 24*7 to provide Help with FPGA Design Homework/Assignment or a long term Graduate/Undergraduate FPGA Design Project. Our Tutors being experienced and proficient in FPGA Design ensure to provide high quality FPGA Design Homework Help. Upload your FPGA Design Assignment at ‘Submit Your Assignment’ button or email it to info@assignmentpedia.com. You can use our ‘Live Chat’ option to schedule an Online Tutoring session with our FPGA Design Tutors. SCAN RADAR USING A UNIFORM RECTANGULAR ARRAY This example simulates a phased array radar that periodically scans a predefined surveillance region. A 900-element rectangular array is used in this monostatic radar. Steps are introduced to derive the radar parameters according to specifications. After synthesizing the received pulses, detection and range estimation are performed. Finally, Doppler estimation is used to obtain the speed of each target. pd = 0.9; % Probability of detection pfa = 1e-6; % Probability of false alarm max_range = 5000; % Maximum unambiguous range tgt_rcs = 1; % Required target radar cross section int_pulsenum = 10; % Number of pulses to integrate Load the radar system and retrieve system parameters. load basicmonostaticradardemodata; fc = hradiator.OperatingFrequency; % Operating frequency (Hz) v = hradiator.PropagationSpeed; % Wave propagation speed (m/s) lambda = v/fc; % Wavelength (m) fs = hwav.SampleRate; % Sampling frequency (Hz) prf = hwav.PRF; % Pulse repetition frequency (Hz) Next, we define a 30-by-30 uniform rectangular array. wsURA = warning('off', 'phased:system:array:SizeConventionWarning'); harray = phased.URA('Element',hant,... 'Size',[30 30],'ElementSpacing',[lambda/2, lambda/2]); % Configure the antenna elements such that they only transmit forward harray.Element.BackBaffled = true; % Visualize the response pattern. plotResponse(harray,fc,physconst('LightSpeed'),... 'RespCut','3D','Format','Polar');
  • 2. Associate the array with the radiator and collector. hradiator.Sensor = harray; hcollector.Sensor = harray; % We need to set the WeightsInputPort property to true to enable it to % accept transmit beamforming weights hradiator.WeightsInputPort = true; Now we need to recalculate the transmit power. The original transmit power was calculated based on a single antenna. For a 900-element array, the power required for each element is much less. % Calculate the array gain hag = phased.ArrayGain('SensorArray',harray,'PropagationSpeed',v); ag = step(hag,fc,[0;0]); % Use the radar equation to calculate the peak power snr_min = albersheim(pd, pfa, int_pulsenum); peak_power = radareqpow(lambda,max_range,snr_min,hwav.PulseWidth,... 'RCS',tgt_rcs,'Gain',htx.Gain + ag) peak_power =
  • 3. 0.0065 The new peak power is 0.0065 Watts. % Set the peak power of the transmitter htx.PeakPower = peak_power; We also need to design the scanning schedule of the phased array. To simplify the example, we only search in the azimuth dimension. We require the radar to search from 45 degrees to -45 degrees in azimuth. The revisit time should be less than 1 second, meaning that the radar should revisit the same azimuth angle within 1 second. initialAz = 45; endAz = -45; volumnAz = initialAz - endAz; To determine the required number of scans, we need to know the beamwidth of the array response. We use an empirical formula to estimate the 3-dB beamwidth. where is the array gain and is the 3-dB beamwidth. % Calculate 3-dB beamwidth theta = radtodeg(sqrt(4*pi/db2pow(ag))) theta = 6.7703 The 3-dB beamwidth is 6.77 degrees. To allow for some beam overlap in space, we choose the scan step to be 6 degrees. scanstep = -6; scangrid = initialAz+scanstep/2:scanstep:endAz; numscans = length(scangrid); pulsenum = int_pulsenum*numscans; % Calculate revisit time revisitTime = pulsenum/prf
  • 4. revisitTime = 0.0050 The resulting revisit time is 0.005 second, well below the prescribed upper limit of 1 second. Target Definition We want to simulate the pulse returns from two non-fluctuating targets, both at 0 degrees elevation. The first target is approaching to the radar, while the second target is moving away from the radar. htarget{1} = phased.RadarTarget(... 'MeanRCS',1.6,... 'OperatingFrequency',fc); htargetplatform{1} = phased.Platform(... 'InitialPosition',[3532.63; 800; 0],... 'Velocity',[-100; 50; 0]); % Calculate the range, angle, and speed of the first target [tgt1_rng,tgt1_ang] = rangeangle(htargetplatform{1}.InitialPosition,... hantplatform.InitialPosition); tgt1_speed = radialspeed(htargetplatform{1}.InitialPosition,... htargetplatform{1}.Velocity,hantplatform.InitialPosition); htarget{2} = phased.RadarTarget(... 'MeanRCS',1.2,... 'OperatingFrequency',fc); htargetplatform{2} = phased.Platform(... 'InitialPosition',[2000.66; 0; 0],... 'Velocity',[60; 80; 0]); % Calculate the range, angle, and speed of the second target [tgt2_rng,tgt2_ang] = rangeangle(htargetplatform{2}.InitialPosition,... hantplatform.InitialPosition); tgt2_speed = radialspeed(htargetplatform{2}.InitialPosition,... htargetplatform{2}.Velocity,hantplatform.InitialPosition); numtargets = length(htarget); Pulse Synthesis Now that all subsystems are defined, we can proceed to simulate the received signals. The total simulation time corresponds to one pass through the surveillance region. Because the reflected signals are received by an array, we use a beamformer pointing to the steering direction to obtain the combined signal. % Create the steering vector for transmit beamforming
  • 5. hsv = phased.SteeringVector('SensorArray',harray,'PropagationSpeed',v); % Create the receiving beamformer hbf = phased.PhaseShiftBeamformer('SensorArray',harray,... 'OperatingFrequency',fc,'PropagationSpeed',v,... 'DirectionSource','Input port'); % Define propagation channel for each target for n = numtargets:-1:1 htargetchannel{n} = phased.FreeSpace(... 'SampleRate',fs,... 'TwoWayPropagation',true,... 'OperatingFrequency',fc); end fast_time_grid = unigrid(0, 1/fs, 1/prf, '[)'); rx_pulses = zeros(numel(fast_time_grid),pulsenum); % Pre-allocate tgt_ang = zeros(2,numtargets); % Target angle for m = 1:pulsenum x = step(hwav); % Generate pulse [s, tx_status] = step(htx,x); % Transmit pulse [ant_pos,ant_vel] = step(hantplatform,1/prf);% Update antenna position % Calculate the steering vector scanid = floor((m-1)/int_pulsenum) + 1; sv = step(hsv,fc,scangrid(scanid)); w = conj(sv); rsig = zeros(length(s),numtargets); for n = numtargets:-1:1 % For each target [tgt_pos,tgt_vel] = step(... htargetplatform{n},1/prf); % Update target position [~,tgt_ang(:,n)] = rangeangle(tgt_pos,...% Calculate range/angle ant_pos); tsig = step(hradiator,s,tgt_ang(:,n),w); % Radiate toward target tsig = step(htargetchannel{n},... % Propagate pulse tsig,ant_pos,tgt_pos,ant_vel,tgt_vel); rsig(:,n) = step(htarget{n},tsig); % Reflect off target end rsig = step(hcollector,rsig,tgt_ang); % Collect all echoes rsig = step(hrx,rsig,~(tx_status>0)); % Receive signal rsig = step(hbf,rsig,[scangrid(scanid);0]); % Beamforming rx_pulses(:,m) = rsig; % Form data matrix end Matched Filter
  • 6. To process the received signal, we first pass it through a matched filter, then integrate all pulses for each scan angle. % Matched filtering matchingcoeff = getMatchedFilter(hwav); hmf = phased.MatchedFilter(... 'Coefficients',matchingcoeff,... 'GainOutputPort',true); [mf_pulses, mfgain] = step(hmf,rx_pulses); mf_pulses = reshape(mf_pulses,[],int_pulsenum,numscans); matchingdelay = size(matchingcoeff,1)-1; sz_mfpulses = size(mf_pulses); mf_pulses = [mf_pulses(matchingdelay+1:end) zeros(1,matchingdelay)]; mf_pulses = reshape(mf_pulses,sz_mfpulses); % Pulse integration int_pulses = pulsint(mf_pulses,'noncoherent'); int_pulses = squeeze(int_pulses); % Visualize r = v*fast_time_grid/2; X = r'*cosd(scangrid); Y = r'*sind(scangrid); clf; pcolor(X,Y,pow2db(abs(int_pulses).^2)); axis equal tight shading interp set(gca,'Visible','off'); text(-800,0,'Array'); text((max(r)+10)*cosd(initialAz),(max(r)+10)*sind(initialAz),... [num2str(initialAz) '^o']); text((max(r)+10)*cosd(endAz),(max(r)+10)*sind(endAz),... [num2str(endAz) '^o']); text((max(r)+10)*cosd(0),(max(r)+10)*sind(0),[num2str(0) '^o']); colorbar;
  • 7. From the scan map, we can clearly see two peaks. The close one is at around 0 degrees azimuth, the remote one at around 10 degrees in azimuth. Detection and Range Estimation To obtain an accurate estimation of the target parameters, we apply threshold detection on the scan map. First we need to compensate for signal power loss due to range by applying time varying gains to the received signal. range_gates = v*fast_time_grid/2; htvg = phased.TimeVaryingGain(... 'RangeLoss',2*fspl(range_gates,lambda),... 'ReferenceLoss',2*fspl(max(range_gates),lambda)); tvg_pulses = step(htvg,mf_pulses); % Pulse integration int_pulses = pulsint(tvg_pulses,'noncoherent'); int_pulses = squeeze(int_pulses); % Calculate the detection threshold npower = noisepow(hrx.NoiseBandwidth,... hrx.NoiseFigure,hrx.ReferenceTemperature); threshold = npower * db2pow(npwgnthresh(pfa,int_pulsenum,'noncoherent')); % Increase the threshold by the matched filter processing gain
  • 8. threshold = threshold * db2pow(mfgain); We now visualize the detection process. To better represent the data, we only plot range samples beyond 50. N = 51; clf; surf(X(N:end,:),Y(N:end,:),... pow2db(abs(int_pulses(N:end,:)).^2)); hold on; mesh(X(N:end,:),Y(N:end,:),... pow2db(threshold*ones(size(X(N:end,:)))),'FaceAlpha',0.8); view(0,56); set(gca,'Visible','Off'); There are two peaks visible above the detection threshold, corresponding to the two targets we defined earlier. We can find the locations of these peaks and estimate the range and angle of each target. [I,J] = find(abs(int_pulses).^2 > threshold); est_range = range_gates(I); % Estimated range est_angle = scangrid(J); % Estimated direction
  • 9. Doppler Estimation Next, we want to estimate the Doppler speed of each target. For details on Doppler estimation, refer to the example Doppler Estimation. for m = 2:-1:1 [p, f] = periodogram(mf_pulses(I(m),:,J(m)),[],256,prf, ... 'power','centered'); speed_vec = dop2speed(f,lambda)/2; spectrum_data = p/max(p); [~,dop_detect1] = findpeaks(pow2db(spectrum_data),'MinPeakHeight',-5); sp(m) = speed_vec(dop_detect1); end warning(wsURA); Finally, we have estimated all the parameters of both detected targets. Below is a comparison of the estimated and true parameter values. ------------------------------------------------------------------------ Estimated (true) target parameters ------------------------------------------------------------------------ Range (m) Azimuth (deg) Speed (m/s) Target 1: 3625.00 (3622.08) 12.00 (12.76) 86.01 (86.49) Target 2: 2025.00 (2000.66) 0.00 (0.00) -59.68 (-60.00) Summary In this example, we showed how to simulate a phased array radar to scan a predefined surveillance region. We illustrated how to design the scanning schedule. A conventional beamformer was used to process the received multi-channel signal. The range, angle, and Doppler information of each target are extracted from the reflected pulses. This information can be used in further tasks such as high resolution direction-of-arrival estimation, or target tracking. visit us at www.assignmentpedia.com or email us at info@assignmentpedia.com or call us at +1 520 8371215