diff options
Diffstat (limited to 'Microwave_Engineering_by_G_S_N_Raju')
8 files changed, 3119 insertions, 0 deletions
diff --git a/Microwave_Engineering_by_G_S_N_Raju/1-INTRODUCTION_TO_MICROWAVE_AND_THEIR_APPLICATIONS.ipynb b/Microwave_Engineering_by_G_S_N_Raju/1-INTRODUCTION_TO_MICROWAVE_AND_THEIR_APPLICATIONS.ipynb new file mode 100644 index 0000000..6caaf07 --- /dev/null +++ b/Microwave_Engineering_by_G_S_N_Raju/1-INTRODUCTION_TO_MICROWAVE_AND_THEIR_APPLICATIONS.ipynb @@ -0,0 +1,420 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 1: INTRODUCTION TO MICROWAVE AND THEIR APPLICATIONS" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.10: direction_of_power_flow_of_microwave.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//FIND THE DIRECTION OF POWER FLOW OF MICROWAVE\n", +"//given\n", +"clc\n", +"function w=cross_prod(E,F)//function to determine the cross product of two vectors\n", +"D=[E(:),F(:)]\n", +"w(1)=det([[1;0;0],D])\n", +"w(2)=det([[0;1;0],D])\n", +"w(3)=det([[0;0;1],D])\n", +"endfunction\n", +"E=[0 1 0]\n", +"F=[1 0 0]\n", +"q=cross_prod(E,F)\n", +"disp(q','the cross product of the given fields')//towards az\n", +"//ERROR in book as cross product of two perpendicular vector gives the third" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.11: pointing_vector_and_direction_of_power_flow_of_microwave.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//find pointing vector and direction of power flow of microwave\n", +"//given\n", +"clc\n", +"function w=cross_prod(E,H)//function to determine the cross product of two vector\n", +"D=[E(:),H(:)]\n", +"w(1)=det([[1;0;0],D])\n", +"w(2)=det([[0;1;0],D])\n", +"w(3)=det([[0;0;1],D])\n", +"endfunction\n", +"E=1*[1 0 0]//electric field towards ax\n", +"H=2*[0 1 0]//magnetic field towards ay\n", +"q=cross_prod(E,H)\n", +"disp(q','the display is along az axis')//along az\n", +"//ERROR in the book as cross product of two perpendicular vector is the third vector" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.12: frequency_of_the_wave.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//find the frequency of the wave\n", +"//given\n", +"clc\n", +"t1=100d-12\n", +"t2=500d-12\n", +"t3=1d-9\n", +"f1=t1^-1\n", +"f2=t2^-1\n", +"f3=t3^-1\n", +"disp(f3*1D-9,f2*1D-9,f1*1D-9,'the frequencies respectively')//in GHz" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.13: velocity_of_propogation_of_microwave.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//determine the velocity of propogation of microwave\n", +"//given\n", +"clc\n", +"ur=1//permeability in H/m\n", +"epsilonr=4//permittivity in F/m\n", +"k=3d+8//the speed of light in vaccum \n", +"v=k/((ur*epsilonr)^1/2)//velocity of microwave\n", +"disp(v,'the velocity of propogation of microwave in m/s:')//velocity in m/s" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.14: wavelength_of_microwave_frequency.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//find the wavelength of microwave frequency\n", +"//given\n", +"clc\n", +"v0=3d+8//velocity in m/s\n", +"function[lem]=wavelength(v0,fr)\n", +"lem=v0/fr//calculating wavelength\n", +"endfunction\n", +"fr=1d+6//frequency in MHz\n", +"[lem1]=wavelength(v0,fr)\n", +"fr=1d+7//frequency in MHz\n", +"[lem2]=wavelength(v0,fr)\n", +"fr=1d+8//frequency in MHz\n", +"[lem3]=wavelength(v0,fr)\n", +"fr=1d+9//frequency in MHz\n", +"[lem4]=wavelength(v0,fr)\n", +"fr=1d+10//frequency in MHz\n", +"[lem5]=wavelength(v0,fr)\n", +"disp(lem5,lem4,lem3,lem2,lem1,'the wavelength for given values of frequency in meter')//wavelength in meter" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.15: phase_shift_of_the_wave.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//find the phase shift of the wave\n", +"//given\n", +"f=1d+9//Hz\n", +"v0=3d+8//m/s\n", +"lem=v0/f//calculating wavelength\n", +"b=2*%pi/lem//calculating phase shift\n", +"b=round(b*100)/100///rounding off decimals\n", +"disp(b,lem,'the wavelength and phase shift respectively')//in rad/m and m" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.1: electric_field_its_magnitude_and_direction.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//calculate the electric field,its magnitude and direction.\n", +"//given\n", +"F=[2 1 1]//force vector in newton\n", +"Q=1//charge in columbs\n", +"E=F/Q//the electric field\n", +"//the magnitude of this field is given by:\n", +"e=norm(E)\n", +"//THE direction of the electric field is given by:\n", +"aE=E/e\n", +"e=round(e*1000)/1000//rounding off decimals\n", +"aE=round(aE*1000)/1000//rounding off decimals\n", +"disp(E,'the electric field is given by:' )//N/C\n", +"disp(e,'the magnitude of the electric field E:')//V/m\n", +"disp(aE,'THE direction of the electric field in x,y,z axis respectively :')\n", +"\n", +"\n", +"" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.2: electric_field_at_a_point.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//determine the electric field at a point;\n", +"//given\n", +"clc\n", +"Qf=2d-6\n", +"Qt=1d-6\n", +"rf=[1 0 0]//this can also be written as ax\n", +"rt=[0 1 0]//this can also be written as ay\n", +"rtf=rt-rf\n", +"Rtf=norm(rtf)//this is the magnitude of the vector\n", +"atf=rtf/Rtf//the unit vector across the two points p1 and p2\n", +"//the electric field at the point p2 is given by:\n", +"epsilon0=8.85D-12//value may differ, as i have not used the estimated value\n", +"E=((Qf*Qt)/(4*%pi*epsilon0*(Rtf)^2))*atf//electric field calculation\n", +"E=round(E*1d+6)/1d+6///rounding off decimals\n", +"disp(E*1d+3,'the electric field of p2 is:')//mN/C" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.3: TOTAL_FIELD_AT_A_POINT_P_DUE_TO_ALL_THE_THREE_CHARGES.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//DETERMINE TOTAL FIELD AT A POINT ,P DUE TO ALL THE THREE CHARGES.\n", +"//given\n", +"clc\n", +"E1=[1 2 -1]//at p due to 1uc\n", +"E2=[0 1 3]//due to 2uc\n", +"E3=[2 -1 0]//due to 3uc\n", +"//total field at p due to all these three charges is given by:\n", +"E=E1+E2+E3//resultant of all the three charges\n", +"disp(E,'the fiel at point p due to all the charges')//N/C" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.4: charge_Q_at_the_point_2_0_0.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//determine the charge Q at the point (2,0,0).\n", +"//given\n", +"clc\n", +"Q1=-10D-9//coulombs\n", +"epsilon0=8.85d-12//permitivity of free space\n", +"r1=[3 1 1]-[0 0 0]\n", +"r2=[3 1 1]-[2 0 0]\n", +"R1=norm(r1)//magnitude of the given vector r1\n", +"R2=norm(r2)//magnitude of vector r2\n", +"ar1=r1/R1//unit vector\n", +"ar2=r2/R2//unit vector\n", +"deff('[Qt]=electricfield(E)','Qt=((E-((Q1/(4*%pi*epsilon0*R1^2))*ar1(1,1)))/ar2(1,1))*(4*%pi*epsilon0*R2^2)')\n", +"Qt=electricfield(0)//in coulombs\n", +"Qt=round(Qt*1d+11)/1d+11///rounding off decimals\n", +"disp(Qt/1d-9,'the electrical field at the point [2,0,0] in nC')//nC" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.5: electric_field_at_Q1.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//the electric field at Q1 needed to be determined.\n", +"//given\n", +"clc\n", +"Q1=1d-9//at (-1,1,-3)\n", +"Q2=5d-9//at (3,1,0)\n", +"epsilon0=8.85D-12//the values may differ as i have used the exact value of permitivity\n", +"R=[-1 1 -3]-[3 1 0]//\n", +"r=norm(R)//magnitude of the vector r\n", +"ar=R/r//unit vector\n", +"E=(Q1/(4*%pi*epsilon0*(r^2)))*ar\n", +"E=round(E*10000)/10000///rounding off decimals\n", +"disp(E,'THE electric field at Q1 is given as:')//both vectors are in ax and az directions respectively\n", +"//ERROR in the book" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.6: electric_field_at_location_of_3_coulombs.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//determine the electric field at location of 3 coulombs\n", +"//given\n", +"clc\n", +"fr=12d-3// N\n", +"Qt=3//C\n", +"E=fr/Qt//electric field\n", +"disp(E*1000,'the electricfield at 3c')//mN/C" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.7: magnetic_field_at_distance_of_2m_in_free_space.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//find the magnetic field at distance of 2m in free space\n", +"//given\n", +"clc\n", +"fr=3d-3//IN Newtons\n", +"mt=2//meters\n", +"H=fr/mt//magnetic field\n", +"disp(H*1d+3,'THE magnetic field:')//mN/Wb" + ] + } +], +"metadata": { + "kernelspec": { + "display_name": "Scilab", + "language": "scilab", + "name": "scilab" + }, + "language_info": { + "file_extension": ".sce", + "help_links": [ + { + "text": "MetaKernel Magics", + "url": "https://github.com/calysto/metakernel/blob/master/metakernel/magics/README.md" + } + ], + "mimetype": "text/x-octave", + "name": "scilab", + "version": "0.7.1" + } + }, + "nbformat": 4, + "nbformat_minor": 0 +} diff --git a/Microwave_Engineering_by_G_S_N_Raju/2-MICROWAVE_TUBES_FOR_MICROWAVE_SIGNAL_GENERATION.ipynb b/Microwave_Engineering_by_G_S_N_Raju/2-MICROWAVE_TUBES_FOR_MICROWAVE_SIGNAL_GENERATION.ipynb new file mode 100644 index 0000000..fb082bf --- /dev/null +++ b/Microwave_Engineering_by_G_S_N_Raju/2-MICROWAVE_TUBES_FOR_MICROWAVE_SIGNAL_GENERATION.ipynb @@ -0,0 +1,182 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 2: MICROWAVE TUBES FOR MICROWAVE SIGNAL GENERATION" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.1: maximum_power_for_given_beam_current.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//maximum power\n", +"//GIVEN\n", +"I1=20D-3//current in ampere\n", +"Va=300//VOLTAGE of the beam in volts\n", +"n=1//given mode value\n", +"Prf=0.39861*I1*Va/(n+0.75)//the maximum output power\n", +"Prf=round(Prf*1000)/1000///rounding off decimals\n", +"disp(Prf,'the maximum r-f power when given beam current is 20mA in watts:')" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.2: gain_parameter_output_power_and_Be.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//gain parameter ,output power and Be\n", +"//given\n", +"clc\n", +"Vdc=2.5d+3//votage in volts\n", +"Idc=25d-3//current in ampere\n", +"Z0=10//resistance in ohm\n", +"L=40//CIRCUIT LENGTH\n", +"f=9.5d+9//in Hz\n", +"G=((Idc*Z0)/(4*Vdc))^(1/3)//the gain parameter\n", +"Ap=-9.54+47.3*L*G//OUTPUT power in dB\n", +"w=2*%pi*f\n", +"Ve=0.593d+6*sqrt(Vdc)\n", +"Be=w/Ve//in rad/m\n", +"Be=round(Be/10)*10///rounding off decimals\n", +"Ap=round(Ap*10)/10////rounding off decimals\n", +"G=round(G*10000)/10000////rounding off decimals\n", +"disp(Be,Ap,G,'the Be,the output power and the gain parameter')//dB,Rad/m" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.3: angular_frequency_and_the_cutoff_voltage.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//angular frequency and the cutoff voltage\n", +"//given\n", +"clc\n", +"Bm=0.4//magnetic flux in tesla\n", +"ebym=1.759d+11//electron to mass ratio\n", +"a=0.04//radius of cathode in meter\n", +"b=0.1//radius of vane edge from centre in meter\n", +"Wc=ebym*Bm//angular frequency in rad\n", +"Vc=((ebym/8)*(Bm^2)*((b/10)^2)*((1-((a/b)^2))^2))//ERROR cut off voltage in volts\n", +"disp(Vc,Wc,'THE the angular frequency and Cutoff voltage in radians and volts is given by:')// rad,volts\n", +"//EERROR in cutoff voltage as value of ((1-((a/b)^2))^2)=0.7056 instead of ((1-((a/b)^2))^2)=0.36" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.4: electron_velocity_transit_angle_and_beam_coupling_coefficent.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//electron velocity,transit angle and beam coupling coefficent\n", +"//given\n", +"Va=900// in volts\n", +"Rb=30d+3//in ohm\n", +"Ib=20d-3//in ampere\n", +"f=3.2d+9//in hertz\n", +"d=1d-3//meter\n", +"Ve=0.593d+6*sqrt(Va)//m/s\n", +"w=2*%pi*f\n", +"Qt=w*d/Ve//radians\n", +"Bc=(sin(Qt/2))/(Qt/2)\n", +"Qt=round(Qt*100)/100///rounding off decimals\n", +"Bc=round(Bc*1000)/1000///rounding off decimals\n", +"disp(Bc,Qt,Ve,'THE electron eloccity ,transit angle and beam coupling coefficient in m/s,radians')//m/s,radians." + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.5: efficency_of_kylstron.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//efficency of kylstron\n", +"//given\n", +"clc\n", +"I2=28d-3//ampere\n", +"V2=850//volts\n", +"Bc=0.496//beam coupling coefficent\n", +"Vd=900//volts\n", +"Ib=26d-3//ampere\n", +"n=(Bc*I2*V2)/(2*Ib*Vd)\n", +"disp(n*100,'the beam efficiency of kylstron in the percentage format')\n", +"//ERROR in calcultion of the book the value of Bc is different in question" + ] + } +], +"metadata": { + "kernelspec": { + "display_name": "Scilab", + "language": "scilab", + "name": "scilab" + }, + "language_info": { + "file_extension": ".sce", + "help_links": [ + { + "text": "MetaKernel Magics", + "url": "https://github.com/calysto/metakernel/blob/master/metakernel/magics/README.md" + } + ], + "mimetype": "text/x-octave", + "name": "scilab", + "version": "0.7.1" + } + }, + "nbformat": 4, + "nbformat_minor": 0 +} diff --git a/Microwave_Engineering_by_G_S_N_Raju/3-MICROWAVE_SEMICONDUCTOR_DEVICES.ipynb b/Microwave_Engineering_by_G_S_N_Raju/3-MICROWAVE_SEMICONDUCTOR_DEVICES.ipynb new file mode 100644 index 0000000..a756d0f --- /dev/null +++ b/Microwave_Engineering_by_G_S_N_Raju/3-MICROWAVE_SEMICONDUCTOR_DEVICES.ipynb @@ -0,0 +1,162 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 3: MICROWAVE SEMICONDUCTOR DEVICES" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 3.1: frequency_of_IMPATT_diode.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//frequency of IMPATT diode\n", +"//given\n", +"clc\n", +"Vd=2.2d+5//m/s\n", +"l=5d-6//meter\n", +"f=Vd/(2*l)//hertz\n", +"disp(f*1d-9,'THE required frequiency in GHz')//Ghz\n", +"" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 3.2: frequency_of_IMPATT_diode.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//frequency of IMPATT diode\n", +"//given\n", +"clc\n", +"Vd=3d+5//m/s\n", +"l=7d-6//meter\n", +"f=Vd/(2*l)//hertz\n", +"f=round(f*1d-8)/1d-8///rounding off decimals\n", +"disp(f*1d-9,'the required frequency of IMPATT diode in GHz')//GHz" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 3.3: avalanche_zone_velocity_of_TRAPATT_diode.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//avalanche zone velocity of TRAPATT diode\n", +"//given\n", +"clc\n", +"Na=1.8d+15//per cm3//doping concentration\n", +"j=25d+3//A/cm2//current density\n", +"q=1.6d-19//couloms\n", +"Vaz=j/(q*Na)//cms//avalanche zone velocity\n", +"Vaz=round(Vaz/1d+5)*1d+5///rounding off decimals\n", +"disp(Vaz/100,'the avalanche zone velocity of TRAPATT in m/s')//m/s" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 3.4: frequency_of_gunn_diode_oscillator.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//frequency of gunn diode oscillator\n", +"//given\n", +"clc\n", +"Vd=2d+8//m/s\n", +"l=12d-6//meter\n", +"f=Vd/l//hertz\n", +"disp(f*1d-9,'the required frequency in GHz')\n", +"//ERROR in the book\n", +"" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 3.5: minimum_voltage_to_operate.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//minimum voltage to operate\n", +"//given\n", +"clc\n", +"Vs=3.3d+3//VOLTS//the minimum voltage gradient required to start the diode\n", +"l=2.5d-6//meter//the drift length\n", +"Vmin=Vs*l//the minimum voltage required to operate\n", +"disp(Vmin*1000,'the minimum voltage required to operate in m/V')//mV//millivolts" + ] + } +], +"metadata": { + "kernelspec": { + "display_name": "Scilab", + "language": "scilab", + "name": "scilab" + }, + "language_info": { + "file_extension": ".sce", + "help_links": [ + { + "text": "MetaKernel Magics", + "url": "https://github.com/calysto/metakernel/blob/master/metakernel/magics/README.md" + } + ], + "mimetype": "text/x-octave", + "name": "scilab", + "version": "0.7.1" + } + }, + "nbformat": 4, + "nbformat_minor": 0 +} diff --git a/Microwave_Engineering_by_G_S_N_Raju/4-SCATTERING_MATRIX_PARAMETERS.ipynb b/Microwave_Engineering_by_G_S_N_Raju/4-SCATTERING_MATRIX_PARAMETERS.ipynb new file mode 100644 index 0000000..5c64b59 --- /dev/null +++ b/Microwave_Engineering_by_G_S_N_Raju/4-SCATTERING_MATRIX_PARAMETERS.ipynb @@ -0,0 +1,113 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 4: SCATTERING MATRIX PARAMETERS" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.3: voltage_standing_wave_ratio.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//voltage standing wave ratio\n", +"//given\n", +"clc\n", +"LEMg=4.82//cm\n", +"d1_d2=0.7//cm\n", +"VSWR=LEMg/(%pi*d1_d2)//VSWR\n", +"VSWR=round(VSWR*1000)/1000///rounding off decimals\n", +"disp(VSWR,'the voltage standing wave ratio:')" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.4: scattering_matrix_of_inductor.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//scattering matrix of inductor\n", +"//given\n", +"clc\n", +"IL=0.3//db//insertion loss\n", +"I=40//db//isolation\n", +"s21=(10^(-0.3/20))//-20log|s21|\n", +"s12=(10^(-40/20))//-20log|s12|\n", +"s11=0//FOR SCATTER MATRIX\n", +"s22=0//FOR SCATTER MATRIX\n", +"S=[s11,s12;s21,s22]\n", +"S=round(S*1000)/1000///rounding off decimals\n", +"disp(S,'THE matrix is S-matrix:')//all points are well matched" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.5: wave_guide_length.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//wave guide length\n", +"//given\n", +"clc\n", +"d1_d2=0.4//distance measured between twice minima\n", +"VSWR=2.5//voltage standing wave ratio\n", +"LEMg=VSWR*%pi*d1_d2//wave guide length\n", +"LEMg=round(LEMg*100)/100///rounding off decimals\n", +"disp(LEMg,'the wave guide length for given VSWR IN cm:')//cm" + ] + } +], +"metadata": { + "kernelspec": { + "display_name": "Scilab", + "language": "scilab", + "name": "scilab" + }, + "language_info": { + "file_extension": ".sce", + "help_links": [ + { + "text": "MetaKernel Magics", + "url": "https://github.com/calysto/metakernel/blob/master/metakernel/magics/README.md" + } + ], + "mimetype": "text/x-octave", + "name": "scilab", + "version": "0.7.1" + } + }, + "nbformat": 4, + "nbformat_minor": 0 +} diff --git a/Microwave_Engineering_by_G_S_N_Raju/5-MICROWAVE_PASSIVE_COMPONENTS_.ipynb b/Microwave_Engineering_by_G_S_N_Raju/5-MICROWAVE_PASSIVE_COMPONENTS_.ipynb new file mode 100644 index 0000000..61abcf6 --- /dev/null +++ b/Microwave_Engineering_by_G_S_N_Raju/5-MICROWAVE_PASSIVE_COMPONENTS_.ipynb @@ -0,0 +1,334 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 5: MICROWAVE PASSIVE COMPONENTS " + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.10: voltage_standing_wave_ratio.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//voltage standing wave ratio\n", +"//given\n", +"clc\n", +"clear \n", +"format\n", +"Vr=0.37//volts\n", +"Vi=1//volts\n", +"row=Vr/Vi\n", +"if(row>=0)\n", +"VSWR=(1+row)/(1-row)\n", +"VSWR=round(VSWR*10)/10///rounding off decimals\n", +"disp(VSWR,'THE voltage standing wave ratio is:')\n", +"else\n", +"disp('not possible')\n", +"end" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.11: magnitude_of_the_reflection_coefficent.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//magnitude of the reflection coefficent\n", +"//given\n", +"clc\n", +"zl=10*%i//ohm\n", +"z0=100//ohm\n", +"row=(zl-z0)/(zl+z0)//reflection coefficent\n", +"mag_row=norm(row)//magnitude of reflection coefficent\n", +"disp(mag_row,'the magnitude of the reflection coefficent:')" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.1: Zo_of_a_two_wire_transmission_line.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//Zo of a two wire transmission line\n", +"//given\n", +"clc\n", +"L=1D-3//H/Km\n", +"C=0.25D-6//F/Km\n", +"Zo=sqrt(L/C)//ohm\n", +"Zo=round(Zo*100)/100///rounding off decimalssc\n", +"disp(Zo,'the Zo for two wire transmission line in ohm:')//ohm" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.2: Zo_of_a_transmission_line.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//Zo of a transmission line\n", +"//given\n", +"clc\n", +"epsilon_r=1//assume as 1 according to question\n", +"s=0.49//cm\n", +"d=0.1//cm \n", +"Zo=(276/sqrt(epsilon_r))*log10((2*s)/d)\n", +"Zo=round(Zo*100)/100///rounding off decimals\n", +"disp(Zo,'the Zo of a transmission line is given in ohm as follows:')//ohm" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.3: wavelength_in_coaxial_line.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//wavelength in coaxial line\n", +"//given\n", +"clc\n", +"V0=3D+8//m/s\n", +"f=8D+9//hertz\n", +"epsilon_r=2.25\n", +"lem=V0/((sqrt(epsilon_r))*f)//meter\n", +"disp(lem,'the wave length for the operating frequency of 8GHz in meter:')\n", +"//error in the form of miscalculation" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.4: frequency_of_air_dielectric_and_highest_frequency.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//frequency of air dielectric and highest frequency\n", +"//given\n", +"clc\n", +"n=1//lowest mode\n", +"d=2.6//mm\n", +"D=0.8//mm\n", +"V0=3d+11//mm/s//ERROR\n", +"lem_c=(%pi/(2*n))*(d+D)\n", +"fc=V0/lem_c//hertz//ERROR\n", +"disp(fc,'the frequency is as follows:')//Hz\n", +"//ERROR in the calculation in the book as value of V0=3d+10" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.5: Zo_of_the_coaxial_cable.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//Zo of the coaxial cable\n", +"//given\n", +"clc\n", +"epsilon_r=2.25\n", +"Dbyd=2.25\n", +"Zo=(138/sqrt(epsilon_r))*log10(Dbyd)//ohm\n", +"Zo=round(Zo*1000)/1000///rounding off decimals\n", +"disp(Zo,'the Zo for the given coaxial cable is :')//ohm" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.6: output_power_of_cable.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//output power of cable\n", +"//given\n", +"clc\n", +"alpha=0.28//db/m//attenuation\n", +"alpha_50m=0.28*50//db//attenutaion of 50 m cable\n", +"pi=0.4//watt//input power//ERROR\n", +"po=pi/(10^((alpha_50m)/10))//watt//output power\n", +"disp(po*1000,'the output power of 50m in mW ')//mW\n", +"//ERROR in calculation of the book as pi=0.04 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.7: percentage_of_reflected_power.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//percentage of reflected power\n", +"//given\n", +"Vi=20//volts//incident voltage\n", +"Vr=12.5//volts//reflected voltage\n", +"row=Vr/Vi//reflected voltage coefficent\n", +"row2=row^2//reflected_power/incident_power\n", +"pi=1//watt\n", +"pr=0.391*1\n", +"%pr=pr*100//percentage power\n", +"disp(%pr,'the percentage of reflected power is:')" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.8: voltage_standing_wave_ratio.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//voltage standing wave ratio\n", +"//given\n", +"clc\n", +"Vmax=5//volts\n", +"Vmin=3//volts\n", +"VSWR=Vmax/Vmin//voltage standing wave ratio\n", +"VSWR_S=20*log10(VSWR)//VSWR IN db\n", +"VSWR_S=round(VSWR_S*100)/100///rounding off decimals\n", +"disp(VSWR_S,'THE voltage standing wave ratio in db:')//decibles" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.9: VSWR_FOR_LOAD_impedence.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//VSWR FOR LOAD impedence\n", +"//given\n", +"clc\n", +"Zo=100\n", +"Zl1=50\n", +"Zl2=125\n", +"VSWR=Zo/Zl1//for Zo>Zl\n", +"VSWR_1=Zl2/Zo//for Zo<Zl\n", +"disp(VSWR_1,VSWR,'THE voltage standing wave ratio for each case:')" + ] + } +], +"metadata": { + "kernelspec": { + "display_name": "Scilab", + "language": "scilab", + "name": "scilab" + }, + "language_info": { + "file_extension": ".sce", + "help_links": [ + { + "text": "MetaKernel Magics", + "url": "https://github.com/calysto/metakernel/blob/master/metakernel/magics/README.md" + } + ], + "mimetype": "text/x-octave", + "name": "scilab", + "version": "0.7.1" + } + }, + "nbformat": 4, + "nbformat_minor": 0 +} diff --git a/Microwave_Engineering_by_G_S_N_Raju/6-MICROWAVE_TRANSMISSION_LINE_.ipynb b/Microwave_Engineering_by_G_S_N_Raju/6-MICROWAVE_TRANSMISSION_LINE_.ipynb new file mode 100644 index 0000000..ddf9ec1 --- /dev/null +++ b/Microwave_Engineering_by_G_S_N_Raju/6-MICROWAVE_TRANSMISSION_LINE_.ipynb @@ -0,0 +1,675 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 6: MICROWAVE TRANSMISSION LINE " + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.10: voltage_standing_wave_ratio.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//voltage standing wave ratio\n", +"//given\n", +"clc\n", +"Vmax=50//volts\n", +"Vmin=35//volts\n", +"VSWR=Vmax/Vmin\n", +"VSWR_db=20*log10(VSWR)//db\n", +"VSWR_db=round(VSWR_db*1000)/1000///rounding off decimals\n", +"disp(VSWR_db,'the voltage standing wave ratio in decibles')//db" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.11: maximum_impedance_of_the_line.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//maximum impedance of the line\n", +"//given\n", +"clc\n", +"Zo=75//ohm\n", +"VSWR=3//voltage standing wave ratio\n", +"Zmax=VSWR*Zo//ohm\n", +"disp(Zmax,'the maximum impedance of the line for the given VSWR IN ohm')//ohm" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.12: voltage_standing_wave_ratio.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//EXAMPLE-6.12;PAGE-201\n", +"//voltage standin wave ratio\n", +"//given\n", +"clc\n", +"row=0.4\n", +"VSWR=(1+row)/(1-row)//voltage standing wave ratio\n", +"VSWR=round(VSWR*100)/100///rounding off decimals\n", +"disp(VSWR,'the voltage standing wave ratio')" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.13: input_impedance.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//input impedance\n", +"//given\n", +"clc\n", +"Zl=0//ohm\n", +"Bl=2*%pi/8//rad\n", +"Zo=75//ohm\n", +"Zi=Zo*(Zl+%i*Zo*tan(Bl))/(Zo+%i*Zl*tan(Bl))\n", +"disp(Zi,'the input impedance at point')//ohm" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.14: length_and_characteristic_impedance_of_transformer.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//length and characteristic impedance of transformer\n", +"//given\n", +"Zo=50//ohm\n", +"Zl=200//ohm\n", +"f=300d+6//MHz\n", +"Vo=3d+8//velocity of wave\n", +"lem=Vo/f\n", +"leng_trans=lem/4//meter//the length of transformer is 1/4 of wavelength\n", +"Zt=sqrt(Zo*Zl)//ohm\n", +"disp(Zt,leng_trans,'the length and characteristic impedance in meter and ohm respectively')" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.15: characteristic_impedance.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//characteristic impedance\n", +"//given\n", +"clc\n", +"Zl=300//ohm\n", +"Zo=75//ohm//of the line\n", +"SWR=1//the source impedence is equal to characteristic impedance of the line\n", +"Zt=sqrt(Zl*Zo)\n", +"disp(Zt,'the characteristic impedance in ohm')" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.16: reflection_coefficent.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//reflection coefficent\n", +"//given\n", +"clc\n", +"S=2//voltage standing wave ratio(VSWR)\n", +"Zo=50//ohm\n", +"row=((S-1)/(S+1))\n", +"row=round(row*1000)/1000///rounding off decimals\n", +"disp(row,'the value of reflection coefficent as modulus row')\n", +"" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.17: input_impedance_of_the_shorted_line.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//input impedance of the shorted line\n", +"//given\n", +"clc\n", +"Zn=50//ohm\n", +"f=500//Mhz\n", +"Bl=0.2*%pi//B=2*pi/lemda\n", +"Zi=%i*Zn*tan(Bl)//input impedance\n", +"Zi=round(Zi*100)/100//rounding off decimals\n", +"disp(Zi,'the input impedance of the shorted line in ohm')" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.18: characteristc_impedance_of_the_line_for_air_dielectric.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//characteristc impedance of the line for air dielectric\n", +"//given\n", +"clc\n", +"b=30-2*2//mm//diameter of the outside conductor\n", +"a=10-2*1//mm//diameter of the inner conductor\n", +"Zo=138*log10(b/a)//characteristic impedance\n", +"Zo=round(Zo*100)/100///rounding off decimals\n", +"disp(Zo,'the characteristic impedance of the line for air dielectric in ohm')\n", +"//error in the value of b\n", +"" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.19: time_delay_propogaion_velocity_propagation_delay.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//time delay ,propogaion velocity,propagation delay\n", +"//given\n", +"clc\n", +"L=500D-9//H/m\n", +"C=30D-12//F/m\n", +"td=sqrt(L*C)//time delay for 1 m long cable \n", +"vp=1/3.87d-9//m/s\n", +"C1=C*10//capacitance of 10 m cable\n", +"L1=L*10//inductance of 10 m cable\n", +"Ld=sqrt(L1*C1)//time delay for 10 m long cable \n", +"Ld=round(Ld*1d+10)/1d+10///rounding off decimals\n", +"td=round(td*1d+11)/1d+11///rounding off decimals\n", +"disp(Ld*1d+9,vp,td*1d+9,'the time delay in nanoseconds ,propogaion velocity in meter/second,propogation delay over a cable length in nanoseconds')\n", +"\n", +"" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.1: determine_Z0_for_given_transmission_line.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//determine Z0 for given transmission line\n", +"//given\n", +"clc\n", +"function[Zo]=zed(L,C)\n", +"Zo=sqrt(L/C)//impedence function\n", +"endfunction\n", +"L=110D-9\n", +"C=20D-12\n", +"[Zo1]=zed(L,C)\n", +"L=110D-9\n", +"C=20D-12\n", +"[Zo2]=zed(L,C)\n", +"Zo2=round(Zo2*100)/100///rounding off decimals\n", +"Zo1=round(Zo1*100)/100///rounding off decimals\n", +"disp(Zo1,Zo2,'the Zo is determined in ohm:')\n", +"\n", +"\n", +" " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.20: radius_of_the_outer_conductor.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//radius of the outer conductor\n", +"//given\n", +"clc\n", +"C=70D-12//F/m\n", +"Zo=75//ohm\n", +"L=Zo^2*C//inductance\n", +"epsilon_r=2.3\n", +"a=0.292//mm//radius of inner conductor\n", +"b=a*10^(Zo*sqrt(epsilon_r)/138)//Zo=(138/sqrt(epsilon_r))*log(b/a)\n", +"b=round(b*1d+4)/1d+4///rounding off decimals\n", +"disp(b,'the radius of the outer conductor')" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.21: resonant_frequency.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//resonant frequency\n", +"//given\n", +"clc\n", +"a=0.03//m\n", +"b=0.01//m\n", +"c=0.04//m\n", +"v=3d+8//speed of wave\n", +"fr=(v/2)*(sqrt((1/a^2)+(1/b^2)+(1/c^2)))//hertz\n", +"disp(fr*1d-9,'resonant frequency for TM110 mode in Ghz')//Ghz" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.22: resonant_frequency_and_quality_cycle.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//resonant frequency and quality cycle\n", +"//given\n", +"clc\n", +"a=0.03//m\n", +"b=0.01//m\n", +"c=0.04//m\n", +"l=0.04//m\n", +"v=3d+8//speed of wave in m/s in mho/m\n", +"uo=4*%pi*10^-7\n", +"con_d=5.8d+7//conductivity of copper\n", +"fr=(v/2)*(sqrt((1/a^2)+(1/b^2)))//hertz\n", +"fr1=(v/2)*(sqrt((1/a^2)+(1/l^2)))//hertz\n", +"del=1/sqrt(%pi*fr1*uo*con_d)\n", +"Q=((a^2+c^2)*a*b*c)/(del*(((a^3+c^3)*2*b)+a*c*(a^2+c^2)))\n", +"fr=round(fr*1d-8)/1d-8///rounding off decimals\n", +"Q=round(Q)///rounding off decimals\n", +"disp(Q,fr1*1d-9,fr*1d-9,'resonant frequency of dominant mode TM110,dominant mode TE101 in Ghz and the quality factor')//GHz " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.23: resonant_frequency_of_TE101_and_its_quality_factor.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//resonant frequency of TE101 and its quality factor\n", +"//given\n", +"clc\n", +"con_d=5.8d+7//mho/m\n", +"a=0.05//m\n", +"b=0.04//m\n", +"c=0.1//m\n", +"v=3d+8//m/s\n", +"epsilon_r=4//dielectric\n", +"uo=4*%pi*10^-7\n", +"fr=(v/(2*sqrt(epsilon_r)))*(sqrt((1/a^2)+(1/c^2)))//hertz\n", +"del=1/sqrt(%pi*fr*uo*con_d)//ERROR\n", +"Q=((a^2+c^2)*a*b*c)/(del*(((a^3+c^3)*2*b)+a*c*(a^2+c^2)))//quality factor\n", +"disp(Q,fr*1d-9,'resonant frequency in dominant mode TE101 in Ghz and the quality factor')//GHz \n", +"//ERROR in the calculation of the book as value of del=32.275d-7 in the book." + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.2: characteristic_impedence.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//characteristic impedence\n", +"//given\n", +"clc\n", +"s=300//mm//\n", +"r=3/2//mm\n", +"Zo=276*log10(s/r)\n", +"Zo=round(Zo)///rounding off decimals\n", +"disp(Zo,'the characteristic impedence in ohm')" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.3: input_impedance.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//input impedance\n", +"//given\n", +"clc\n", +"Zl=0//ohm\n", +"Zo=50//ohm\n", +"Bl=2*%pi*0.1//((2*pi/lem)*lem)\n", +"Zi=Zo*(Zl+%i*Zo*tan(Bl))/(Zo+%i*Zl*tan(Bl))//the input impedence in ohm\n", +"Zi=round(Zi*100)/100///rounding off decimals\n", +"disp(Zi,'the input impedance of 50ohm loss less transmission line')" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.4: input_of_lossless_transmission_line.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//input of lossless transmission line\n", +"//given\n", +"clc\n", +"Zo=50//ohms\n", +"Zl=%inf//defined as infinity\n", +"Bl=2*%pi*0.1\n", +"Zi=(Zo*(1+%i*(Zo/Zl)*tan(Bl))/(Zo/Zl+%i*tan(Bl)))//taking Zl common from numerrator and denominator\n", +"Zi=round(Zi*100)/100///rounding off decimals\n", +"disp(Zi,'the input of 50ohm lossless transmission line')//ohm" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.5: input_impedance_of_a_lossless_transmission.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//input impedance of a lossless transmission\n", +"//given\n", +"clc\n", +"Zo=100//ohm\n", +"Bl=(2*%pi)/3//ERROR \n", +"Zl=150+%i*60\n", +"Zi=Zo*(Zl+%i*Zo*tan(Bl))/(Zo+%i*Zl*tan(Bl))//the input impedence in ohm\n", +"disp(Zi,'the input impedance of lossless transmission line in ohm:')\n", +"//ERROR in the calculation of the book as value of Bl=120*pi" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.6: time_required_for_wave_to_travell.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//time required for wave to travell\n", +"//given\n", +"clc\n", +"L=1.2d-6//H/m\n", +"C=12.5d-12//F/m\n", +"leng_line=2//length of the line in meter\n", +"t=sqrt(L*C)*leng_line//time required for the wave to travell in seconds\n", +"t=round(t*1d+12)/1d+12///rounding off decimals\n", +"disp(t*1d+9,'the time required for wave to travell in nanoseconds')//nsec" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.7: characteristic_impedance.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//characteristic impedance\n", +"//given\n", +"clc\n", +"L=1.5d-6//H/m\n", +"C=10d-12//F\n", +"Zo=sqrt(L/C)\n", +"Zo=round(Zo)///rounding off decimals\n", +"disp(Zo,'the characteristic impedence in ohm')//ohm" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.8: reflected_voltage.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//reflected voltage\n", +"//given\n", +"clc\n", +"Vi=50//volts\n", +"row=0.25//reflection coefficent\n", +"Vr=Vi*row//the reflected voltage\n", +"disp(Vr,'the reflected voltage for given reflection coefficent in volts')" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.9: percenage_of_reflected_voltage.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//percentage of reflected voltage\n", +"//given\n", +"clc\n", +"Vi=50//volts\n", +"Vr=25//volts\n", +"row=Vr/Vi//reflection coefficent\n", +"per_ref_volt=row*100//percentage of reflected voltage \n", +"disp(per_ref_volt,'the percentage of reflected voltage')" + ] + } +], +"metadata": { + "kernelspec": { + "display_name": "Scilab", + "language": "scilab", + "name": "scilab" + }, + "language_info": { + "file_extension": ".sce", + "help_links": [ + { + "text": "MetaKernel Magics", + "url": "https://github.com/calysto/metakernel/blob/master/metakernel/magics/README.md" + } + ], + "mimetype": "text/x-octave", + "name": "scilab", + "version": "0.7.1" + } + }, + "nbformat": 4, + "nbformat_minor": 0 +} diff --git a/Microwave_Engineering_by_G_S_N_Raju/7-MICROWAVE_INTEGRATED_CIRCUITS.ipynb b/Microwave_Engineering_by_G_S_N_Raju/7-MICROWAVE_INTEGRATED_CIRCUITS.ipynb new file mode 100644 index 0000000..bc2fcd3 --- /dev/null +++ b/Microwave_Engineering_by_G_S_N_Raju/7-MICROWAVE_INTEGRATED_CIRCUITS.ipynb @@ -0,0 +1,418 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 7: MICROWAVE INTEGRATED CIRCUITS" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.10: resistance_per_square.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//resistance per square\n", +"//given\n", +"clc\n", +"l=12d-3//metre\n", +"t=0.12d-6//metre\n", +"w=10d-3//metre\n", +"delta_s=4.10d+7//mho/m\n", +"Rp=l/(w*t*delta_s)//resistance in ohm\n", +"Rp=round(Rp*10000)/10000///rounding off decimals\n", +"disp(Rp,'the resistance for the given parameter in ohm')//ohm" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.11: resistance_per_square.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//resistance per square\n", +"//given\n", +"clc\n", +"l=20d-3//metre\n", +"t=15d-6//metre\n", +"w=10d-3//metre\n", +"delta_s=5.8d+7//mho/m\n", +"Rp=l/(w*t*delta_s)//resistance in ohm\n", +"disp(Rp,'the resistance for the given parameter in ohm/square')//ohm/square\n", +"//ERROR IN THE BOOK CALCULATION" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.12: resistance_per_square.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//resistance per square\n", +"//given\n", +"clc\n", +"l=30d-3//metre\n", +"t=0.1d-6//metre\n", +"Rp=0.3//ohm\n", +"delta_s=4.1d+7//mho/m\n", +"w=l/(Rp*t*delta_s)//metre\n", +"w=round(w*1000)/1000///rounding off decimals\n", +"disp(t*1d+6, w*1000,l*1d+3 ,'the design parameter of planer resistor are in mm and um')//millimetre" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.13: resistance_per_square.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//resistance per square\n", +"//given\n", +"clc\n", +"w=10d-3//metre\n", +"t=0.08d-6//metre\n", +"Rp=0.15//ohm\n", +"delta_s=6.17d+7//mho/m\n", +"l=w*(Rp*t*delta_s)//metre\n", +"disp(l*1000,'the resistance for the given parameter in mm')//millimetre" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.14: inductance_of_circular_spiral.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//inductance of circular spiral\n", +"//given\n", +"clc\n", +"N=10//number of turns\n", +"w=50//mils//sepration\n", +"s=20//mils//film width\n", +"d=2.5*N*(w+s)//\n", +"L=31.25*(N^2)*d//PH/mil\n", +"L=round(L*1D-3)/1d-3///rounding off decimals\n", +"disp(L*1d-3,'the resistance for the given parameter in nH/mil')//nH/mil(the value is different on book)" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.1: resistance_of_a_planar_resistor.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//resistance of a planar resistor\n", +"//given\n", +"clc\n", +"con_d=4.1d+7//mho/m\n", +"l=10d-3//m\n", +"w=5d-3//m\n", +"d=0.2d-6//m\n", +"Rp=l/(w*d*con_d)//resistance\n", +"Rp=round(Rp*1000)/1000///rounding off decimals\n", +"disp(Rp,'resistance of a aluminum planar resistor')//ohm" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.2: inductance_for_given_dimensions.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//inductance for given dimensions\n", +"//given\n", +"clc\n", +"l=100//mils\n", +"d=10//mils\n", +"Lw=5.08*l*(log(l/d)+0.386)//PH/mil\n", +"Lw=round(Lw)///rounding off decimals\n", +"disp(Lw*1d-3,'the inductance in nH/mil')//nH/mil" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.3: resistance.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//resistance \n", +"//given\n", +"clc\n", +"l=11d-3//meter\n", +"d=0.2d-6//meter\n", +"w=8d-3//meter\n", +"delta_s=3.82d+7//mho/m\n", +"Rp=l/(w*d*delta_s)//resistance\n", +"Rp=round(Rp*100)/100///rounding off decimals\n", +"disp(Rp,'the resistance for the given parameter in ohm')//ohm" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.4: resistance.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//resistance \n", +"//given\n", +"clc\n", +"l=11d-3\n", +"d=0.2d-6\n", +"w=8d-3\n", +"delta_s=4.10d+7\n", +"Rp=l/(w*d*delta_s)//resistance\n", +"Rp=round(Rp*1000)/1000///rounding off decimals\n", +"disp(Rp,'the resistance for the given parameter in ohm')//ohm" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.5: resistance.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//resistance \n", +"//given\n", +"clc\n", +"l=11d-3\n", +"d=0.2d-6\n", +"w=8d-3\n", +"delta_s=6.17d+7\n", +"Rp=l/(w*d*delta_s)//resistance\n", +"Rp=round(Rp*1000)/1000///rounding off decimals\n", +"disp(Rp,'the resistance for the given parameter in ohm')//ohm" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.6: inductance.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//inductance\n", +"//given\n", +"clc\n", +"A=0.04//cm^2\n", +"N=4//no. of turns\n", +"Lss=8.5*(A^(0.5))*(N^(5/3))*1d+3//PH\n", +"Lss=round(Lss/10)*10///rounding off decimals\n", +"disp(Lss*1d-3,'the inductance for the given parameter in nH')//nH\n", +"" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.7: inductance.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//inductance \n", +"//given\n", +"clc\n", +"l=10//mils\n", +"t=0.2//mils\n", +"w=8//mils\n", +"Lt=5.08*l*(log(l/(w+t))+0.222*((w+t)/l)+1.19)//PH/mil\n", +"Lt=round(Lt*10)/10///rounding off decimals\n", +"disp(Lt,'the inductance for the given parameters')" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.8: resistance_of_a_planer_resistor.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//resistance of a planer resistor\n", +"//given\n", +"clc\n", +"l=8d-3//metre\n", +"t=0.1d-6//metre\n", +"w=8d-3//metre\n", +"delta_s=1/0.262d-7//mho/m\n", +"Rp=l/(w*t*delta_s)//resistance in ohm\n", +"disp(Rp,'the resistance for the given parameter in ohm')//ohm" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.9: resistance_per_square.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//resistance per square\n", +"//given\n", +"clc\n", +"l=15d-3//metre\n", +"t=0.1d-6//metre\n", +"w=15d-3//metre\n", +"delta_s=6.17d+7//mho/m\n", +"Rp=l/(w*t*delta_s)//resistance in ohm\n", +"Rp=round(Rp*1000)/1000///rounding off decimals\n", +"disp(Rp,'the resistance for the given parameter in ohm/square')//ohm/square\n", +"//ERROR IN THE PRINTING OF THE BOOK" + ] + } +], +"metadata": { + "kernelspec": { + "display_name": "Scilab", + "language": "scilab", + "name": "scilab" + }, + "language_info": { + "file_extension": ".sce", + "help_links": [ + { + "text": "MetaKernel Magics", + "url": "https://github.com/calysto/metakernel/blob/master/metakernel/magics/README.md" + } + ], + "mimetype": "text/x-octave", + "name": "scilab", + "version": "0.7.1" + } + }, + "nbformat": 4, + "nbformat_minor": 0 +} diff --git a/Microwave_Engineering_by_G_S_N_Raju/8-MICROWAVE_ANTENNAS.ipynb b/Microwave_Engineering_by_G_S_N_Raju/8-MICROWAVE_ANTENNAS.ipynb new file mode 100644 index 0000000..8839f31 --- /dev/null +++ b/Microwave_Engineering_by_G_S_N_Raju/8-MICROWAVE_ANTENNAS.ipynb @@ -0,0 +1,815 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 8: MICROWAVE ANTENNAS" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.10: half_power_radiation_pattern_and_beamwidth_between_first_null.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//half power radiation pattern and beamwidth between first null\n", +"//given\n", +"clc\n", +"Da=5//metre\n", +"f=10d+9//hertz\n", +"v=3d+8//m/s\n", +"lemda=v/f//metre\n", +"NNBW=140*(lemda/Da)//degree\n", +"HPBW=70*(lemda/Da)//degree\n", +"gp=6.4*(Da/lemda)^2//gain pattern\n", +"gp_decibles=10*log10(gp)//changing to db\n", +"gp_decibles=round(gp_decibles*1000)/1000///rounding off decimals\n", +"disp(NNBW,HPBW,gp_decibles,'the half power beamwidth and beamwidth between first null and the gain pattern in degrees and decibles')//degree,db" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.11: half_power_radiation_pattern_and_beamwidth_between_first_null.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//half power radiation pattern and beamwidth between first null\n", +"//given\n", +"clc\n", +"Da=12//metre\n", +"f=10d+9//hertz\n", +"v=3d+8//m/s\n", +"lemda=v/f//metre\n", +"ie=0.6//illumination efficiency\n", +"gp=ie*(Da/lemda)^2//gain pattern\n", +"gp_decibles=10*log10(gp)//changing to db\n", +"gp_decibles=round(gp_decibles*100)/100///rounding off decimals\n", +"disp(gp_decibles,'the power gain in decibles')//degree,db" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.12: mouth_diameter_and_capture_area.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//mouth diameter and capture area\n", +"//given\n", +"clc\n", +"f=4d+9//hertz\n", +"v=3d+8//m/s\n", +"NNBW=8//degree\n", +"lemda=v/f//metre\n", +"Da=140*(lemda/NNBW)//degree\n", +"A=%pi*(Da^2)/4//actual area\n", +"Ac=0.65*A//capture area\n", +"Ac=round(Ac*1000)/1000///rounding off decimals\n", +"disp(Ac,Da,'the mouth diameter and capture area in metre and metersquare')//m,m^2" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.13: mouth_diameter_and_power_gain.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//mouth diameter and power gain\n", +"//given\n", +"clc\n", +"NNBW=2//degree//null to null beamwidth\n", +"f=4d+9//hertz\n", +"v=3d+8//m/s\n", +"lemda=v/f//metre//\n", +"Da=140*(lemda/NNBW)//degree//beamwidth between first null\n", +"gp=6.4*(Da/lemda)^2\n", +"gp_decibles=10*log10(gp)//changing to decibles\n", +"gp_decibles=round(gp_decibles*100)/100///rounding off decimals\n", +"disp(gp_decibles,Da,'the beamwidth between first null and the value of half power beamwidth in decibles and degree')//decibles,degrees\n", +"" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.14: null_to_null_beamwidth_and_the_gain_power.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//null to null beamwidth and the gain power\n", +"//given\n", +"clc\n", +"HPBW=6//degree//half power beamwidth\n", +"f=6d+9//hertz\n", +"v=3d+8\n", +"NNBW=2*HPBW//degree//null to null beamwidth\n", +"lemda=v/f//metre\n", +"Da=70*(lemda/HPBW)//degree//half power beamwidth\n", +"gp=6.4*(Da/lemda)^2\n", +"gp_decibles=10*log10(gp)//changing to decibles\n", +"gp_decibles=round(gp_decibles*100)/100///rounding off decimals\n", +"disp(gp_decibles,NNBW,'the beamwidth between first null and gain power in degree and decibles')//degrees,decibles" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.15: power_gain_of_paraboloid_reflector.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//power gain of paraboloid reflector\n", +"//given\n", +"clc\n", +"lemda=1//as value of lemda do not effect the expression\n", +"for(lemda!=0)\n", +"Da=6*lemda\n", +"gp=6.4*(Da/lemda)^2\n", +"gp_decibles=10*log10(gp)//changing to decibles\n", +"end\n", +"gp_decibles=round(gp_decibles*100)/100///rounding off decimals\n", +"disp(gp_decibles,'the power gain of paraboloid reflector in decibles')//decibles" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.16: HPBW_NNBW_directivity.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//HPBW NNBW directivity\n", +"//given\n", +"clc\n", +"lemda=1//as value of lemda do not effect the expression\n", +"for(lemda!= 0)\n", +"Da=7*lemda//aperture diameter\n", +"NNBW=140*(lemda/Da)//degree\n", +"HPBW=70*(lemda/Da)//degree\n", +"D=6.4*(Da/lemda)^2//directivity\n", +"end\n", +"disp(D,NNBW,HPBW,'the half power beamwidth and beamwidth between first null and the directivity in degrees and decibles')//degree,db" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.17: beamwidth_power_gain_and_directivity.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//beamwidth power gain and directivity\n", +"//given\n", +"clc\n", +"f=8d+9//hertz\n", +"v=3d+8//m/s\n", +"d=0.09//m//aperture dimentions\n", +"W=0.04//m//aperture dimentions\n", +"lemda=v/f//metre\n", +"QE=56*lemda/d//\n", +"QH=67*lemda/W//\n", +"gp=4.5*W*d/lemda^2\n", +"gp_decibles=10*log10(gp)//changing to decibles\n", +"D=7.5*W*d/lemda^2//directivity\n", +"gp_decibles=round(gp_decibles*100)/100///rounding off decimals\n", +"QH=round(QH*100)/100///rounding off decimals\n", +"QE=round(QE*100)/100///rounding off decimals\n", +"disp(D,gp_decibles,QH,QE,'the beamwidth power gain and directivity in degrees,decibles')//degrees,decibles" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.18: power_gain_of_square_horn_antenna.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//power gain of square horn antenna\n", +"//given\n", +"clc\n", +"lemda=1//as value of lemda do not affect the expression\n", +"for(lemda!=0)\n", +" d=10*lemda // dimentions \n", +" W=10*lemda//dimentions\n", +"gp=4.5*W*d/lemda^2//power gain\n", +"gp_decibles=10*log10(gp)//changing to decibles\n", +"end\n", +"gp_decibles=round(gp_decibles*1000)/1000///rounding off decimals\n", +"disp(gp_decibles,'the power gain in decibles')//decibles" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.19: power_gain_and_directivity_of_a_horn.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//power gain and directivity of a horn\n", +"//given\n", +"clc\n", +"f=8d+9//hertz\n", +"v=3d+8//m/s\n", +"d=0.1//m//aperture dimentions\n", +"W=0.05//m//aperture dimentions\n", +"lemda=v/f//metre\n", +"gp=4.5*W*d/lemda^2\n", +"gp_decibles=10*log10(gp)//changing to decibles\n", +"D=7.5*W*d/lemda^2//directivity\n", +"D_decibles=10*log10(D)\n", +"gp_decibles=round(gp_decibles*100)/100///rounding off decimals\n", +"D_decibles=round(D_decibles*100)/100///rounding off decimals\n", +"disp(D_decibles,gp_decibles,'the beamwidth power gain and directivity in decibles')//decibles" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.1: half_power_beam_width.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//given\n", +"clc\n", +"Da=2.5//metre\n", +"f=5d+9//hertz\n", +"v=3d+8\n", +"lemda=v/f//metre\n", +"NNBW=140*(lemda/Da)//degree//beamwidth between first null\n", +"HPBW=70*(lemda/Da)//degree//half power beamwidth\n", +"disp(HPBW,NNBW,'the beamwidth between first null and the value of half power beamwidth in degree')//degrees" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.20: complementary_slot_impedence.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//complementary slot impedence\n", +"//given\n", +"clc\n", +"function[Zs]=slot_imp(Zd)\n", +"no=377\n", +"Rd=real(Zd)\n", +"Xd=imag(Zd)\n", +"Zs=(no^2/(4*(Rd^2+Xd^2)))*(Rd-%i*Xd)//slot impedance\n", +"Zs=round(Zs*100)/100///rounding off decimals\n", +"endfunction\n", +"Zd=73+%i*50//ohm\n", +"[Zs1]=slot_imp(Zd)\n", +"Zd=70//ohm\n", +"[Zs2]=slot_imp(Zd)\n", +"Zd=800//ohm\n", +"[Zs3]=slot_imp(Zd)\n", +"Zd=400//ohm\n", +"[Zs4]=slot_imp(Zd)\n", +"Zd=50+%i*10//ohm\n", +"[Zs5]=slot_imp(Zd)\n", +"Zd=50-%i*30//ohm\n", +"[Zs6]=slot_imp(Zd)\n", +"Zd=350//ohm\n", +"[Zs7]=slot_imp(Zd)\n", +"disp(Zs7,Zs6,Zs5,Zs4,Zs3,Zs2,Zs1,'the complementry slot impedence in ohms')//ohm" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.21: radiation_resistance_of_hertzian_dipole.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//radiation resistance of hertzian dipole\n", +"//given\n", +"clc\n", +"lemda=1//as the radiation resistance is independent of lemda\n", +"function[Rr]=rad_resistance(dl)\n", +" for(lemda!=0)\n", +" Rr=80*%pi^2*(dl/lemda)^2\n", +" Rr=round(Rr*1000)/1000///rounding off decimals\n", +" end\n", +" endfunction\n", +"dl=lemda/20\n", +"[Rr1]=rad_resistance(dl)\n", +"dl=lemda/30\n", +"[Rr2]=rad_resistance(dl)\n", +"dl=lemda/40\n", +"[Rr3]=rad_resistance(dl)\n", +"disp(Rr3,Rr2,Rr1,'the radiation resistance of hertzian dipole')" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.22: directivity_of_half_wave_dipole.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//directivity of half wave dipole\n", +"//given\n", +"clc\n", +"Pr=1//watts\n", +"r=1//as value of 'r' do not effect the expression\n", +"n0=120*%pi\n", +"for(r!=0)\n", +"I=sqrt(Pr/73)\n", +"Emax=60*I/r\n", +"si=r^2*Emax^2/n0\n", +"gdmax=4*%pi*(si)/Pr\n", +"gdmax=round(gdmax*1000)/1000///rounding off decimals\n", +"end\n", +"disp(gdmax,'the directivity expression for half wave dipole')" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.23: radiated_power_of_an_antenna.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//radiated power of an antenna \n", +"//given\n", +"clc\n", +"I=2//amperes\n", +"Rr=300//ohms\n", +"Pr=I^2*Rr//radiated power\n", +"disp(Pr,'the radiated power of anantenna in watts')" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.24: effective_area_of_a_half_wave_dipole.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//effective area of a half wave dipole\n", +"//given\n", +"clc\n", +"f=0.6d+9//hertz\n", +"Vo=3d+8//m/s\n", +"gd=1.644//directivity of half wave dipole\n", +"lemda=Vo/f\n", +"Ae=(lemda^2/(4*%pi))*gd//metre^2\n", +"Ae=round(Ae*1d+4)/1d+4///rounding off decimals\n", +"disp(Ae,'the effective area of a half wave dipole in metre^2')//m^2" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.25: effective_area_of_hertzian_dipole.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//effective area of hertzian dipole\n", +"//given\n", +"clc\n", +"f=0.2d+9//hertz\n", +"Vo=3d+8//m/s\n", +"lemda=Vo/f\n", +"Ae=(lemda^2/(4*%pi))//metre^2//ERROR\n", +"Ae=round(Ae*1000)/1000///rounding off decimals\n", +"disp(Ae,'the effective area of a half wave dipole in metre^2')//m^2\n", +"//ERROR in the calculation of the book as effective area includes lemda square not cube." + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.2: gain_of_paraboloid.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//gain of paraboloid\n", +"//given\n", +"clc\n", +"Da=2.5//metre\n", +"f=5d+9//hertz\n", +"v=3d+8//m/s\n", +"lemda=v/f\n", +"gp=6.4*(Da/lemda)^2\n", +"gp_decibles=10*log10(gp)//changing to decibles\n", +"gp_decibles=round(gp_decibles*100)/100///rounding off decimals\n", +"disp(gp_decibles,'the gain of paraboloid in decibles')//db" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.3: half_power_radiation_pattern_and_beamwidth_between_first_null.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//half power radiation pattern and beamwidth between first null\n", +"//given\n", +"clc\n", +"Da=0.15//metre\n", +"f=9d+9//hertz\n", +"v=3d+8//m/s\n", +"lemda=v/f//metre\n", +"NNBW=140*(lemda/Da)//degree\n", +"HPBW=70*(lemda/Da)//degree\n", +"gp=6.4*(Da/lemda)^2//gain pattern\n", +"gp_decibles=10*log10(gp)//changing to db\n", +"gp_decibles=round(gp_decibles*100)/100///rounding off decimals\n", +"HPBW=round(HPBW*100)/100///rounding off decimals\n", +"NNBW=round(NNBW*100)/100///rounding off decimals\n", +"disp(gp_decibles,HPBW,NNBW,'the half power beamwidth and beamwidth between first null and the gain pattern in degrees and decibles')//degree,db\n", +"" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.4: gain_of_paraboloid.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//gain of paraboloid\n", +"//given\n", +"clc\n", +"Da=2//metre\n", +"f=2d+9//hertz\n", +"v=3d+8//m/s\n", +"lemda=v/f\n", +"gp=6.4*(Da/lemda)^2\n", +"gp_decibles=10*log10(gp)//changing to decibles\n", +"disp(gp_decibles,'the gain of paraboloid in decibles')//db\n", +"//ERROR in the printing of the book" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.5: half_power_beam_width_the_gain_power.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//half power beam width the gain power\n", +"//given\n", +"clc\n", +"NNBW=5//degree//null to null beamwidth\n", +"f=6d+9//hertz\n", +"v=3d+8\n", +"lemda=v/f//metre\n", +"Da=140*(lemda/NNBW)//degree//beamwidth between first null\n", +"HPBW=70*(lemda/Da)//degree//half power beamwidth\n", +"gp=6.4*(Da/lemda)^2\n", +"gp_decibles=10*log10(gp)//changing to decibles\n", +"disp(gp_decibles,HPBW,Da,'the beamwidth between first null and the value of half power beamwidth in degree')//degrees\n", +"//ERROR in the printing of the book" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.6: beamwidth_directivity_and_capture_area.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//beamwidth,directivity and capture area\n", +"//given\n", +"clc\n", +"Da=5//metre\n", +"f=9d+9//hertz\n", +"v=3d+8//m/s\n", +"lemda=v/f//metre\n", +"A=%pi*(Da^2)/4//actual area\n", +"Ac=0.65*A//capture area\n", +"NNBW=140*(lemda/Da)//degree\n", +"HPBW=70*(lemda/Da)//degree\n", +"D=6.4*(Da/lemda)^2//directivity\n", +"D_decibles=10*log10(D)//changing to db\n", +"NNBW=round(NNBW*1D+4)/1D+4///rounding off decimals\n", +"HPBW=round(HPBW*1D+3)/1D+3///rounding off decimals\n", +"Ac=round(Ac*100)/100///rounding off decimals\n", +"D_decibles=round(D_decibles*100)/100///rounding off decimals\n", +"disp(D_decibles,Ac,HPBW,NNBW,'the half power beamwidth and beamwidth between first null and the gain pattern in degrees and decibles')//degree,m^2,db\n", +"" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.7: minimum_distance_between_two_antennas.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//minimum distance between two antennas\n", +"//given\n", +"clc\n", +"Da=5//metre\n", +"f=5d+9//hertz\n", +"v=3d+8//m/s\n", +"lemda=v/f//metre\n", +"r=2*(Da^2)/lemda//metre\n", +"r=round(r*100)/100///rounding off decimals\n", +"disp(r,'the minimum distance required between two antennas in metre')//metre\n", +"" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.8: mouth_diameter_and_the_beamwidth_of_antenna.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//mouth diameter and the beamwidth of antenna\n", +"//given\n", +"clc\n", +"Da=0.15//metre\n", +"f=4d+9//hertz\n", +"gp=500//\n", +"v=3d+8//m/s\n", +"lemda=v/f//metre\n", +"Da=lemda*sqrt(gp/6.4)//diameter\n", +"NNBW=140*(lemda/Da)//degree\n", +"HPBW=70*(lemda/Da)//degree\n", +"Da=round(Da*1000)/1000///rounding off decimals\n", +"HPBW=round(HPBW*100)/100///rounding off decimals\n", +"NNBW=round(NNBW*100)/100///rounding off decimals\n", +"disp(NNBW,HPBW,Da,'the mouth diameter and the beamwidth of antenna in metre and degrees')//metre,degree\n", +"" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.9: beamwidth_directivity_and_capture_area.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"//beamwidth,directivity and capture area\n", +"//given\n", +"clc\n", +"f=9d+9//hertz\n", +"v=3d+8//m/s\n", +"gp_decibles=100//db\n", +"lemda=v/f//metre\n", +"gp=10^(gp_decibles/10)//\n", +"Da=lemda*sqrt(gp/6.4)//metre\n", +"A=%pi*(Da^2)/4//actual area\n", +"Ac=0.65*A//capture area\n", +"NNBW=140*(lemda/Da)//degree\n", +"HPBW=70*(lemda/Da)//degree\n", +"HPBW=round(HPBW*1D+5)/1D+5///rounding off decimals\n", +"NNBW=round(NNBW*1D+4)/1D+4///rounding off decimals\n", +"disp(HPBW,NNBW,Ac,'the half power beamwidth and beamwidth between first null and the gain pattern in degrees and decibles')//degree,m^2,db" + ] + } +], +"metadata": { + "kernelspec": { + "display_name": "Scilab", + "language": "scilab", + "name": "scilab" + }, + "language_info": { + "file_extension": ".sce", + "help_links": [ + { + "text": "MetaKernel Magics", + "url": "https://github.com/calysto/metakernel/blob/master/metakernel/magics/README.md" + } + ], + "mimetype": "text/x-octave", + "name": "scilab", + "version": "0.7.1" + } + }, + "nbformat": 4, + "nbformat_minor": 0 +} |