summaryrefslogtreecommitdiff
path: root/3773/CH15
diff options
context:
space:
mode:
authorprashantsinalkar2017-10-10 12:27:19 +0530
committerprashantsinalkar2017-10-10 12:27:19 +0530
commit7f60ea012dd2524dae921a2a35adbf7ef21f2bb6 (patch)
treedbb9e3ddb5fc829e7c5c7e6be99b2c4ba356132c /3773/CH15
parentb1f5c3f8d6671b4331cef1dcebdf63b7a43a3a2b (diff)
downloadScilab-TBC-Uploads-7f60ea012dd2524dae921a2a35adbf7ef21f2bb6.tar.gz
Scilab-TBC-Uploads-7f60ea012dd2524dae921a2a35adbf7ef21f2bb6.tar.bz2
Scilab-TBC-Uploads-7f60ea012dd2524dae921a2a35adbf7ef21f2bb6.zip
initial commit / add all books
Diffstat (limited to '3773/CH15')
-rw-r--r--3773/CH15/EX15.1/Ex15_1.sce23
-rw-r--r--3773/CH15/EX15.10/Ex15_10.sce49
-rw-r--r--3773/CH15/EX15.11/Ex15_11.sce37
-rw-r--r--3773/CH15/EX15.12/Ex15_12.sce19
-rw-r--r--3773/CH15/EX15.2/Ex15_2.sce41
-rw-r--r--3773/CH15/EX15.3/Ex15_3.sce79
-rw-r--r--3773/CH15/EX15.4/Ex15_4.sce14
-rw-r--r--3773/CH15/EX15.5/Ex15_5.sce13
-rw-r--r--3773/CH15/EX15.6/Ex15_6.sce13
-rw-r--r--3773/CH15/EX15.7/Ex15_7.sce37
-rw-r--r--3773/CH15/EX15.8/Ex15_8.sce60
-rw-r--r--3773/CH15/EX15.9/Ex15_9.sce53
12 files changed, 438 insertions, 0 deletions
diff --git a/3773/CH15/EX15.1/Ex15_1.sce b/3773/CH15/EX15.1/Ex15_1.sce
new file mode 100644
index 000000000..505688201
--- /dev/null
+++ b/3773/CH15/EX15.1/Ex15_1.sce
@@ -0,0 +1,23 @@
+//Chapter 15: Antennas for Special Applications
+//Example 15-2.1
+clc;
+
+//Variable Initialization
+frequency = 100e3 //Frequency (Hz)
+height = 150 //Height of antenna(m)
+RL = 2 //Loss resistance (ohm)
+c = 3e8 //Speed of light (m/s)
+
+//Calculations
+wave_lt = c/frequency //Wavelength (m)
+hp = height/wave_lt //Antenna (physical) height (lambda)
+he = hp/2 //Effective height (lambda)
+
+Rr = 400*(hp**2) //Radiation resistance (ohm)
+
+R_E = Rr/(Rr+RL) //Radiation efficiency (unitless)
+
+//Results
+mprintf("The Effective height of the antenna is %.3f lambda", he)
+mprintf("\nThe Radiation resistance for 150m vertical radiator is %d ohm", Rr)
+mprintf("\nThe radiation efficiency is %.2f or %.2f percent", R_E,R_E*100)
diff --git a/3773/CH15/EX15.10/Ex15_10.sce b/3773/CH15/EX15.10/Ex15_10.sce
new file mode 100644
index 000000000..159ce003e
--- /dev/null
+++ b/3773/CH15/EX15.10/Ex15_10.sce
@@ -0,0 +1,49 @@
+//Chapter 15: Antennas for Special Applications
+//Example 15-20.3
+clc;
+
+//Variable Initialization
+f = 30e9 //Frequency (Hz)
+Tr = 300 //Receiver temperature (K)
+Ta = 275 //Satellite antenna temperature (K)
+r = 1400e3 //Height (m)
+c = 3e8 //Speed of light(m/s)
+bw = 9.6e3 //Bandwidth per channel (Hz)
+rcp_gain = 10 //RCP satellite gain (dBi)
+rain_att = 10 //Rain attenuation (dB)
+k = 1.4e-23 //Boltzmann's constant (J/K)
+snr = 10 //Required SNR (dB)
+ap_eff = 0.7 //Aperture efficiency (unitless)
+Ta_2 = 10 //Dish antenna temperature (K)
+
+//Calculations
+wave_lt = c/f //Wavelength (m)
+Ld = (wave_lt/(4*%pi*r))**2 //Spatial loss factor(unitless)
+Ld_db = 10*log10(Ld) //Spatial loss factor(dB)
+Tsys = Ta+Tr //System temperature (K)
+
+N = k*Tsys*bw //Propagation loss due to rain (W)
+N = 10*log10(N) //Propagation loss due to rain (dB)
+
+Dr = -rcp_gain + snr - Ld_db + N + rain_att //Antenna gain (dB)
+Dr = 10**(Dr/10) //Antenna gain (unitless)
+
+Dr_req = Dr/ap_eff //Required antenna gain (unitless)
+Dr_req_db = 10*log10(Dr_req) //Required antenna gain (dB)
+
+dish_dia = 2*wave_lt*sqrt(Dr_req/28) //Required diameter of dish (m)
+
+hpbw = sqrt(40000/Dr_req) //Half power beam width (degrees)
+
+Tsys2 = Ta_2 + Tr //System temperature(K)
+N2 = k*Tsys2*bw //Propagation loss due to rain(W)
+N2 = 10*log10(N2) //Propagation loss due to rain(dB)
+
+Pt_db = snr - Dr_req_db - rcp_gain + N2 - Ld_db + rain_att //Transmitted power (dB)
+Pt = 10**(Pt_db/10)
+
+//Results
+mprintf("The Uplink antenna gain required is %d dB",Dr_req_db)
+mprintf("\nThe Required dish size %.3f m",dish_dia)
+mprintf("\nThe HPBW is %.1f degrees",hpbw)
+mprintf("\nThe Downlink satellite power required is %.3f W", Pt)
diff --git a/3773/CH15/EX15.11/Ex15_11.sce b/3773/CH15/EX15.11/Ex15_11.sce
new file mode 100644
index 000000000..9356a5643
--- /dev/null
+++ b/3773/CH15/EX15.11/Ex15_11.sce
@@ -0,0 +1,37 @@
+//Chapter 15: Antennas for Special Applications
+//Example 15-21.1
+clc;
+
+//Variable Initialization
+dia = 1000 //Diameter of asteroid (m)
+prc = 0.4 //Power reflection coefficient of asteroid (unitless)
+f = 4e9 //Frequency (Hz)
+P = 1e9 //Power (W)
+s = 20e3 //Asteroid speed (m/s)
+ast_dis = 0.4 //Distance of asteroid (AU)
+au = 1.5e11 //Astronomical Unit (m)
+c = 3e8 //Speed of light (m/s)
+k = 1.38e-23 //Boltzmann's constant (m^2 kg s^-2 K^-1)
+Tsys = 10 //System temperature (K)
+B = 1e6 //Bandwidth (Hz)
+snr = 10 //Signal to noise ratio (dB)
+eap = 0.75 //Aperture efficiency (unitless)
+
+sigma = prc*%pi*s**2 //Radar cross section (m^2)
+ast_dm = au*ast_dis //Astroid distance (m)
+lmda = c/f //Wavelength(m)
+
+d4 = (64*(lmda**2)*(ast_dm**4)*k*Tsys*B*snr)/((eap**2)*%pi*(sigma)*P)
+d = d4**(0.25) //Diameter of dish (m)
+
+delf = 2*s/lmda //Doppler shift (Hz)
+delt = 2*(ast_dm)/c //Time delay (s)
+
+timp = ast_dm/s //Time before impact (s)
+
+
+//Result
+mprintf("The diameter of the dish is %.0f m",d)
+mprintf("\nThe doppler shift is %.1f Hz",delf)
+mprintf("\nThe time delay for the radar signal is %d s", delt)
+mprintf("\nThe time before impact is %d s", timp)
diff --git a/3773/CH15/EX15.12/Ex15_12.sce b/3773/CH15/EX15.12/Ex15_12.sce
new file mode 100644
index 000000000..d19f679e3
--- /dev/null
+++ b/3773/CH15/EX15.12/Ex15_12.sce
@@ -0,0 +1,19 @@
+//Chapter 15: Antennas for Special Applications
+//Example 15-26.1
+clc;
+
+//Variable Initialization
+t1 = 0.3e-9 //Echo time off the top of pavement (s)
+t2 = 2.4e-9 //Echo time off bottom of pavement (s)
+t3 = 14.4e-9 //Echo time off bottom of water pocket (s)
+er_1 = 4 //Relative permittivity of pavement (unitless)
+er_2 = 81 //Relative permittivity of water pocket (unitless)
+c = 3e8 //Speed of light (m/s)
+
+//Calculations
+d1 = (t2-t1)*c/(2*sqrt(er_1))
+d2 = (t3-t2)*c/(2*sqrt(er_2))
+
+//Result
+mprintf("The thickness of pavement is %.2f m",d1)
+mprintf("\nThe thickness of water pocket is %.1f m",d2)
diff --git a/3773/CH15/EX15.2/Ex15_2.sce b/3773/CH15/EX15.2/Ex15_2.sce
new file mode 100644
index 000000000..78686640d
--- /dev/null
+++ b/3773/CH15/EX15.2/Ex15_2.sce
@@ -0,0 +1,41 @@
+//Chapter 15: Antennas for Special Applications
+//Example 15-4.1
+clc;
+
+//Variable Initialization
+eps_r1 = 16 //Real part of relative permittivity of ground (unitless)
+sigma = 1e-2 //conductivity of ground (mho per meter)
+eps_0 = 8.85e-12 //Air permittivity (F/m)
+f1 = 1e6 //Frequency (Hz)
+f2 = 100e6 //Frequency (Hz)
+
+//Calculation
+eps_r11 = sigma/(2*%pi*f1*eps_0) //Loss part of relative permittivity for f1 (unitless)
+eps_r11_2 = sigma/(2*%pi*f2*eps_0) //Loss part of relative permittivity for f2 (unitless)
+
+eps_ra = eps_r1 -(%i)*eps_r11 //Relative permittivity for f1 (unitless)
+eps_rb = eps_r1 -(%i)*eps_r11_2 //Relative permittivity for f2 (unitless)
+
+n1 = sqrt(eps_ra) //Refractive index for f1 (unitless)
+n2 = sqrt(eps_rb) //Refractive index for f2 (unitless)
+
+E_perp1t=[]
+E_perp2t=[]
+
+for i=0:%pi/180:%pi/2
+E_perp1 = [1 + (abs((sin(i) - n1)/(sin(i)+n1))*exp(%i*(2*%pi*sin(i) + ((sin(i) - n1)/(sin(i)+n1)))))]
+E_perp2 = [1 + (abs((sin(i) - n2)/(sin(i)+n2))*exp(%i*(2*%pi*sin(i) + ((sin(i) - n2)/(sin(i)+n2)))))]
+E_perp1t($+1)=E_perp1
+E_perp2t($+1)=E_perp2
+end
+
+E_perp1_rel = E_perp1/(E_perp1t) //Relative electric field for f1 (unitless)
+
+E_perp2_rel = E_perp2/(E_perp2t) //Relative electric field for f2 (unitless)
+
+
+//Result
+mprintf("The loss parameter for 1MHz is %.0f", eps_r11)
+mprintf("\nThe loss parameter for 100MHz is %.1f", eps_r11_2)
+mprintf("\nThe relative permittivity for 1MHz is (%d%.0fj)", eps_ra,imag(eps_ra))
+mprintf("\nThe relative permittivity for 100MHz is (%d%.1fj)", eps_rb,imag(eps_rb))
diff --git a/3773/CH15/EX15.3/Ex15_3.sce b/3773/CH15/EX15.3/Ex15_3.sce
new file mode 100644
index 000000000..9cf97010a
--- /dev/null
+++ b/3773/CH15/EX15.3/Ex15_3.sce
@@ -0,0 +1,79 @@
+//Chapter 15: Antennas for Special Applications
+//Example 15-12.1
+clc;
+
+//Variable Initialization
+f = 60e6 //Frequency(Hz)
+dep = 20 //Depth of antenna location (m)
+sigma = 1.33e-2 //Conductivity (mho per m)
+eps0 = 8.85e-12 //Air Permittivity (F/m)
+epr1 = 80 //Real part of relative permittivity (unitless)
+alphat = 10 //Elevation angle (degrees)
+cl = 1 //Circumference (lambda)
+%pitch = 12.5 //%pitch angle (degrees)
+c = 3e8 //Speed of light (m/s)
+
+dir_gb = 3 //Directivity of George Brown turnstile (unitless)
+Aer_gb = 6 //Effective aperture of George Brown turnstile (unitless)
+r = 1e3 //Distance between transmitter and receiver (m)
+Pt = 100 //Transmitted power (W)
+
+//Calculations
+epr11 = sigma/(eps0*2*%pi*f) //Loss term of relative permittivity (unitless)
+epr = epr1 + %i*epr11 //Relative permittivity (unitless)
+alphac = acos(sqrt(1/epr1)) //Critical angle (degrees)
+alpha = acos(cos((alphat)*%pi/180)/sqrt(epr1)) //Angle of incidence (degrees)
+
+n1=12 //Number of turns
+rad = cl/(2*%pi) //Radius of loop (lambda)
+sl = tan((12.5)*%pi/180)
+hpbw1 = 52/(cl*sqrt(n1*sl)) //Half power beamwidth for 12 turns(degrees)
+dir1 = 12*(cl**2)*n1*sl //Directivity for 12 turns (unitless)
+n2 = n1*2 //Number of turns
+hpbw2 = 52/(cl*sqrt(n2*sl)) //Half power beamwidth for 24 turns(degrees)
+dir2 = 12*(cl**2)*n2*sl //Directivity for 24 turns (unitless)
+num = 20 //Number of turns chosen
+
+p_perpt=[]
+p_pallt=[]
+for i=0:%pi/180:%pi
+p_perp = [(sin(i)-sqrt(epr - cos(i)**2))/(sin(i)+sqrt(epr - cos(i)**2))]
+p_pall = [(epr*sin(i)-sqrt(epr - cos(i)**2))/(epr*sin(i)+sqrt(epr - cos(i)**2))]
+p_perpt($+1)=p_perp
+p_pallt($+1)=p_pall
+end
+
+Sr = 0.5*((p_perpt)**2 + (p_pallt)**2) //Relative power density reflected (unitless)
+St = 1 - Sr //Relative power density transmitted (unitless)
+
+theta = 0:%pi/180:%pi
+
+subplot(1,2,1)
+plot(theta,St)
+title("Relative Power Vs Elevation Angle")
+
+subplot(1,2,2)
+polarplot(theta,real(St))
+title("Pattern of Transmission")
+
+wave_lt = c/f //Wavelength (m)
+diam = wave_lt/(sqrt(epr1)*%pi) //Submerged helix diameter (m)
+att_cons = (%pi*epr11)/(wave_lt*sqrt(epr1)) //Attenuation constant for water (Np/m)
+att_d = 20*log10(exp(-att_cons*dep)) //Attenuation in the water path (dB)
+Dir = 12*(cl**2)*num*sl //Directivity for 20 turn helix (unitless)
+Ae = Dir*(wave_lt**2)/(4*%pi) //Effective aperture (m^2)
+
+Pr = Pt*Ae*dir_gb/((r**2)*(wave_lt**2)) //Received power(W)
+
+loss_inter = 10*log10(St(10)) //Loss at the interface for alpha = 83.68 (dB)
+tot_loss = abs(att_d + loss_inter) //Total loss (dB)
+Pr_act = Pr/(10**(ceil(tot_loss)/10)) //Net Actual received power (W)
+
+
+//Results
+mprintf("Half power beamwidth for 12 turns is %.0f degrees",hpbw1)
+mprintf("\nDirectivity for 12 turns is %.1f", dir1)
+mprintf("\nHalf power beamwidth for 24 turns is %.0f degrees",hpbw2)
+mprintf("\nDirectivity for 24 turns is %.1f", dir2)
+mprintf("\nA helix of %d turns is chosen for reasonable compromise",num)
+mprintf("\nThe signal level at the distance of 1km is %.2e W",Pr_act)
diff --git a/3773/CH15/EX15.4/Ex15_4.sce b/3773/CH15/EX15.4/Ex15_4.sce
new file mode 100644
index 000000000..e806a6e7a
--- /dev/null
+++ b/3773/CH15/EX15.4/Ex15_4.sce
@@ -0,0 +1,14 @@
+//Chapter 15: Antennas for Special Applications
+//Example 15-13.1
+clc;
+
+//Variable Initialization
+fre = 3e9 //Frequency (Hz)
+Re_Zc = 14.4e-3 //Real part of intrinsic impedance of copper (ohm)
+Zd = 377 //Intrinsic impedance of air (ohm)
+
+//Calculation
+tau = atan(Re_Zc/Zd)*180/%pi //Tilt angle (degrees)
+
+//Result
+mprintf("The tilt angle is %.4f degrees",tau)
diff --git a/3773/CH15/EX15.5/Ex15_5.sce b/3773/CH15/EX15.5/Ex15_5.sce
new file mode 100644
index 000000000..c8eefd833
--- /dev/null
+++ b/3773/CH15/EX15.5/Ex15_5.sce
@@ -0,0 +1,13 @@
+//Chapter 15: Antennas for Special Applications
+//Example 15-13.2
+clc;
+
+//Variable Initialization
+fre = 3e9 //Frequency (Hz)
+eps_r = 80 //Relative permittivity of water (unitless)
+
+//Calculation
+tau = atan(1/sqrt(eps_r))*180/%pi //Forward Tilt angle (degrees)
+
+//Result
+mprintf("The forward tilt angle is %.1f degrees",tau)
diff --git a/3773/CH15/EX15.6/Ex15_6.sce b/3773/CH15/EX15.6/Ex15_6.sce
new file mode 100644
index 000000000..599d34322
--- /dev/null
+++ b/3773/CH15/EX15.6/Ex15_6.sce
@@ -0,0 +1,13 @@
+//Chapter 15: Antennas for Special Applications
+//Example 15-13.3
+clc;
+
+//Variable Initialization
+lambda_g = 1.5 //Wavelength in guide (lambda)
+m = -1 //Mode number
+
+//Calculation
+phi = acos((1/lambda_g)+m)*180/%pi //Forward tilt angle (degrees)
+
+//Result
+mprintf("The beam angle is %.1f degrees",phi)
diff --git a/3773/CH15/EX15.7/Ex15_7.sce b/3773/CH15/EX15.7/Ex15_7.sce
new file mode 100644
index 000000000..ef436f8f7
--- /dev/null
+++ b/3773/CH15/EX15.7/Ex15_7.sce
@@ -0,0 +1,37 @@
+//Chapter 15: Antennas for Special Applications
+//Example 15-14.1
+clc;
+
+//Variable Initialization
+fre = 4e9 //Frequency (Hz)
+T_sys = 100 //System Temperature (K)
+S_N = 20 //Signal to Noise ratio (dB)
+bandwidth = 30e6 //Bandwidth (Hz)
+P_trans = 5 //Satellite transponder power (W)
+dia = 2 //Satellite parabolic dish diameter (m)
+sat_spacing = 2 //Spacing between satellites (degrees)
+r = 36000e3 //Downlink distance (m)
+k = 1.38e-23 //Boltzmann's constant (J/K)
+c = 3e8 //Speed of light (m/s)
+
+//Calculation
+wave_lt = c/fre
+s_n = (wave_lt**2)/(16*(%pi**2)*(r**2)*k*T_sys*bandwidth)
+s_n = 10*log10(s_n) //Signal to noise ratio for isotropic antennas (dB)
+
+Ae = 0.5*%pi*(dia**2)/4 //Effective Aperture (m^2)
+Gs = 4*%pi*Ae/(wave_lt**2)
+Gs = 10*log10(Gs) //Antenna Gain (dB)
+
+Ge = 20 - s_n - Gs - 10*log10(P_trans) //Required earth station antenna gain(dB)
+Ae_e = (10**(Ge/10))*(wave_lt**2)/(4*%pi) //Required earth station effective aperture (m^2)
+Ap = Ae_e*2 //Required Physical aperture (m^2)
+
+De = 2*sqrt(Ap/%pi) //Required diameter of earth-station antenna(m)
+hpbw = 65/(De/wave_lt) //Half power beam width (degree)
+bwfn = 145/(De/wave_lt) //Beamwidth between first null (degree)
+
+//Results
+mprintf("The Required parabolic dish diameter of earth station antenna is %.1f m",De)
+mprintf("\nThe Half power beamwidth is %.1f degrees",hpbw)
+mprintf("\nThe Beamwidth between first null is %.1f",bwfn)
diff --git a/3773/CH15/EX15.8/Ex15_8.sce b/3773/CH15/EX15.8/Ex15_8.sce
new file mode 100644
index 000000000..a6e4c53cf
--- /dev/null
+++ b/3773/CH15/EX15.8/Ex15_8.sce
@@ -0,0 +1,60 @@
+//Chapter 15: Antennas for Special Applications
+//Example 15-20.1
+clc;
+
+//Variable Initialization
+Tr = 45 //Satellite receiver temperature (K)
+rcp_gain = 6 //Right circularly polarized antenna gain (dBi)
+rcp_quad_gain = 3 //RCP gain of quadrifilar helix antenna (dBi)
+bandwidth = 9.6e3 //Bandwidth (Hz)
+snr = 10 //Required Signal-to-Noise ratio (dB)
+c = 3e8 //Speed of light (m/s)
+f = 1.65e9 //Frequency (Hz)
+r = 780e3 //Distance to the satellite (m)
+Ta = 300 //Antenna temperature (K)
+k = 1.4e-23 //Boltzmann's constant (J/K)
+theta = 10 //Zenith angle (degree)
+Tr_handheld = 75 //Hand held receiver temperature (K)
+Tsky = 6 //Sky Temperature (K)
+theta_horz = 80 //Zenith angle for horizontal dipole (degree)
+
+//Calculations
+wave_lt = c/f //Wavelength (m)
+Ld = (wave_lt/(4*%pi*r))**2 //Spatial loss factor(unitless)
+Ld_db = 10*log10(Ld) //Spatial loss factor(dB)
+Tsys_up = Ta + Tr //Satellite system temperature (K)
+N = k*Tsys_up*bandwidth //Noise power(W)
+N_db = 10*log10(N) //Noise power (dB)
+E_vert = cos(%pi*cos(theta*%pi/180)/2)/sin(theta*%pi/180) //Pattern factor for vertical lambda/2 dipole (unitless)
+E_vert_db = 20*log10(E_vert)
+Pt_vert_up = snr - (2.15 + (E_vert_db) - 3) - rcp_gain + ceil(N_db) - floor(Ld_db) //Uplink power for vertical lambda/2 antenna (dB)
+Pt_vert_up = 10**(Pt_vert_up/10) //Uplink power for vertical lambda/2 antenna (W)
+Ta_down = 0.5*(Ta)+0.5*(Tsky)+3 //Downlink antenna temperature (K)
+Tsys_down = Ta_down + Tr_handheld //System temperature(K)
+N_down = k*Tsys_down*bandwidth //Noise power (W)
+N_down_db = 10*log10(N_down) //Noise power (dB)
+Pt_vert_down = snr -(2.15+ (E_vert_db) - 3) - rcp_gain + ceil(N_down_db) - floor(Ld_db) //Downlink power for vertical lambda/2 antenna (dB)
+Pt_vert_down = 10**(Pt_vert_down/10) //Downlink power for vertical lambda/2 antenna (W)
+E_horz = cos(%pi*cos(theta_horz*%pi/180)/2)/sin(theta_horz*%pi/180) //Pattern factor for horizontal lambda/2 dipole (unitless)
+E_horz_db = (20*log10(E_horz))
+Pt_horz_up = snr -(2.15 + E_horz_db - 3) - rcp_gain + round(N_db) - round(Ld_db) //Uplink power for horizonal lambda/2 dipole (dB)
+Pt_horz_up = 10**(Pt_horz_up/10) //Uplink power for horizonal lambda/2 dipole (W)
+Pt_horz_down = snr -(2.15 + E_horz_db - 3) - rcp_gain + round(N_down_db) - round(Ld_db) //Downlink power for horizonal lambda/2 dipole (dB)
+Pt_horz_down = 10**(Pt_horz_down/10) //Downlink power for horizonal lambda/2 dipole (W)
+Pt_quad_up = snr -(rcp_quad_gain + E_horz_db) - rcp_gain + round(N_db) - round(Ld_db) //Uplink power for RCP quadrifilar helix antenna (dB)
+Pt_quad_up = 10**(Pt_quad_up/10) //Uplink power for RCP quadrifilar helix antenna (W)
+Ta_quad = 0.85*(Tsky) + 0.15*(Ta) //Downlink antenna temperature (K)
+Tsys_quad = Ta_quad + Tr_handheld //System temperature(K)
+N_quad = k*Tsys_quad*bandwidth //Noise power (W)
+N_quad_db = 10*log10(N_quad) //Noise power (dB)
+Pt_quad_down = snr -(rcp_quad_gain + E_horz_db) - rcp_gain + round(N_quad_db) - round(Ld_db) //Downlink power for RCP quadrifilar helix antenna (dB)
+Pt_quad_down = 10**(Pt_quad_down/10) //Downlink power for RCP quadrifilar helix antenna (W)
+
+
+//Results
+mprintf("The Uplink power for vertical lambda/2 dipole is %.1f W",Pt_vert_up)
+mprintf("\nThe Uplink power for horizontal lambda/2 dipole is %.3f W",Pt_horz_up)
+mprintf("\nThe Uplink power for RCP quadrifilar helix antenna is %.3f W",Pt_quad_up)
+mprintf("\nThe Downlink power for vertical lambda/2 dipole is %.1f W",Pt_vert_down)
+mprintf("\nThe Downlink power for horizontal lambda/2 dipole is %.3f W",Pt_horz_down)
+mprintf("\nThe Downlink power for RCP quadrifilar helix antenna is %.3f W",Pt_quad_down)
diff --git a/3773/CH15/EX15.9/Ex15_9.sce b/3773/CH15/EX15.9/Ex15_9.sce
new file mode 100644
index 000000000..102b382ce
--- /dev/null
+++ b/3773/CH15/EX15.9/Ex15_9.sce
@@ -0,0 +1,53 @@
+//Chapter 15: Antennas for Special Applications
+//Example 15-20.2
+clc;
+
+//Variable Initialization
+f = 1.6e9 //Frequency (Hz)
+r = 1400e3 //Height (m)
+r_sep = 3500e3 //Height for 10 degree seperation (m)
+c = 3e8 //Speed of light(m/s)
+Ta = 300 //Satellite antenna temperature (K)
+Tr = 45 //Satellite receiver temperature (K)
+k = 1.3e-23 //Boltzmann's constant (J/K)
+bandwidth = 9.6e3 //Bandwidth (Hz)
+snr = 6 //Signal to noise ratio (dB)
+rcp_gain = 3 //Helix gain(dB)
+beam_angle = 25 //RCP spot beam (degree)
+Tsky = 6 //Sky Temperature (K)
+Tr_handheld = 75 //Hand held receiver temperature (K)
+
+
+//Calculations
+wave_lt = c/f //Wavelength (m)
+Ld = (wave_lt/(4*%pi*r))**2
+Ld = 10*log10(Ld) //Propagation loss factor (dB)
+sat_gain = 40000/(beam_angle**2)
+sat_gain = 10*log10(sat_gain) //Satellite gain (dB)
+
+Tsys = Ta+Tr //System temperature (K)
+N = k*Tsys*bandwidth //Noise power (W)
+N_db = 10*log10(N) //Noise power (dB)
+
+Pt_up = snr - (rcp_gain) - (sat_gain) + N_db - Ld //Uplink power (dB)
+Pt_up = 10**(Pt_up/10) //Uplink power (W)
+
+Ta_quad = 0.85*(Tsky) + 0.15*(Ta) //Downlink antenna temperature (K)
+Tsys_quad = Ta_quad + Tr_handheld //System temperature(K)
+N_quad = k*Tsys_quad*bandwidth //Noise power (W)
+N_quad_db = 10*log10(N_quad) //Noise power (dB)
+
+Pt_down = snr - (rcp_gain) - (sat_gain) + round(N_quad_db) - round(Ld) //Downlink power (dB)
+Pt_down = 10**(Pt_down/10) //Downlink power (W)
+
+Ld_sep = (wave_lt/(4*%pi*r_sep))**2
+Ld_sep = 10*log10(Ld_sep) //Propagation loss factor(dB)
+
+Pt_sep = snr - (rcp_gain) - sat_gain + ceil(N_db) - round(Ld_sep) //Uplink power (dB)
+Pt_sep = 10**(Pt_sep/10) //Uplink power (W)
+
+//Results
+mprintf( "The Satellite gain is %.1f dB",sat_gain)
+mprintf( "\nThe Uplink power required is %.3f W", Pt_up)
+mprintf( "\nThe Downlink power required is %.4f W",Pt_down)
+mprintf( "\nThe Uplink power required for 10 deg. from horizon is %.3f W",Pt_sep)