Lab
No.
6
7
Radar & Navigation Lab
List of Experiments
Compute the
duty
pulse repetition
frequen
nd
ley average {ransmitted power, pulse energy an
Ney of Radar wave
Computation of Radar Equation
Analysis of
of Radar Signal to Noise Ratio ‘against target detection range for
sifYerent val
Nes of target Radar crosssection
Analysis of Radar Signal to Noise
Ratio (SNR) against target detection range for
Uifferent value.
of Radar peak power
‘Compute the puls. ‘width required to achieve a certain SNR for a given
Aetection range
Analysis of the probability of false alarm, probability density function
Analyse the performance of a Delay Line Canceller at different blind speeds |
Analyse the performance ofa Double-Tap Delay Line Cancellerat |
different blind speeds
Understand and analyse the sum and difference antenna pattem of
in
monopulse radar
Understand and analyse the radiation pattern of linear array antenna
in
‘To study the characteristics of Gunn oscillator, Gun diode as modulated source
istics of illator,
ly teri
ic roe
judy the Characteristics of Reflex Klystron tube & to determine it |
To study .
electronic tuning range.Experiment 01,
Objective:
ompute the duty ¢
Compute the duty cycle, average transmitted power, pulse energy and pulse
repetition frequency of Radar wave
Simulation T
SCILAB
Input Parameters:
| tau Pulse width
9 | pri PRI Seconds
| ppower [Peak power Watts
4 Output parameters:
4
, ep | Pulse Energy | Joules
A prt I PRE l
3 Description:
The most common radar signal or waveform is a series of short duration, somewhat
rectangular shaped pulses modulating a sine wave carrier. (This is sometimes called a
pulse train)
&
Figure 1.1 Train of transmitted and received pulses
vee eve 86 So DeeIn general, pulse radar transmits and receives a train of pulses, as illustrated in
figure 1.1. The Inter Pulse Period (IPP) is T, and the pulse width is 1. The IPP is often
referred to as Pulse Repetition Interval (PRI). The inverse of PRI is PRF, denoted by fr.
fr=1/PRI=1/T
During each PRI the radar radiates energy only for T seconds and listens for target
returns for the rest of the PRI. The Radar transmitting duty cycle dt is defined as the
ratio d= 4/1. The radar average transmitted power is
a
: Pav= Ptxdt
9 Where Pt is radar peak power, The pulse energy is
2
Ep=Pt t= Pay T= Pav/fr
SCILAB Code and Results:
Secalculate range of radar
cle ;
200*10* -6; % timedelayinsec
a vee ttosityiam/s
=( Vo* Tdelay ) /2; %Range o fthe targetinmts
> R=R/1000;% inkms ° .
disp(range of radar’)
9 disp(R)
%6%6%0%0%%%%F NDING DUTY CYCLE PRT PULSE WIDTH PULSE ENERGY
3 Pt=5000; %Peak tx power in watts
Pav =1000; %Average Power
PRF1 = 10; %Pulserepetitionfrequencyinkhz
E %Duty cycle
PRFI ;%Pulserepetitiveintervalinmsec
* PRII ; %Puls e Width in msec
=Pt*PW1;%PulseEnergyinjoules
disp(‘duty cycle’)
disp(D)
disp(‘pulse repetition time in msec’)
disp(PRI1)
disp('pulse energy in joule’)
disp(PE1
WANA /Range Resolutio
UR =200; %unambiguous r ang e i n kms
*10%6; Ybandwidth i n hz
*10°8; Yvelocityinm/s
PRF =V0/(2* UR *10°3) ;%pulserepetitionfrequency inhz
PRI=1/PRF; %pulserepetitionintervalinsec
RR=VO /(2* BW); %Range Re solutioninmts
PW =(2* RR) V0); %pul se width
disp(‘range resolution in mts')
disp(RR)
2 e
vv & 6 & 2 & © & SF & @
we ’ 8s uw Se.
yeo 2. 8&2 82 S
»
-
a
a
cow eee ef ee eS
oC -
Experiment 02
Aim:
Computation of Radar Equation using SCILAB.
Simulation Tool:
SCILAB
Description:
The radar equation is given by:
SNR =[Pt.G2,
0] / {(4).k.Te.B.Fn.L.R4}
Input Parameters:
Eas Peak Power | Watts
f Frequency “Hz
[¢ Gain of the Antenna B
oOo Target cross section 2
| Te | Effective noise | ‘Kelvin |
Baa] Bandwidth Hertz
Fn] Noise figure B
iemak, Boltzmann constant | _1/K
[_L Radar loss meters|
R _ Target range B
SNR Signal to noise ratio dB
Simulate the Radar equation (A). The program must consist of a reasonably simple
user interface that will enable users to enter the input parameters for the Radar
Equation. Attach the code and output result.
SCILAB Code and Results:
cle
clear
Pt=500000; Yopeak power in watts
F=10*1049; %operating freq in hz
MRP =0.1*10* -12; Yominimum r eceivable power in watts
Ac=5;%captureareaofantennainm2;
RCS =20; %r adarcrosssectionalareainm*2;
Vo =3*10°8 Yov elocityinm/s
lamda =Vo/F
Rmax=((Pt*Ac*2*RCS) /(4* pi * lamda”2* MRP ))“0.25;%in mt
Rmax=Rmax/1000;% inkm
disp(‘maximum range in km’)LAB SESSION 03
Objective:
Analysis of Radar Si
values of target Rad ignal to Noise Ratio against target detection range for different
lar cross section,
Software Required: SCILAB
Description:
The radar equation is given by:
SNR =[Pt.G?..2.0] /{(4n3),-Te.B.Fn.LR4]-
Here,
| Pt Peak Power Watts
al Frequency |_—-#Hz_|
G Gain ofthe Antenna | dB
oO Target cross section =m.
Te | Effective noise Kelvin
B Bandwidth Hertz
Fn Noise figure | dB
K Boltzmann constant | _J/K
as Radar loss meters)
R Target range dB
|__SNR Signal to noise ratio dB
The radar minimum and maximum detection ranges are Rmin = 25km and Rmax =
165km. The different target cross section values are O= 0 dBm, O'=-10 dBm and = -20
dBm.
SCILAB Code and Results:
{funetion [snr] = radar_eq(pt, freq, g, sigma, te, b, nf, loss, range)
% This program implements Eq.A
c= 3.00+8; % speed of light
lambda = c / freq; % wavelength
p_peak = 10*log10(pi); % convert peak power todB
lambda_sqdb = 10*log!0(lambda"2); % compute wavelength square in dB
sigmadb = 10*log10(sigma); % convert sigma to dB
‘four _pi_cub = 10*10g10((4.0 * pi)/3): % (4p)"3 in dB
kdb = 10*log10(1.380-23); % Boltzman’s constant in dB
te_db = 10*log!0(te); % noise temp. in dB
b_db = 10*log!0(b); % bandwidth in dB> es ve we weve OUT™SeleO
ow eo
a
7
range pwrd. db ~ 10*log O¢range 4)
% vector of target range’ 4 in dB
% Implement Equation (1.56)
num = p peak + 8+ 9+ lambda 5qdb + sigmadb;
den = four plcub +k dbs t@ db + b db + nf + loss + range pord db;
snr = num ~
den; return
WARM main program target v/a range
close all
clear all
Pt= 1.Se+6; % peak power in Watts
freq = 5.6¢+9; % radar operating frequency in Hz.
8 = 45.0; % antenna gain in dB
sigma = 0.1; % radar cross section in m squared
te=290.0; % effective Noise temperature in Kelvins
b=5.0c+6; % radar Operating bandwidth in Hz
nf = 3.0; %noise figure in dB
loss = 6.0; % radar losses in dB
range = linspace(25e3,165¢3,1000);
snrl = radar_eq(pt, freq, g, sigma, te, b, nf, oss, range);
snr2 = radar_eq(pt, freq, g, sigma/10, te, b, nf, loss, range);
snr3 = radar_eq(pt, freq, g, sigma*10, te, b, nf, loss, range);
“plot SNR versus range
figure(1)
rangekm = range / 1000;
plot(rangekm,snr3,’k’,rangekm,snrl,'k ~‘yrangekm,snr2,k:')
id
Tegend("\sigma = 0 dBsm',\sigma = -10dBs',\sigma = -20 dBsm')
xlabel (‘Detection range - Km’);
ylabel (‘SNR - dB’);
‘% traget range 25 -165 Km, 1000 points
‘Bije et te vo Se SOR Soper op Omi icp vPmirr cpus veep sr] TOP
}
esc
o*-10aB6
| | PrP]
ol. aoe
10
20 40 60 800012040180 180
Figure 3.1 SNR versus detection range for three different values of RCS.ee woe GoLG
Objective:
Analysis of Radar Signal to No
different values of Radar peak loise ae (SNR) against target detection range for
Software Required:
SCILAB
Description:
The radar equation is given by:
SNR = [Pt.G?.2?,0]/ [(4).kTe.B.Fn.L.R4}
(A)
Syntax:
[snr] = radar_eq (Pt, Freq, G, sigma, Te, B, Nf, loss, range)
Here,
___Peak Power Wats
Pt
if ist | UUEEIEEE Frequency manasn |
_G | Gain of the Antenna _| e
t+ mma | dB
T
| Target cross section
€ Effective noise Kelvin
B Bandwidth | Hertz
Fn Noise figure 1
Boltzmann constant | W/K
‘Radar loss meters
Target range
Signal to noise ratio
alt
al
Be
K
L
ane
_SNR
The radar minimum and maximum detection ranges are Rmin = 25Km and Rmax =
165Km. The different target cross section values are Pt = 2.16 MW, Pt = 1.5 MW and Pt =
MW.
Plot the SNR versus detection range for given values of Radar Peak Power . Also attach
the code and result plots.SCILAB Code and Results:
function [snr] = radar_eq(pt,
°% This program implements i) eee ea maneey
¢ = 3.0e+8; % speed of light
lambda = c/ freq; % wavelength
p_peak ~ 10*log10(p1); % convert peak power todB
‘ambda_sqdb ~ 10*log10(lambda"2); % compute wavelength square indB sigmadb
= 10*log10(sigma); % convert sigma to dB
four_pi_cub = 10*log10((4.0 * pi)3); % (4pi)?3 in dB
k_db = 10*log10(1.38e-23); % Boltzman's constant in dB
te_db = 10*log10(te); % noise temp. in dB
b db = 10*log10(b); % bandwidth in dB
range_pwrt_db = 10*log10(range.™4); % vector of target range™4 in dB
% Implement Equation (1.56)
num = p_peak + g + g + lambda_sqdb + sigmadb;
den = four pi_cub + k_db + te_db + b_db + nf + loss +
range_pwrd_db; snr = num - den;
return
%e'
close all
clear all
fo %o%o%o%o%o/o'/omnain program SNR v/s peak power
pt = 1.5e+6; % peak power in Watts
freq = 5.6e+9; % radar operating frequency in Hz
g = 45.0; % antenna gain in dB
sigma = 0.1; % radar cross section in m squared
te = 290.0; % effective noise temperature in Kelvins
b = 5.0e+6; % radar operating bandwidth in Hz
nf = 3.0; Yonoise figure in aB
loss = 6.0; % radar losses in
4B
range = linspace(25e3, 165¢3,1000);
snrl = radar_eq(pt, freq, & sigma, te, b, nf, loss,
sigma, te, b, nf, loss, range):
sigma, te, b, nf loss,
% traget range 25 -165 Km, 1000 points
range);
snr2 = radar_eq(pt*.4, freq, &
snr3 = radar_eq(pt*1.8, freq, &
range); figure (2)plot(rangekm.snr3,'k\rangekm, snr. rangelonsnr?,'k:)
grid
legend! Pt = 2.16 MW’. Pt= 1.5 MW P= 0.6 Mw")
Jabel (‘Detection -
Km’); label (SNR - dB’);
; Pte218 Mw
we rte ||
¥ Pis08 MW
4 |
r: |
‘ |
. |
| |
8 T
=
g |
Z |
9 t
r | } |
10
| | |
| |
s
°
|
A eee b
Oe a OGtOe ater
Detection range - Km
x10
Fig. 4.1 SNR versus detection range for given values of Radar Peak Power4
LAB SESSION 05
Objective:
ompute the Wit
Tocompute the pulse-width required to achieve a certain SNR for a given detection range.
Software Required;
SCILAB
Description:
The equation linking the SNR and radar Pulse width is given by:
= 3,
77 (GR*).49.(Pe).(8).¢Fm).(1).(SNR).(R4] /1(P).(G2).02)0)]
Here,
;— Pt | Peak Power Watts
mat __ Frequency Hz
G Gain of the Antenna 4B
| 0 Target cross section 2
| Te | Effective noise Kelvin
B Bandwidth | Hertz
| Fn Noise figure B
K Boltzmann constant VK
iE Radar loss Meters|
R Target range dB
SNR Signal to noise ratio aB
The three different range values are R1 = 75 Km, R2 = 100 Km and R3= 150 Km.
Obtain a plot for pulse width versus required SNR for three given range values, Also
attach the code along with plot.
SCILAB Code and Results:
close all
clear all
I= 1.e+6; % peak power in Watts
req = 5.6€+9; % radar operating frequency in Hz
8 = 40.0; % antenna gain in dB
Sigma = 0.1; % radar cross section in m squared
'e =300.0; % effective noise temperature in Kelvins
"I= 5.0; Yonoise figure in dBJoss ~ 6.0; % radar losses in dB
range = [75¢3,10003,150€3]; % three range values
snr_db = linspace(5,20,200); % SNR value
ab =| 200); % 's from 5 dB s
snr = 10:"(0.1.*snr_db); % convert sr into base 10 epee
gain = 10°(0.1*g); Yéconvert antenna gain into base 10
loss = 10°(0.1 *loss); % convert losses into base 10
F = 10%(0.1*nf); % convert noise figure into base 10
lambda = 3.¢8 / freq; % compute wavelength
% Implement Eq.(1.57)
den = pt * gain * gain * sigma * lambda’2;
num] = (A*pi)"3 * 1380-23 * te * F * loss * range(1)*4 .*
snr; num2 = (4*pi)*3 * 1.38e-23 * te * F * loss * range(2)4
© snr; num3 = (4*pi)3 * 1.38e-23 * te * F * loss *
range(3)*4..* snr; taul = num! / den ;
tau2 = num? / den;
tau3 = num3 / den;
% plot tau versus snr
Sigure(1)
semilogy(snr_db, 1e6*taul, 'k’,snr_db, le6*tau2, 'k -
\snr_db, 1e6*tau3, 'k:') grid
legend(’R = 75 Km’,'R = 100 Km’,'R = 150 Km’)
xlabel (’Minimum required SNR - dB’);
ylabel (\tau (pulsewidth) in \mu sec );= ~
=a _
~ =——
- poe
~ es
ae
WO ieee
Minimum required 8NR - dB
Figure 5.1 Pulse width versus required SNR for three different detection range values
10Experiment 06
objective:
Analysis of probability density function( sian Rayleighy
»Probability of false alarm
Software Required:
SCILAB
Description:
SCILAB Code and Results:
%probability density function (Guassian &Rayleigh)
clear all
close all
38 ~ linspace(-6,6,1500); % random variable between -6 and 6
it = linspace(0,6,1500); % random variable between 0 and 6
0
; % zero mean Gaussian pdf mean
Sigma = 1.5;
% standard deviation (sqrt(variance))
ormpdf(xg,mu, sigma); % use SCILAB function normpdf
>fay = raylpdf(xr,sigma); % use SCILAB function raylpdf
Plotxe,ynorm, k nyray,’k-.');
eri
legend(Gaussian pdf, ‘Rayleigh pdf)
Alabel(
YlabelProbability density’)- a "4
Se
. ss —s es —-— se — —s 's = Mes '
ee ee:
— st. os ss ee
I
sa¢\mu = 03 sigma = 1,5)
ate’ (\sigma =1.5')
tex
WAAAY
ce;
clears
.5*10°9; Yobandwidth of pulsed i
The 10;9% false alarm timeinminues tit
al =Tfa*60;%Falsealarm timeinsecond
pia= 1 BW* Tfal ) :
disp(probability of false alarm is~)
disp(Pfa)
o4
osobjective:
write a SCILAB code to plot the frequency response of a single-tap delay canceler (with
normalized frequency). Amplitude is to be shown in Volts and in a3,
software Required:
scILAB
Description:
single-Delay Line Canceler frequency response:
The signal from a target at range Ro at the output of
phase detector is V1 = Vo sin(2nfdt- 0)
where, fd = Doppler frequency shift = 2ve/ A or n/Tp
‘onstant Phase shift = 4TfRo/A (Range at time = 0)
Amplitude of the signal
V2 = Vo sin(2nfd(t - Tp) - 0)
Where, Tp = Pulse Repetition Interval
Delay Line Cancelation: V=V1 — V2
The amplitude response hence derived to be: H(f) = 2 sin(nfd Tp)
[symbol Description
Fd Doppler frequency shift
Vo Amplitude of signal
Tp Pulse Repetition Period
Vv Delay Line Canceler output _|
cH ‘Amplitude Response° 08 1 18
° os 1 16 2 26 3 35 4
Normalized frequency - tir
Figure 7.1 Single tap delay canceler frequency response
SCILAB Code and Results:
foft1=4;%no of periods required
.00001;
.01 :fofrl;
argl = pi..* fofr;
resp = 4.0 .*((sin(arg1)).”2);
maxl = max(resp);
resp = resp / maxl;
Subplot(2,1 sl)
Plot(foft,resp,'k")
‘label (‘Normalized frequency - f/fr’)
vane ‘Amplitude response - Volts’)
i
Subplot(2,1 2)
$P=10.*log 1 0(respteps);
Dlotfofrresp,k’y;
axis tight
grid
pt (Normalized frequency - f/ft’)
\CAmplitude response - 4’)objective:
gerstand and analyse the performance of aDouble-Tap Delay Line Cancellerat
Uneeent blind speeds
gifferer
software Required:
sCILAB
Description:
pouble-Delay Line Canceler frequency response:
The signal from a target at range Ro at the output of phase
detector is V1 =Vo sin(2nfdt—
@o)
where, fd = Doppler frequency shift = 2vr/ A or /Tp
©0 = constant Phase shift = 4TTRo/A (Range at time
= 0) Vo = Amplitude of the signal
V2 = Vo sin(2nfd(t - Tp) -
0) Where, Tp = Pulse Repetition Interval
Delay Line Cancelation: V=V1-V2
The amplitude response of two cascaded delay line canceller hence derived to be:
H(f) =4 sin?(@efd Tp)
Here,
Symbol ~__ Description
oe fd i Doppler frequency shift
‘Vo L ‘Amplitude of signal
pai _ Pulse Repetition Period
Saeaves ~__Delay Line Canceler output _|
L H ‘Amplitude Responsehh’ he ee eee ee a
eh
}
|
LABcode and Results:
scl
249600 of periods
ee 0.00001;
_ -0.01:fofrl
fal 2 pi.* Soft:
40% ((sin(arg)).*2);
nperesp. Po Psp, 8):
‘Amplitude response - Volts’)
as 30. * log (resp2+eps);
ee = 30. .* log] 0(resp*eps);
‘eubplot(2.1,2)
plowfofrrespl. ke 'fofrsresp2, ke);
legend (‘single canceler’, ‘double anceler’)
abel (Normalized frequency fifr’)
yabe(‘Amplitude response - dB’)
° os 1 15 2 25 3 3.8 4
single canceler’,;double canceler
: os 1 16 2 25 3 36 «
Normalized frequency t/tr
Ri
gure 8.1 Frequency response of a double tap DLC compared with that of single DLCExperiment 10
opiective: oe
i nderstand and analyse the radiation pattern of linear array antenna
qmare Required:
so
scILAB
pescription®
Figure 10.1 Linear array of equally spaced elements.
The far field array normalized intensity pattern is then given by
‘sievyy| = 2, [alin (kel siny)/2)
HEaCsinw)| = ay TS CCkdsimy)/2)iaw)l2
(sow) = |E,(siny)|
Symbol
y
N
k
d
cit aB Code and Results:
glearal
gel%da hi
jum =sin((nelements
ifabs(num) <= eps)
tum =epSi
ead ;
den= sin((k* d * 0.5) .* vars
iflabs(den) <= eps)
end
pattern = abs(num / den);
maxy. jax(pattern);
pattern = pattern / maxval;
figure(1)
plot(var,pattern)
xlabel('sine angle- dimension!
ylabel('Array pattern’)
id
figure(2)
plot(var,20*log 10(pattern))
axis ([-1 1 -60 0))
less')
Mlabel(‘sine angle - dimensionless’)
ylabel(‘Power pattern [dB]')
Figure(3)
theta = theta +pi/2;
Polar(theta,pattern)
tile (Array pattern’)
1
Nv (suman
| Description
Azimuthal angle(0< y< tt)
| Number of identical elements in linear
TN
clement spacing (normally measured in
wavelength units)
*k*d*0.5).* var);
sin ((Nkdsiny)/2)
;SEE erate teeta
Array pattern
Power pattern (dB)
basal 150
(oe
fis
| °
- 8
Vee
2 < ~ NY | 8
(|) %
ITP PCR CU FUE eaeOn fn nama
pn ng
¢ the sum and difference antenna pattern of monopulse radar
ver
ad and analys
ired:
gre RET
sol
cB
pesorintfOm?
Fe deol pram lapse oe . The sum
is used for both transmit and receive. In the receive mode the sum
dianne) Grovides the phase reference for the other two difference channels.
Range can also be obtained from the sum channel. In order to
row the sum and difference antenna pattems are formed, we will
assume & sing/® single element antenna pattern and squint angle @o- The
sssMsigoal in one coordinate (azimuth or elevation) is then given by
x(@) = sin(p—o) , Sin(® + Po)
a (@- Po) (® + Po)
rence patterns depend heavily on the squint angle. Using @
le produces a better sum pattern than that resulting from @
Clearly, the sum and diffe:
pe is steeper for the small squint
wlatively small squint angl
lager angle. Additionally, the difference pattern sloj
angle.
®o = 0.15
@o = 0.75~) SCILAB Code and Results:
phiO=0.15;
eps = 0.000001;
4 angle = -pi:0.01:pi;
yl = sinc(angle +
* phid)s y2=
4 sine((angle - phio));
e
6
6
ysum = yl + y2;
© dit=-y1
+ y2;
‘ figure (1)
4 plot
e langle L’kangle.y2,'k');
arid;
‘
' xlabel ‘Ang le -
rans) ylabel
" (Squinted Patterns")
figure (2)
Potente ysum, "k);
>
2Pog
aries
SS Be ydieyy,‘Angle =
ylabel
nce pattern’)
gids
Fae! (
yi
angle
sy esinetangle +
plot
Mingle doves, K's
grids
xlabel(‘Angle-
radians’) ylabel
(voltage gain’)
tpittere
He = -pi/a:0.01:pi/4;
1
|
|
|_ +]
2Angle - radians03)
04
r
05 |
oer
a
Angle - radians
o8
4
voltage gain
_o
02
a
on
-0.2 °
Angle - radians) EXPERIMENT +a
)
sp necharactersties of Gunn oscillator, Gun diode a modulated
ot source
EQUIRED:-
,
| pio, Gunn power Supply, PIN Modul
vent Mout, Wave guide stand, VSWR m
ye
lator, Isolator, Freq
wen 7
eter, Cables and icy meter, Variable Attenuator,
accessories,
go
disturbance atthe cathode gives rise to high Ree ee
field regi i anode.
When this high field domain reaches the dine evel towards the anode.
wards
{ anode, it dis in i
: jomed atthe cathode and starts moving to ob alacant
[on
PROCEDURE:
(1) Set the components and equipments as shown in block diagram.
2) Initially set the variable attenuator for minimum
| attenuation. (3)Keep the control knob of Gunn Power
—>
Supply as below:
Meter Switch - ‘OFF
Gunn bias knob - Fully anti-clockwise
Pin bias knob - Fully anti-clockwise
Pin Mod frequency - Anyposition
(4)Keep the control knob of VSWR meter
as below: Meter Switch-
Normal
Input Switch - Low Impedance
Range db Switch - — 40db :
Gain Control knob - Fully clockwise
<=P
the micrometer of Gunn oscillator for required frequency of
set
6 n. ,
oP era ON ! the Gunn Power Supply, VSWR meter and Cooling Fa!
wi
on CHARACTERISTIC
: (2)Measure
+h of Gunn power supply to voltage position
4 wan se cuet Corresponding tothe various voltages (3)Plot the voltage
| un reading on the graph
me vasure the threshold voltage, which corresponds to the graph.
(ayMeas
(0 |Voltage | Current
SULTS:- The values of voltage and current is measured and the graph is
'se fan to keep the Klystron temperature low.
“tasure tight connections of the apparatus 3.Avoid
‘ypoimections of the threads.
\se stabilized Power supply.EXPERIMENT 12
of Reflex Klystron tube & to determine its
charact eristics electronic
the
Ve
ge
A
ry$ REQUIRED:
a
Klystron power supply, Klystron mount, Isolator, Frequency Meter, Variable
gsr PE rector mount, Wave guide stand, Cooling fan, VSWR meter, Cables. and
ea
seers.
| eflex Klystron makes use of velocity modulation to transform continuous electron beam in
ete wave power. Electron Beam emitted is accelerated towards the anode cavity After
vie the gap in the cavity electron travel towards the repeller electrode which is at « high
eave potential (Vr ). The electron beam never reach the repeller because of the negative field
| sad retumed back towards the gap.The accelerated electrons leave the resonator at an
| iareased velocity and the retarded electrons leave at the reduced velocity. the electrons leaving
} teresonator will need different time to return, due to change in velocities, as a result, returning
* ekcrons group together in bunches. As the electron bunches pass through resonator, they
| nae with voltage at resonator grids. If the bunches pass the grid at such time that the
t teerons are slowed down by the voltage, energy will be delivered to the resonator; and
‘Ssten wll oscillate. The dimension of resonant cavity primarily determines the frequency. A
sual frequency change can be obtained by adjusting the reflector voltage. This is called
Eeeronic Tuning Range.
OCUOIAGRAM:-
I
|
Ti
wave
=
= ‘solator | 4! Frequen L4{ Variable L4! Detector|_9l VSWR
cy Attenua Mount Meter
=| Meter tormoo STUDY OF A KLYSTRON TUBE;
RE
1)Set the equipment as shown in fig.
(yinitially set the variable attenuator for
maximum position.
3) Keep the control knobs of Klystron Power
Supply as below:
Meter Switch - ‘OFF’
Mod Switch : AM
Beam voltage knob - Fully anti-clockwise
Reflector voltage + Fully anti-clockwise
‘AM- amplitude - Around fully clockwise
AM- frequency -Around mid position.
(4)Keep the control knob of VSWR meter as :
Meter Switch -Normal
Input Switch . Low
Impedance Range db Switch- 40 db
Gain Control knob - Mid position
(5)Switch‘ON’ the Klystron Power Supply, VS WR meterand Cooling Fan.
(6)Turn the meter switch of power supply to beam voltage position and
setbeam voltage at 300V with the help of beam voltage knob.
(7)Adjust the reflector voltage to get some deflection in VSWR meter.
(8)Maximize the deflection with AM amplitude and frequency control knob
of power supply.
(9) Tune the plunger of Klystron Mount for the max. Output.
(10) Rotate the knob of frequency meter slowly and stop
at that position, when there is ‘dip’ on VSWR meter.
Read directly the frequency meter between two
horizontal lines and vertical marker.
(il) Change the reflector voltage and read the frequency
for each reflector voltage and plot the graph .
OBSERVATIONS:-
[SNO_ [Repeller voltage | Frequency
L
AESULT.. Frequency and Repellervoltagecurveis drawmandisinaccordancewiththe
Stipulated curves ofKlystron.