diff options
Diffstat (limited to 'Nuclear_Physics_by_D_C_Tayal')
16 files changed, 6465 insertions, 0 deletions
diff --git a/Nuclear_Physics_by_D_C_Tayal/1-General_Properties_of_Atomic_Nucleus.ipynb b/Nuclear_Physics_by_D_C_Tayal/1-General_Properties_of_Atomic_Nucleus.ipynb new file mode 100644 index 0000000..d922a80 --- /dev/null +++ b/Nuclear_Physics_by_D_C_Tayal/1-General_Properties_of_Atomic_Nucleus.ipynb @@ -0,0 +1,570 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 1: General Properties of Atomic Nucleus" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.10: Calculation_of_energy_released_during_nuclear_fusion_reaction.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Ex1.10 : : Page 55 (2011)\n", +"clc; clear;\n", +"M_Li = 7.0116004; // Mass of lithium nucleus, u\n", +"M_Be = 7.016929; // Mass of beryllium nucleus, u\n", +"m_e = 0.511; // Mass of an electron, MeV\n", +"if (M_Li-M_Be)*931.48 < 2*m_e then\n", +" printf('\nThe Li-7 is not a beta emitter');\n", +"else\n", +" printf('\nThe Li-7 is a beta emitter'); \n", +"end\n", +"if (M_Be-M_Li)*931.48 > 2*m_e then\n", +" printf('\nThe Be-7 is a beta emitter');\n", +"else\n", +" printf('\nThe Be-7 is not a beta emitter'); \n", +"end\n", +"\n", +"// Result\n", +"// The Li-7 is not a beta emitter\n", +"// The Be-7 is a beta emitter " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.11: Binding_energies_calculation.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Ex1.11 : : Page 55 (2011)\n", +"clc; clear;\n", +"M_n = 1.008665; // Mass of neutron, amu\n", +"M_p = 1.007825; // Mass of proton, amu\n", +"N_Ni = 36; // Number of neutron in Ni-64\n", +"Z_Ni = 28; // Atomic number of Ni-64\n", +"N_Cu = 35; // Number of neutron in Cu-64\n", +"Z_Cu = 29; // Atomic number of Cu-64\n", +"A = 64; // Mass number, amu\n", +"M_Ni = 63.927958; // Mass of Ni-64\n", +"M_Cu = 63.929759; // Mass of Cu-64\n", +"m_e = 0.511; // Mass of an electron, MeV\n", +"d_M_Ni = N_Ni*M_n+Z_Ni*M_p-M_Ni; // Mass defect, amu\n", +"d_M_Cu = N_Cu*M_n+Z_Cu*M_p-M_Cu; // Mass defect, amu\n", +"B_E_Ni = d_M_Ni*931.49; // Binding energy of Ni-64, MeV\n", +"B_E_Cu = d_M_Cu*931.49; // Binding energy of Cu-64, MeV\n", +"Av_B_E_Ni = B_E_Ni/A; // Average binding energy of Ni-64, MeV\n", +"Av_B_E_Cu = B_E_Cu/A; // Average binding energy of Cu-64, MeV\n", +"printf('\nBinding energy of Ni-64 : %7.3f MeV \nBinding energy of CU-64 : %7.3f MeV \nAverage binding energy of Ni-64 : %5.3f MeV \nAverage binding energy of Cu-64 : %5.3f MeV ', B_E_Ni, B_E_Cu, Av_B_E_Ni, Av_B_E_Cu);\n", +"if (M_Cu - M_Ni)*931.48 > 2*m_e then\n", +" printf('\nNi-64 is not a beta emitter but Cu-64 is a beta emitter');\n", +"end\n", +"\n", +"// Result\n", +"// Binding energy of Ni-64 : 561.765 MeV \n", +"// Binding energy of CU-64 : 559.305 MeV \n", +"// Average binding energy of Ni-64 : 8.778 MeV \n", +"// Average binding energy of Cu-64 : 8.739 MeV \n", +"// Ni-64 is not a beta emitter but Cu-64 is a beta emitter " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.12: Calculation_of_energy_released_during_nuclear_fusion_reaction.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa1.12 : : Page 55 (2011)\n", +"clc; clear;\n", +"M_n = 1.008665*931.49; // Mass of neutron, MeV\n", +"M_p = 1.007825*931.49; // Mass of proton, MeV\n", +"M_He = 2*M_p+2*M_n-28; // Mass of He-4 nucleus, MeV\n", +"M_H = M_p+M_n-2.2; // Mass of H-2 nucleus, MeV\n", +"d_E = 2*M_H-M_He; // Energy released during fusion reaction, MeV\n", +"printf('\nEnergy released during fusion reaction : %4.1f MeV ',d_E);\n", +"\n", +"// Result\n", +"// Energy released during fusion reaction : 23.6 MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.13: To_find_the_stable_Isobar.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Ex1.13 : : P.No.55 (2011)\n", +"// We have to determine for mass numbers 80 and 97.\n", +"clc; clear;\n", +"A = [80, 97]; // Matrix of Mass numbers\n", +"Element = ['Br','Mo']; // Matrix of elements\n", +"M_n = 939.6; // Mass of neutron, MeV\n", +"M_H = 938.8; // Mass of proton, MeV\n", +"a_v = 14.0; // Volume energy, MeV\n", +"a_s = 13.0; // Surface energy, MeV\n", +"a_c = 0.583; // Coulomb energy, MeV\n", +"a_a = 19.3; // Asymmetry energy, MeV\n", +"a_p = 33.5; // Pairing energy, MeV\n", +"for i = 1:1:2\n", +"Z = poly(0,'Z'); // Declare the polynomial variable\n", +"M_AZ = M_n*(A(i)-Z)+M_H*Z-a_v*A(i)+a_s*A(i)^(2/3)+a_c*Z*(Z-1)*A(i)^(-1/3)+a_a*(A(i)-2*Z)^2/A(i)+a_p*A(i)^(-3/4); // Mass of the nuclide, MeV/c^2\n", +"Z = roots(derivat(M_AZ));\n", +"printf('\nFor A = %d, the most stable isobar is %s(%d,%d)', A(i), Element(i), Z, A(i)); \n", +"end\n", +"\n", +"// Result\n", +"// For A = 80, the most stable isobar is Br(35,80)\n", +"// For A = 97, the most stable isobar is Mo(42,97) " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.14: To_calculate_the_pairing_energy_term.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa1.14 : : P.no. 56(2011)\n", +"clc; clear;\n", +"A = 50; // Mass number\n", +"M_Sc = 49.951730; // Mass of scandium, atomic mass unit\n", +"M_Ti = 49.944786; // Mass of titanium, atomic mass unit\n", +"M_V = 49.947167; // Mass of vanadium, atomic mass unit\n", +"M_Cr = 49.946055; // Mass of chromium, atomic mass unit\n", +"M_Mn = 49.954215; // Mass of manganese, atomic mass unit\n", +"a_p = (M_Mn-M_Cr+M_V-M_Ti)/(8*A^(-3/4))*931.5; // Pairing energy temr, mega electron volts\n", +"printf('\nPairing energy term : %5.2f MeV', a_p);\n", +"\n", +"// Result\n", +"// Pairing energy term : 23.08 MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.17: Relative_error_in_the_electric_potential_at_the_first_Bohr_radius.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Ex1.17 : : Page 57 (2011)\n", +"clc; clear;\n", +"b = 1; // For simplicity assume minor axis length to be unity, unit\n", +"a = 10/100+b; // Major axis length, unit\n", +"A = 125; // Mass number of medium nucleus\n", +"r = 0.53e-010; // Bohr's radius, m\n", +"eps = (a-b)/(0.5*a+b); // Deformation parameter\n", +"R = 1.2e-015*A^(1/3); // Radius of the nucleus, m\n", +"Q = 1.22/15*R^2 // Electric Quadrupole moment, metre square\n", +"V_rel_err = Q/r^2; // Relative error in the potential\n", +"printf('\nThe relative error in the electric potential at the first Bohr radius : %e', V_rel_err);\n", +"\n", +"// Result\n", +"// The relative error in the electric potential at the first Bohr radius : 1.042364e-09 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.1: Distance_of_closest_approach.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa1.1 : : Page 51 (2011)\n", +"clc; clear;\n", +"Z = 79; // Atomic number of Gold \n", +"z = 1; // Atomic number of Hydrogen\n", +"e = 1.60218e-019; // Charge of an electron, coulomb\n", +"K = 9e+09; // Coulomb constant, newton metre square per coulomb square\n", +"E = 2*1.60218e-013; // Energy of the proton, joule\n", +"b = Z*z*e^2*K/E; // Distance of closest approach, metre\n", +"printf('\nDistance of closest approach : %7.5e metre', b);\n", +"\n", +"// Result\n", +"// Distance of closest approach : 5.69575e-014 meter " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.21: Spherical_symmetry_of_Gadolinium_nucleus.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa1.21 : : Page-58(2011)\n", +"clc; clear;\n", +"Q = 130; // Quadrupole moment, square femto metre\n", +"A = 155; // Mass number of gadolinium\n", +"R_0 = 1.4*A^(1/3) // Distance of closest approach, fm\n", +"Z = 64; // Atomic number\n", +"delR0 = 5*Q/(6*Z*R_0^2)*100; // Change in the value of R_0, percent\n", +"printf('\nChange in the value of fractional change in R_0 is only %4.2f percent \nThus, we can assumed that Gadolinium nucleus is spherical.', delR0);\n", +"\n", +"// Result\n", +"// Change in the value of fractional change in R_0 is only 2.99 percent \n", +"// Thus, we can assumed that Gadolinium nucleus is spherical. " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.2: Nuclear_Spi.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa1.2 : : Page 51 (2011)\n", +"clc; clear;\n", +"A = 14; // Number of protons\n", +"Z = 7; // Number of neutrons\n", +"N = A-Z; // Number of electrons \n", +"i = modulo((N+A),2); // Remainder\n", +"// Check for even and odd number of particles !!!!! \n", +"if i == 0 then // For even number of particles\n", +" printf('\nParticles have integral spin');\n", +" s = 1; // Nuclear spin\n", +"end\n", +" if i == 1 then // For odd number of particles\n", +" printf(' \nParticles have half integral spin ');\n", +" s = 1/2;\n", +"end\n", +"if s == 1 then\n", +" printf( '\nMeasured value agree with the assumption');\n", +"end\n", +"if s == 1/2 then\n", +" printf( '\nMeasured value disagree with the assumption' );\n", +"end\n", +"\n", +"// Result\n", +"// Particles have half integral spin \n", +"// Measured value disagree with the assumption " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.3: Kinetic_energy_and_Coulomb_energy_for_an_electron_confined_within_the_nucleus.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa1.3 : : Page 52 (2011)\n", +"clc; clear; \n", +"p = 62; // Momentum of the electron, MeV/c\n", +"K = 9e+09; // Coulomb constant\n", +"E = 0.511; // Energy of the electron, MeV\n", +"e = 1.60218e-019; // Charge of an electron, C\n", +"Z = 23; // Atomic number\n", +"R = 0.5*10^-14; // Diameter of the nucleus, meter\n", +"T = sqrt(p^2+E^2)-E; // Kinetic energy of the electron,MeV\n", +"E_c = -Z*K*e^2/(R*1.60218e-013); // Coulomb energy, MeV\n", +"printf('\nKinetic energy of the electron : %5.2f MeV \nCoulomb energy per electron : %5.3f MeV',T,E_c);\n", +"\n", +"// Result\n", +"// Kinetic energy of the electron : 61.49 MeV \n", +"// Coulomb energy per electron : -6.633 MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.4: Scattering_of_electron_from_target_nucleus.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa1.4 : : Page 52 (2011) \n", +"clc; clear;\n", +"K = 500*1.60218e-013; // Kinetic energy of the electron,joule\n", +"h = 6.6262e-034; // Planck's constant, joule sec\n", +"C = 3e+08; // Velocity of light, metre per sec\n", +"p = K/C; // Momentum of the electron, joule sec per meter\n", +"lambda = h/p; // de Broglie wavelength, metre\n", +"A = 30*%pi/180; // Angle (in radian)\n", +"r = lambda/(A*10^-15); // Radius of the target nucleus, femtometre\n", +"printf('\nRadius of the target nucleus : %4.2f fm', r);\n", +"\n", +"// Result\n", +"// Radius of the target nucleus : 4.74 fm" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.5: Positron_emission_from_Cl33_decays.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa1.5 : : Page 52 (2011) \n", +"clc; clear;\n", +"e = 1.60218e-019; // Charge of an electron, C\n", +"A = 33; // Atomic mass of Chlorine, amu\n", +"K = 9e+09; // Coulomb constant, newton metre sqaure per coulomb square\n", +"E = 6.1*1.60218e-013; // Coulomb energy, joule\n", +"R_0 = 3/5*K/E*e^2*(A)^(2/3); // Distance of closest approach, metre\n", +"R = R_0*A^(1/3); // Radius of the nucleus, metre\n", +"printf('\nRadius of the nucleus : %4.2e metre', R);\n", +"\n", +"// Result\n", +"// Radius of the nucleus : 4.6805e-015 metre " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.6: Charge_accelerated_in_mass_spectrometer.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa1.6: : Page 53 (2011)\n", +"clc; clear;\n", +"V = 1000; // Potential difference, volts\n", +"R = 18.2e-02; // Radius of the orbit, metre\n", +"B = 1000e-04; // Magnetic field, tesla\n", +"e = 1.60218e-019; // Charge of an electron, C\n", +"n = 1; // Number of the ion\n", +"v = 2*V/(R*B); // Speed of the ion, metre per sec\n", +"M = 2*n*e*V/v^2; // Mass of the ion, Kg\n", +"printf('\nSpeed of the ion: %6.4e m/s \nMass of the ion : %4.2f u', v, M/1.67e-027);\n", +"\n", +"// Result\n", +"// Speed of the ion: 1.0989e+05 m/s \n", +"// Mass of the ion : 15.89 u " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.7: Ionized_atoms_in_Bainbridge_mass_spectrograph.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa1.7 : : Page 53 (2011)\n", +"clc; clear;\n", +"M = 20*1.66054e-027; //\n", +"v = 10^5; // Speed of the ion, metre per sec\n", +"B = 0.08; // Magnetic field, tesla\n", +"e = 1.60218e-019; // Charge of an electron, C\n", +"n = 1; // Number of the ion\n", +"R_20 = M*v/(B*n*e) // Radius of the neon-20, metre\n", +"R_22 = 22/20*R_20; // Radius of the neon-22, metre\n", +"printf('\nRadius of the neon-20 : %5.3f metre \nRadius of the neon-22 : %5.3f metre', R_20, R_22);\n", +"\n", +"// Result\n", +"// Radius of the neon-20 : 0.259 metre \n", +"// Radius of the neon-22 : 0.285 metre " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.8: Calculating_the_mass_of_hydrogen.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa1.8 : : Page 53 (2011)\n", +"clc; clear;\n", +"a = 17.78e-03; // First doublet mass difference, u\n", +"b = 72.97e-03; // Second doublet mass difference, u\n", +"c = 87.33e-03; // Third doublet mass difference, u\n", +"M_H = 1+1/32*(4*a+5*b-2*c); // Mass of the hydrogen,amu\n", +"printf('\nMass of the hydrogen: %8.6f amu',M_H);\n", +"\n", +"// Result\n", +"// Mass of the hydrogen: 1.008166 amu " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 1.9: Silver_ions_in_Smith_mass_spectrometer.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa1.9 : : Page 54 (2011)\n", +"clc; clear;\n", +"e = 1.60218e-019; // Charge of an electron,C\n", +"B = 0.65; // Magnetic field, tesla\n", +"d_S1_S2 = 27.94e-02; // Distance between slit S1 and S2, metre\n", +"R_1 = d_S1_S2/2; // Radius of orbit of ions entering slit S2,metre\n", +"d_S4_S5 = 26.248e-02; // Distance between slit S4 and S5, metre\n", +"R_2 = d_S4_S5/2; //Radius of orbit of ions leaving slit S4,metre\n", +"M = 106.9*1.66054e-027; // Mass of an ion(Ag+)Kg, \n", +"T_1 = B^2*e^2*R_1^2/(2*M*1.60218e-019); // Kinetic energy of the ion entering slit S2,eV \n", +"T_2 = B^2*e^2*R_2^2/(2*M*1.60218e-019); // Kinetic energy of the ion leaving slit S4,eV \n", +"printf('\nKinetic energy of the ion entering slit S2 : %d eV \nKinetic energy of the ion leaving slit S4 : %d eV ',T_1,T_2)\n", +"\n", +"// Result\n", +"// Kinetic energy of the ion entering slit S2 : 3721 eV \n", +"// Kinetic energy of the ion leaving slit S4 : 3284 eV " + ] + } +], +"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/Nuclear_Physics_by_D_C_Tayal/10-Nuclear_Reactions.ipynb b/Nuclear_Physics_by_D_C_Tayal/10-Nuclear_Reactions.ipynb new file mode 100644 index 0000000..838045c --- /dev/null +++ b/Nuclear_Physics_by_D_C_Tayal/10-Nuclear_Reactions.ipynb @@ -0,0 +1,511 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 10: Nuclear Reactions" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 10.10: Fractional_attenuation_of_neutron_beam_on_passing_through_nickel_sheet.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa10.10 : : Page-458 (2011)\n", +"clc; clear;\n", +"N_0 = 6.02252e+26; // Avogadro's constant\n", +"sigma = 3.5e-28; // Cross section, square metre\n", +"rho = 8.9e+03; // Nuclear density, Kg per cubic metre\n", +"M = 58; // Mass number \n", +"summation = rho/M*N_0*sigma; // Macroscopic cross section, per metre\n", +"x = 0.01e-02; // Thickness of nickel sheet, metre\n", +"I0_ratio_I = exp(summation*x/2.3026); // Fractional attenuation of neutron beam on passing through nickel sheet\n", +"printf('\nThe fractional attenuation of neutron beam on passing through nickel sheet = %6.4f', I0_ratio_I);\n", +"// Result\n", +"// The fractional attenuation of neutron beam on passing through nickel sheet = 1.0014 \n", +"// Wrong answer given in the textbook" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 10.11: Scattering_contribution_to_the_resonance.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa10.11 : : Page-458 (2011)\n", +"clc; clear;\n", +"lambda = sqrt(1.45e-021/(4*%pi)); // Wavelength, metre\n", +"W_ratio = 2.3e-07; // Width ratio\n", +"sigma = W_ratio*(4*%pi)*lambda^2*10^28; // Scattering contribution, barn\n", +"printf('\nThe scattering contribution to the resonance = %4.2f barns', sigma);\n", +"// Result\n", +"// The scattering contribution to the resonance = 3.33 barns " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 10.12: Estimating_the_relative_probabilities_interactions_in_the_indium.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa10.12 : : Page-458 (2011)\n", +"clc; clear;\n", +"sigma = 2.8e-024; // Cross section, metre square\n", +"lambda = 2.4e-11; // de Broglie wavelength, metre\n", +"R_prob = %pi*sigma/lambda^2; // Relative probabilities of (n,n) and (n,y) in indium\n", +"printf('\nThe relative probabilities of (n,n) and (n,y) in indium = %5.3f', R_prob);\n", +"// Result\n", +"// The relative probabilities of (n,n) and (n,y) in indium = 0.015 \n", +" " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 10.13: Peak_cross_section_during_neutron_capture.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa10.13 : : Page-459 (2011)\n", +"clc; clear;\n", +"h = 6.625e-34; // Planck's constant, joule sec \n", +"m_n = 1.67e-27; // Mass of neutron, Kg\n", +"E = 4.906; // Energy, joule \n", +"w_y = 0.124; // radiation width, eV\n", +"w_n = 0.007*E^(1/2); // Probability of elastic emission of neutron, eV\n", +"I = 3; // Total angular momentum\n", +"I_c = 2; // Total angular momentum in the compound state\n", +"sigma = ((h^2)*(2*I_c+1)*w_y*w_n)*10^28/(2*%pi*m_n*E*1.602e-019*(2*I+1)*(w_y+w_n)^2); // Cross section, barns\n", +"printf('\nThe cross section of neutron capture = %5.3e barns', sigma);\n", +"// Result\n", +"// The cross section of neutron capture = 3.755e+004 barns \n", +" " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 10.14: Angle_at_which_differential_cross_section_is_maximumat_a_givem_l_value.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa10.14 : : Page-459 (2011)\n", +"clc; clear;\n", +"R = 5; // Radius, femto metre\n", +"k_d = 0.98; // The value of k for deutron \n", +"k_p = 0.82; // The value of k for triton\n", +"theta = rand(1,5); // Angles at which differetial cross section is maximum, degree\n", +"// Use of for loop for angles calculation(in degree)\n", +"for l = 0:4\n", +" theta = round((acos((k_d^2+k_p^2)/(2*k_d*k_p)-l^2/(2*k_d*k_p*R^2)))*180/3.14);\n", +" printf('\nFor l = %d', l);\n", +" printf(',the value of theta_max = %d degree', ceil(theta));\n", +" end\n", +"// Result\n", +"// For l = 0,the value of theta_max = 0 degree\n", +"// For l = 1,the value of theta_max = 8 degree\n", +"// For l = 2,the value of theta_max = 24 degree\n", +"// For l = 3,the value of theta_max = 38 degree\n", +"// For l = 4,the value of theta_max = 52 degree " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 10.15: Estimating_the_angular_momentum_transfer.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa10.15 : : Page-459 (2011)\n", +"clc; clear;\n", +"k_d = 2.02e+30; // The value of k for deutron\n", +"k_t = 2.02e+30; // The value of k for triton\n", +"theta = 23*3.14/180; // Angle, radiams\n", +"q = sqrt (k_d+k_t-2*k_t*cos(theta))*10^-15; // the value of q in femto metre\n", +"R_0 = 1.2; // Distance of closest approach, femto metre\n", +"A = 90; // Mass number of Zr-90\n", +"z = 4.30; // Deutron size, femto metre\n", +"R = R_0*A^(1/3)+1/2*z; // Radius of the nucleus, femto metre\n", +"l = round(q*R); // Orbital angular momentum\n", +"I = l+1/2 // Total angular momentum\n", +"printf('\nThe total angular momentum transfer = %3.1f ', I);\n", +"// Result\n", +"// The total angular momentum transfer = 4.5 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 10.1: Q_value_for_the_formation_of_P30_in_the_ground_state.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa10.1 : : Page-455 (2011) \n", +"clc; clear;\n", +"M = 47.668; // Total mass of reaction, MeV\n", +"E = 44.359; // Total energy, MeV\n", +"Q = M-E; // Q-value, MeV\n", +"printf('\nThe Q-value for the formation of P30 = %5.3f MeV', Q);\n", +"\n", +"// Result\n", +"// The Q-value for the formation of P30 = 3.309 MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 10.2: Q_value_of_the_reaction_and_atomic_mass_of_the_residual_nucleus.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa10.2 : : Page-455 (2011) \n", +"clc; clear;\n", +"E_x = 7.70; // Energy of the alpha particle, MeV\n", +"E_y = 4.44; // Energy of the proton, MeV\n", +"m_x = 4.0; // Mass number of alpha particle\n", +"m_y = 1.0; // Mass number of protium ion\n", +"M_X = 14; // Mass number of nitrogen nucleus\n", +"M_Y = 17; // Mass number of oxygen nucleus\n", +"theta = 90*3.14/180; // Angle between incident beam direction and emitted proton, degree\n", +"A_x = 4.0026033; // Atomic mass of alpha particle, u\n", +"A_X = 14.0030742; // Atomic mass of nitrogen nucleus, u\n", +"A_y = 1.0078252; // Atomic mass of proton, u\n", +"Q = ((E_y*(1+m_y/M_Y))-(E_x*(1-m_x/M_Y))-2/M_Y*sqrt((m_x*m_y*E_x*E_y))*cos(theta))/931.5; // Q-value, u\n", +"A_Y = A_x+A_X-A_y-Q; // Atomic mass of O-17, u\n", +"printf('\nThe Q-value of the reaction = %9.7f u \nThe atomic mass of the O-17 = %10.7f u', Q, A_Y);\n", +"\n", +"// Result\n", +"// The Q-value of the reaction = -0.0012755 u \n", +"// The atomic mass of the O-17 = 16.9991278 u \n", +"// Atomic mass of the O-17 : 16.9991278 u " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 10.3: Kinetic_energy_of_the_neutrons_emitted_at_given_angle_to_the_incident_beam.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa10.3 : : Page-455 (2011) \n", +"clc; clear;\n", +"m_p = 1.007276; // Atomic mass of the proton, u\n", +"m_H = 3.016049; // Atomic mass of the tritium, u \n", +"m_He = 3.016029; // Atomic mass of the He ion, u \n", +"m_n = 1.008665; // Atomic mass of the emitted neutron, u\n", +"Q = (m_p+m_H-m_He-m_n)*931.5; // Q-value in MeV\n", +"E_p = 3; // Kinetic energy of the proton, MeV \n", +"theta = 30*3.14/180; // angle, radian\n", +"u = sqrt(m_p*m_n*E_p)/(m_He+m_n)*cos(theta); //\n", +"v = ((m_He*Q)+E_p*(m_He-m_p))/(m_He+m_n); //\n", +"E_n = (u+sqrt(u^2+v))^2; // Kinetic energy of the emitted neutron,MeV\n", +"printf('\nThe kinetic energy of the emitted neutron = %5.3f MeV', E_n);\n", +"\n", +"// Result\n", +"// The kinetic energy of the emitted neutron = 1.445 MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 10.4: Estimating_the_temperature_of_nuclear_fusion_reaction.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa10.4 : : Page-456 (2011) \n", +"clc; clear;\n", +"r_min = 4e-015; // Distance between two deutrons, metre\n", +"k = 1.3806504e-023; // Boltzmann's constant, Joule per kelvin\n", +"alpha = 1/137; // Fine structure constant\n", +"h_red = 1.05457168e-034; // Reduced planck's constant, Joule sec\n", +"C = 3e+08; // Velocity of light, meter per second\n", +"T = alpha*h_red*C/(r_min*k);\n", +"printf('\nThe temperature in the fusion reaction is = %3.1e K', T);\n", +"\n", +"// Result\n", +"// The temperature in the fusion reaction is = 4.2e+009 K " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 10.5: Excitation_energy_of_the_compound_nucleus.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa11.5 : : Page-456 (2011) \n", +"clc; clear;\n", +"E_0 = 4.99; // Energy of the proton, MeV \n", +"m_p = 1; // Mass number of the proton\n", +"m_F = 19; // Mass number of the flourine\n", +"E = E_0/(1+m_p/m_F); // Energy of the relative motion, MeV\n", +"A_F = 18.998405; // Atomic mass of the fluorine, amu\n", +"A_H = 1.007276; // Atomic mass of the proton, amu\n", +"A_Ne = 19.992440; // Atomic mass of the neon, amu\n", +"del_E = (A_F+A_H-A_Ne)*931.5; // Binding energy of the absorbed proton, MeV\n", +"E_exc = E+del_E; // Excitation energy of the compound nucleus, MeV\n", +"printf('\nThe excitation energy of the compound nucleus = %6.3f MeV', E_exc);\n", +"\n", +"// Result\n", +"// The excitation energy of the compound nucleus = 17.074 MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 10.6: Excitation_energy_and_parity_for_compound_nucleus.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa10.6 : : Page-457 (2011) \n", +"clc; clear;\n", +"E_d = 0.6; // Energy of the deutron, MeV \n", +"m_d = 2; // Mass number of the deutron\n", +"m_Li = 19; // Mass number of the Lithium\n", +"E = E_d/(1+m_d/m_Li); // Energy of the relative motion, MeV\n", +"A_Li = 6.017; // Atomic mass of the Lithium, amu\n", +"A_d = 2.015; // Atomic mass of the deutron, amu\n", +"A_Be = 8.008; // Atomic mass of the Beryllium, amu\n", +"del_E = (A_Li+A_d-A_Be)*931.5; // Binding energy of the absorbed proton, MeV\n", +"E_exc = E+del_E; // Excitation energy of the compound nucleus, MeV\n", +"l_f = 2; // orbital angular momentum of two alpha particle\n", +"P = (-1)^l_f*(+1)^2; // Parity of the compound nucleus\n", +"printf('\nThe excitation energy of the compound nucleus = %6.3f MeV\nThe parity of the compound nucleus = %d', E_exc, P);\n", +"\n", +"// Result\n", +"// The excitation energy of the compound nucleus = 22.899 MeV\n", +"// The parity of the compound nucleus = 1 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 10.7: Cross_section_for_neutron_induced_fission.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa10.7 : : Page-457 (2011)\n", +"clc; clear;\n", +"lambda = 1e-016; // Disintegration constant, per sec\n", +"phi = 10^11; // Neutron flux, neutrons per square cm per sec\n", +"sigma = 5*lambda/(phi*10^-27); // Cross section, milli barns\n", +"printf('\nThe cross section for neutron induced fission = %d milli barns', sigma);\n", +"// Result\n", +"// The cross section for neutron induced fission = 5 milli barns " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 10.8: Irradiance_of_neutron_beam_with_the_thin_sheet_of_Co59.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa10.8 : : Page-457 (2011)\n", +"clc; clear;\n", +"N_0 = 6.02252e+026; // Avogadro's constant \n", +"rho = 8.9*10^3; // Nuclear density of Co-59, Kg per cubic metre\n", +"M = 59; // Mass number\n", +"sigma = 30e-028; // Cross section, per square metre\n", +"phi = 10^16; // Neutron flux, neutrons per square metre per sec\n", +"d = 0.04e-02; // Thickness of Co-59 sheet, metre\n", +"t = 3*60*60; // Total reaction time, sec\n", +"t_half = 5.2*365*86400; // Half life of Co-60, sec \n", +"lambda = 0.693/t_half; // Disintegration constant, per sec\n", +"N_nuclei = round(N_0*rho/M*sigma*phi*d*t); // Number of nuclei of Co-60 produced\n", +"Init_activity = lambda*N_nuclei; // Initial activity, decays per sec\n", +"printf('\nThe number of nuclei of Co60 produced = %5.2e \nThe initial activity per Sq. metre = %1.0g decays per sec', N_nuclei, Init_activity);\n", +"// Result\n", +"// The number of nuclei of Co60 produced = 1.18e+019 \n", +"// The initial activity per Sq. metre = 5e+010 decays per sec " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 10.9: Bombardment_of_protons_on_Fe54_target.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa10.9 : : Page-458 (2011)\n", +"clc; clear;\n", +"d = 0.1; // Thickness of Fe-54 sheet, Kg per squre metre\n", +"M = 54; // Mass number of Fe \n", +"m = 1.66e-027; // Mass of the proton, Kg\n", +"n = d/(M*m); // Number of nuclei in unit area of the target, nuclei per square metre\n", +"ds = 10^-5; // Area, metre square\n", +"r = 0.1; // Distance between detector and target foil, metre\n", +"d_omega =ds/r^2; // Solid angle, steradian\n", +"d_sigma = 1.3e-03*10^-3*10^-28; // Differential cross section, square metre per nuclei\n", +"P = d_sigma*n; // Probablity, event per proton\n", +"I = 10^-7; // Current, ampere\n", +"e = 1.6e-19; // Charge of the proton, C\n", +"N = I/e; // Number of protons per second in the incident beam, proton per sec\n", +"dN = P*N; // Number of events detected per second, events per sec\n", +"printf('\nThe number of events detected = %d events per sec', dN);\n", +"// Result\n", +"// The number of events detected = 90 events per sec " + ] + } +], +"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/Nuclear_Physics_by_D_C_Tayal/11-Particle_Accelerators.ipynb b/Nuclear_Physics_by_D_C_Tayal/11-Particle_Accelerators.ipynb new file mode 100644 index 0000000..74f6461 --- /dev/null +++ b/Nuclear_Physics_by_D_C_Tayal/11-Particle_Accelerators.ipynb @@ -0,0 +1,457 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 11: Particle Accelerators" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 11.10: Electrons_accelerated_in_electron_synchrotron.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa11.10 : : Page-538 (2011)\n", +"clc; clear;\n", +"e = 1.6023e-19; // Charge of an electron, C\n", +"E = 70*1.6e-13; // Energy, electron volts\n", +"R = 0.28; // Radius of the orbit, metre\n", +"c = 3e+08; // Velocity of light, metre per sec\n", +"B = E/(e*R*c); // Magnetic field intensity, tesla\n", +"f = e*B*c^2/(2*%pi*E); // Frequency, cycle per sec\n", +"del_E = 88.5*(0.07)^4*10^3/(R); // Energy radiated by an electron, electron volts\n", +" printf('\nThe frequency of the applied electric field = %5.3e cycles per sec \nThe magnetic field intensity = %4.3f tesla\nThe energy radiated by the electron = %3.1f eV', f, B, del_E);\n", +"// Result\n", +"// The frequency of the applied electric field = 1.705e+008 cycles per sec \n", +"// The magnetic field intensity = 0.832 tesla\n", +"// The energy radiated by the electron = 7.6 eV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 11.11: Kinetic_energy_of_the_accelerated_nitrogen_ion.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa11.11 : : Page-538 (2011)\n", +"clc; clear;\n", +"E = 3; // Energy of proton synchrotron, giga electron volts\n", +"m_0_c_sq = 0.938; // Relativistic energy, mega electron volts\n", +"P_p = sqrt(E^2-m_0_c_sq^2); // Momentum of the proton, giga electron volts per c\n", +"P_n = 6*P_p; // Momentum of the N(14) ions, giga electron volts\n", +"T_n = sqrt(P_n^2+(0.938*14)^2)-0.938*14; // Kinetic energy of the accelerated nitrogen ion\n", +" printf('\nThe kinetic energy of the accelerated nitrogen ion = %4.2f MeV', T_n);\n", +"// Result\n", +"// The kinetic energy of the accelerated nitrogen ion = 8.43 MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 11.12: EX11_12.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa11.12 : : Page-539 (2011)\n", +"clc; clear;\n", +"e = 1.6e-19; // Charge of an electron, C\n", +"R = 9.144; // Radius, metre\n", +"m_p = 1.67e-027; // Mass of the proton, Kg\n", +"E = 3.6*1.6e-13; // Energy, joule\n", +"L = 3.048; // Length of the one synchrotron section, metre \n", +"T = 3; // Kinetic energy, giga electron volts\n", +"c = 3e+08; // Velocity of the light, metre per sec\n", +"m_0_c_sq = 0.938; // Relativistic energy, mega electron volts\n", +"B = round (sqrt(2*m_p*E)/(R*e)*10^4); // Maximum magnetic field density, web per square metre\n", +"v = B*10^-4*e*R/m_p; // Velocity of the proton, metre per sec\n", +"f_c = v/(2*%pi*R*10^6); // Frequency of the circular orbit, mega cycles per sec\n", +"f_0 = 2*%pi*R*f_c*10^3/(2*%pi*R+4*L); // Reduced frequency, kilo cycles per sec\n", +"B_m = 3.33*sqrt(T*(T+2*m_0_c_sq))/R; // Relativistic field, web per square metre\n", +"f_0 = c^2*e*R*B*1e-004/((2*%pi*R+4*L)*(T+m_0_c_sq)*e*1e+015); // Maximum frequency of the accelerating voltage, mega cycles per sec\n", +" printf('\nThe maximum magnetic flux density = %5.3f weber/Sq.m\nThe maximum frequency of the accelerating voltage = %4.2f MHz', B_m, f_0);\n", +" \n", +"// Result\n", +"// The maximum magnetic flux density = 1.393 weber/Sq.m\n", +"// The maximum frequency of the accelerating voltage = 0.09 MHz\n", +"// Answer is given wrongly in the textbook " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 11.13: Energy_of_the_single_proton_in_the_colliding_beam.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa11.13 : : Page-539 (2011)\n", +"clc; clear;\n", +"E_c = 30e+009; // Energy of the proton accelerator, GeV\n", +"m_0_c_sq = 0.938*10^6; // Relativistic energy, GeV\n", +"E_p = (4*E_c^2-2*m_0_c_sq^2)/(2*m_0_c_sq) ; // Energy of the proton, GeV\n", +"printf('\nThe energy of the proton = %5.2e GeV', E_p/1e+009);\n", +" \n", +"// Result\n", +"// The energy of the proton = 1.92e+006 GeV \n", +"// Wrong answer given in the textbook" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 11.14: Energy_of_the_electron_during_boson_production.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa11.14 : : Page-539 (2011)\n", +"clc; clear;\n", +"M_z = 92; // Mass of the boson,giga electron volts\n", +"E_e = M_z/2; // Energy of the electron,giga electron volts\n", +"c = 3e+08; // Velocity of the light, metre per second\n", +"m_e = 9.1e-31*c^2/(1.6e-019*1e+009); // Mass of electron, giga electron volts\n", +"E_e_plus = M_z^2/(2*m_e); // Threshold energy for the positron, giga electron volts \n", +" printf('\nThe energy of the electron = %d GeV\nThe threshold energy of the positron = %4.2e GeV', E_e, E_e_plus);\n", +" \n", +"// Result\n", +"// The energy of the electron = 46 GeV\n", +"// The threshold energy of the positron = 8.27e+006 GeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 11.1: Optimum_number_of_stages_and_ripple_voltage_in_Cockcroft_Walton_accelerator.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa11.1 : : Page-535(2011) \n", +"clc; clear;\n", +"V_0 = 10^5; // Accelerating voltage, volts\n", +"C = 0.02e-006; // Capacitance, farad\n", +"I = 4*1e-003; // Current, ampere\n", +"f = 200; // Frequency, cycles per sec\n", +"n = sqrt (V_0*f*C/I); // Number of particles\n", +"delta_V = I*n*(n+1)/(4*f*C);\n", +"printf('\nThe optimum number of stages in the accelerator = %d', n);\n", +"printf('\nThe ripple voltage = %4.1f kV', delta_V/1e+003);\n", +"// Result\n", +"// The optimum number of stages in the accelerator = 10\n", +"// The ripple voltage = 27.5 kV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 11.2: Charging_current_and_potential_of_an_electrostatic_generator.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa11.2 : : Page-536 (2011)\n", +"clc; clear;\n", +"s = 15; // Speed, metre per sec\n", +"w = 0.3; // Width of the electrode, metre\n", +"E = 3e+06; // Breakdown strength, volts per metre\n", +"eps = 8.85e-12; // Absolute permitivity of free space, farad per metre\n", +"C = 111e-12; // Capacitance, farad\n", +"i = round (2*eps*E*s*w*10^6); // Current, micro ampere\n", +"V = i/C*10^-12; // Rate of rise of electrode potential, mega volts per sec\n", +"printf('\nThe charging current = %d micro-ampere \nThe rate of rise of electrode potential = %4.2f MV/sec', i, V);\n", +"// Result\n", +"// The charging current = 239 micro-ampere \n", +"// The rate of rise of electrode potential = 2.15 MV/sec " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 11.3: Linear_proton_accelerator.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa11.3 : : Page-536 (2011)\n", +"clc; clear;\n", +"f = 200*10^6; // Frequency of the accelerator, cycle per sec\n", +"M = 1.6724e-27; // Mass of the proton, Kg\n", +"E = 45.3*1.6e-13; // Accelerating energy, joule\n", +"L_f = round (1/f*sqrt(2*E/M)*100); // Length of the final drift tube, centi metre\n", +"L_1 = 5.35*10^-2; // Length of the first drift tube, metre\n", +"K_E = (1/2*M*L_1^2*f^2)/1.6e-13; // Kinetic energy of the injected proton, MeV\n", +"E_inc = E/1.6e-13-K_E; // Increase in energy, MeV\n", +"q = 1.6e-19; // Charge of the proton, C\n", +"V = 1.49e+06; // Accelerating voltage, volts\n", +"N = E_inc*1.6e-13/(q*V); // Number of drift protons\n", +"L = 1/f*sqrt(2*q*V/M)*integrate('n^(1/2)', 'n', 0, N); // Total length of the accelerator, metre\n", +"printf('\nThe length of the final drift tube = %d cm\nThe kinetic energy of the injected protons = %4.2f MeV\nThe total length of the accelerator = %3.1f metre', L_f, K_E, L);\n", +"// Result\n", +"// The length of the final drift tube = 47 cm\n", +"// The kinetic energy of the injected protons = 0.60 MeV\n", +"// The total length of the accelerator = 9.2 metre " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 11.5: Energy_and_the_frequency_of_deuterons_accelerated_in_cyclotron.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa11.5 : : Page-536 (2011)\n", +"clc; clear;\n", +"B = 1.4; // Magnetic field, tesla\n", +"R = 88e-002; // Radius of the orbit, metre\n", +"q = 1.6023e-019; // Charge of the deutron, C\n", +"M_d = 2.014102*1.66e-27; // Mass of the deutron, Kg\n", +"M_He = 4.002603*1.66e-27; // Mass of the He ion, Kg\n", +"E = B^2*R^2*q^2/(2*M_d*1.6e-13); // Energy og the emerging deutron, mega electron volts\n", +"f = B*q/(2*%pi*M_d)*10^-6; // Frequency of the deutron voltage, mega cycles per sec\n", +"B_He = 2*%pi*M_He*f*10^6/(2*q); // Magnetic field required for He(++) ions, weber per square metre\n", +"B_change = B-B_He; // Change in magnetic field, tesla\n", +"printf('\nThe energy of the emerging deutron = %4.1f MeV\nThe frequency of the dee voltage = %5.2f MHz\nThe change in magnetic field = %4.2f tesla', E, f, B_change);\n", +"// Result\n", +"// The energy of the emerging deutron = 36.4 MeV\n", +"// The frequency of the dee voltage = 10.68 MHz\n", +"// The change in magnetic field = 0.01 tesla " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 11.6: Protons_extracted_from_a_cyclotron.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa11.6: : Page-537 (2011)\n", +"clc; clear;\n", +"K_E = 7.5*1.6023e-13; // Kinetic energy, joule \n", +"r = 0.51; // Radius of the proton's orbit, metre\n", +"E = 5*10^6; // Electric field, volts per metre\n", +"m = 1.67e-27; // Mass of the proton, Kg\n", +"q = 1.6023e-19; // Charge of the proton, C\n", +"v = sqrt(2*K_E/m); // Velocity of the proton, metre per sec\n", +"B_red = E/v; // The effective reduction in magnetic field, tesla\n", +"B = m*v/(q*r); // Total magnetic field produced, tesla\n", +"r_change = r*B_red/B; // The change in orbit radius, metre\n", +" printf('\nThe effective reduction in magnetic field = %5.3f tesla \nThe change in orbit radius = %5.3f metre ', B_red, r_change);\n", +"// Result\n", +"// The effective reduction in magnetic field = 0.132 tesla \n", +"// The change in orbit radius = 0.087 metre " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 11.7: Energy_of_the_electrons_in_a_betatron.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa11.7 : : Page-537 (2011)\n", +"clc; clear;\n", +"B = 0.4; // Magnetic field, tesla\n", +"e = 1.6203e-19; // Charge of an electron, C\n", +"R = 30*2.54e-02; // Radius, metre\n", +"c = 3e+08; // Capacitance, farad\n", +"E = B*e*R*c/1.6e-13; // The energy of the electron, mega electron volts\n", +"f = 50; // Frequency, cycles per sec\n", +"N = c/(4*2*%pi*f*R); // Total number of revolutions\n", +"Avg_E_per_rev = E*1e+006/N; // Average energy gained per revolution, electron volt\n", +"printf('\nThe energy of the electron = %4.1f MeV\nThe average energy gained per revolution = %6.2f eV', E, Avg_E_per_rev);\n", +"// Result\n", +"// The energy of the electron = 92.6 MeV\n", +"// The average energy gained per revolution = 295.57 eV \n", +"// Note: Wrong answer is given in the textbook \n", +"// Average energy gained per revolution : 295.57 electron volts" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 11.8: Electrons_accelerated_into_betatron.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa11.8 : : Page-537 (2011)\n", +"clc; clear;\n", +"R = 0.35; // Orbit radius, metre\n", +"N = 100e+06/480; // Total number of revolutions\n", +"L = 2*%pi*R*N; // Distance traversed by the electron, metre\n", +"t = 2e-06; // Pulse duration, sec\n", +"e = 1.6203e-19; // Charge of an electron, C\n", +"n = 3e+09; // Number of electrons\n", +"f = 180; // frequency, hertz\n", +"I_p = n*e/t; // Peak current, ampere\n", +"I_avg = n*e*f; // Average current, ampere \n", +"tau = t*f; // Duty cycle\n", +" printf('\nThe peak current = %3.1e ampere \nThe average current = %4.2e ampere \nThe duty cycle = %3.1e', I_p, I_avg, tau);\n", +"// Result\n", +"// The peak current = 2.4e-004 ampere \n", +"// The average current = 8.75e-008 ampere \n", +"// The duty cycle = 3.6e-004 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 11.9: Deuterons_accelerated_in_synchrocyclotron.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa11.9 : : Page-538 (2011)\n", +"clc; clear;\n", +"q = 1.6023e-19; // Charge of an electron, C\n", +"B_0 = 1.5; // Magnetic field at the centre, tesla\n", +"m_d = 2.014102*1.66e-27; // Mass of the deutron, Kg\n", +"f_max = B_0*q/(2*%pi*m_d*10^6); // Maximum frequency of the dee voltage, mega cycles per sec\n", +"B_prime = 1.4310; // Magnetic field at the periphery of the dee, tesla\n", +"f_prime = 10^7; // Frequency, cycles per sec\n", +"c = 3e+08; // Velocity of the light, metre per sec\n", +"M = B_prime*q/(2*%pi*f_prime*1.66e-27); // Relativistic mass, u\n", +"K_E = (M-m_d/1.66e-27)*931.5; // Kinetic energy of the particle, mega electron volts\n", +" printf('\nThe maximum frequency of the dee voltage = %5.2f MHz\nThe kinetic energy of the deuteron = %5.1f MeV', f_max, K_E);\n", +" \n", +"// Result\n", +"// The maximum frequency of the dee voltage = 11.44 MHz\n", +"// The kinetic energy of the deuteron = 171.6 MeV " + ] + } +], +"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/Nuclear_Physics_by_D_C_Tayal/12-Neutrons.ipynb b/Nuclear_Physics_by_D_C_Tayal/12-Neutrons.ipynb new file mode 100644 index 0000000..9caa48f --- /dev/null +++ b/Nuclear_Physics_by_D_C_Tayal/12-Neutrons.ipynb @@ -0,0 +1,376 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 12: Neutrons" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 12.10: Energy_of_the_neutrons_reflected_from_the_crystal.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa12.10 : : Page-576 (2011)\n", +"clc; clear;\n", +"theta = 3.5*%pi/180; // Reflection angle, radian\n", +"d = 2.3e-10; // Lattice spacing, metre\n", +"n = 1; // For first order\n", +"h = 6.6256e-34; // Planck's constant, joule sec\n", +"m = 1.6748e-27; // Mass of the neutron, Kg\n", +"E = n^2*h^2/(8*m*d^2*sin(theta)^2*1.6023e-19); // Energy of the neutrons, electron volts\n", +"printf('\nThe energy of the neutrons = %4.2f eV', E);\n", +"// Result\n", +"// The energy of the neutrons = 1.04 eV \n", +" " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 12.1: Maximum_activity_induced_in_100_mg_of_Cu_foil.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa12.1 : : Page-573 (2011)\n", +"clc; clear; \n", +"N_0 = 6.23e+23; // Avogadro's number, per mole\n", +"m = 0.1; // Mass of copper foil, Kg\n", +"phi = 10^12; // Neutron flux density, per square centimetre sec\n", +"a_63 = 0.691; // Abundance of Cu-63\n", +"a_65 = 0.309; // Abundance of Cu-65\n", +"W_m = 63.57; // Molecular weight, gram\n", +"sigma_63 = 4.5e-24; // Activation cross section for Cu-63, square centi metre\n", +"sigma_65 = 2.3e-24; // Activation cross section for Cu-65, square centi metre\n", +"A_63 = phi*sigma_63*m*a_63/W_m*N_0; // Activity for Cu-63, disintegrations per sec\n", +"A_65 = phi*sigma_65*m*a_65/W_m*N_0; // Activity for Cu-65, disintegrations per sec\n", +"printf('\nThe activity for Cu-63 is = %4.3e disintegrations per sec \nThe activity for Cu-65 is = %4.2e disintegrations per sec', A_63, A_65);\n", +"// Result\n", +"// The activity for Cu-63 is = 3.047e+009 disintegrations per sec \n", +"// The activity for Cu-65 is = 6.97e+008 disintegrations per sec " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 12.2: Energy_loss_during_neutron_scattering.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa12.2 : : Page-573 (2011)\n", +"clc; clear; \n", +"A_Be = 9; // Mass number of beryllium\n", +"A_U = 238; // Mass number of uranium\n", +"E_los_Be = (1-((A_Be-1)^2/(A_Be+1)^2))*100; // Energy loss for beryllium\n", +"E_los_U = round((1-((A_U-1)^2/(A_U+1)^2))*100); // Energy loss for uranium\n", +"printf('\nThe energy loss for beryllium is = %d percent \nThe energy loss for uranium is = %d percent', E_los_Be, E_los_U);\n", +"// Check for greater energy loss !!!!\n", +"if E_los_Be >= E_los_U then\n", +" printf('\nThe energy loss is greater for beryllium');\n", +"else\n", +" printf('\nThe energy loss is greater for uranium');\n", +"end\n", +"// Result\n", +"// The energy loss for beryllium is = 36 percent \n", +"// The energy loss for uranium is = 2 percent\n", +"// The energy loss is greater for beryllium \n", +" " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 12.3: Energy_loss_of_neutron_during_collision_with_carbon.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa12.3 : : Page-574 (2011)\n", +"clc; clear; \n", +"A = 12; // Mass number of Carbon\n", +"alpha = (A-1)^2/(A+1)^2; // Scattering coefficient\n", +"E_loss = 1/2*(1-alpha)*100; // Energy loss of neutron\n", +"printf('\nThe energy loss of neutron = %5.3f percent',E_loss)\n", +"// Result\n", +"// The energy loss of neutron = 14.201 percent \n", +" " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 12.4: Number_of_collisions_for_neutron_loss.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa12.4 : : Page-574 (2011)\n", +"clc; clear; \n", +"zeta = 0.209; // Moderated assembly\n", +"E_change = 100/1; // Change in energy of the neutron\n", +"E_thermal = 0.025; // Thermal energy of the neutron, electron volts\n", +"E_n = 2*10^6; // Energy of the neutron, electron volts\n", +"n = 1/zeta*log(E_change); // Number of collisions of neutrons to loss 99 percent of their energies \n", +"n_thermal = 1/zeta*log(E_n/E_thermal); // Number of collisions of neutrons to reach thermal energies\n", +"printf('\nThe number of collisions of neutrons to loss 99 percent of their energies = %d \nThe number of collisions of neutrons to reach thermal energies = %d',n,n_thermal)\n", +"// Result\n", +"// The number of collisions of neutrons to loss 99 percent of their energies = 22 \n", +"// The number of collisions of neutrons to reach thermal energies = 87 \n", +" " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 12.5: Average_distance_travelled_by_a_neutron.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa12.5 : : Page-574 (2011)\n", +"clc; clear;\n", +"L = 1; // For simplicity assume thermal diffusion length to be unity, unit\n", +"x_bar = integrate('x*exp(-x/L)', 'x', 0, 100); // Average distance travelled by the neutron, unit\n", +"x_rms = sqrt(integrate('x^2*exp(-x/L)', 'x', 0, 100)); // Root mean square of the distance trvelled by the neutron, unit\n", +"printf('\nThe average distance travelled by the neutron = %d*L', x_bar);\n", +"printf('\nThe root mean square distance travelled by the neutron = %5.3fL = %5.3fx_bar', x_rms, x_rms);\n", +"// Result\n", +"// The average distance travelled by the neutron = 1*L\n", +"// The root mean square distance travelled by the neutron = 1.414L = 1.414x_bar \n", +" " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 12.6: Neutron_flux_through_water_tank.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa12.6 : : Page-574 (2011)\n", +"clc; clear;\n", +"Q = 5e+08; // Rate at which neutrons produce, neutrons per sec\n", +"r = 20; // Distance from the source, centi metre\n", +"// For water\n", +"lambda_wtr = 0.45; // Transport mean free path, centi metre\n", +"L_wtr = 2.73; // Thermal diffusion length, centi metre\n", +"phi_wtr = 3*Q/(4*%pi*lambda_wtr*r)*exp(-r/L_wtr); // Neutron flux for water, neutrons per square centimetre per sec\n", +"// For heavy water\n", +"lambda_h_wtr = 2.40; // Transport mean free path, centi metre\n", +"L_h_wtr = 171; // Thermal diffusion length, centi metre\n", +"phi_h_wtr = 3*Q/(4*%pi*lambda_h_wtr*r)*exp(-r/L_h_wtr); // Neutron flux for heavy water, neutrons per square centimetre per sec\n", +"printf('\nThe neutron flux through water = %5.3e neutrons per square cm per sec \nThe neutron flux through heavy water = %5.3e neutrons per square cm per sec', phi_wtr, phi_h_wtr);\n", +"// Result\n", +"// The neutron flux through water = 8.730e+003 neutrons per square cm per sec \n", +"// The neutron flux through heavy water = 2.212e+006 neutrons per square cm per sec \n", +" " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 12.7: Diffusion_length_and_neutron_flux_for_thermal_neutrons.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa12.7 : : Page-575 (2011)\n", +"clc; clear;\n", +"k = 1.38e-23; // Boltzmann constant, joules per kelvin\n", +"T = 323; // Temperature, kelvin\n", +"E = (k*T)/1.6e-19; // Thermal energy, joules\n", +"sigma_0 = 13.2e-28; // Cross section, square metre\n", +"E_0 = 0.025; // Energy of the neutron, electron volts\n", +"sigma_a = sigma_0*sqrt(E_0/E); // Absorption cross section, square metre\n", +"t_half = 2.25; // Half life, hours\n", +"lambda = 0.69/t_half; // Decay constant, per hour\n", +"N_0 = 6.023e+026; // Avogadro's number, per \n", +"m_Mn = 55; // Mass number of mangnese\n", +"w = 0.1e-03; // Weight of mangnese foil, Kg\n", +"A = 200; // Activity, disintegrations per sec\n", +"N = N_0*w/m_Mn; // Number of mangnese nuclei in the foil\n", +"x1 = 1.5; // Base, metre\n", +"x2 = 2.0; // Height, metre\n", +"phi = A/(N*sigma_a*0.416); // Neutron flux, neutrons per square metre per sec\n", +"phi1 = 1; // For simplicity assume initial neutron flux to be unity, neutrons/Sq.m-sec\n", +"phi2 = 1/2*phi1; // Given neutron flux, neutrons/Sq.m-sec\n", +"L1 = 1/log(phi1/phi2)/(x2-x1); // Thermal diffusion length for given neutron flux, m\n", +"L = sqrt(1/((1/L1)^2+(%pi/x1)^2+(%pi/x2)^2)); // Diffusion length, metre\n", +"printf('\nThe neutron flux = %3.2e neutrons per square metre per sec \nThe diffusion length = %4.2f metre', phi, L);\n", +"// Result\n", +"// The neutron flux = 3.51e+008 neutrons per square metre per sec \n", +"// The diffusion length = 0.38 metre\n", +"// Note: the difussion length is solved wrongly in the testbook\n", +" " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 12.8: Diffusion_length_for_thermal_neutrons_in_graphite.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa12.8 : : Page-575(2011)\n", +"clc; clear;\n", +"N_0 = 6.023e+026; // Avogadro's number, per mole\n", +"rho = 1.62e+03; // Density, kg per cubic metre\n", +"sigma_a = 3.2e-31; // Absorption cross section, square metre\n", +"sigma_s = 4.8e-28; // Scattered cross section, square metre\n", +"A = 12; // Mass number\n", +"lambda_a = A/(N_0*rho*sigma_a); // Absorption mean free path, metre\n", +"lambda_tr = A/(N_0*rho*sigma_s*(1-2/(3*A))); // Transport mean free path, metre\n", +"L = sqrt(lambda_a*lambda_tr/3); // Diffusion length for thermal neutron\n", +"printf('\nThe diffusion length for thermal neutron = %5.3f metre ',L)\n", +"// Result\n", +"// The diffusion length for thermal neutron = 0.590 metre \n", +" " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 12.9: Neutron_age_and_slowing_down_length_of_neutrons_in_graphite_and_beryllium.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa12.9 : : Page-575 (2011)\n", +"clc; clear;\n", +"E_0 = 2e+06; // Average energy of the neutron, electron volts\n", +"E = 0.025; // Thermal energy of the neutron, electron volts\n", +"// For graphite\n", +"A = 12 // Mass number\n", +"sigma_g = 33.5; // The value of sigma for graphite\n", +"tau_0 = 1/(6*sigma_g^2)*(A+2/3)/(1-2/(3*A))*log(E_0/E); // Age of neutron for graphite, Sq.m\n", +"L_f = sqrt(tau_0); // Slowing down length of neutron through graphite, m\n", +"printf('\nFor Graphite, A = %d', A);\n", +"printf('\nNeutron age = %d Sq.cm', tau_0*1e+004);\n", +"printf('\nSlowing down length = %5.3f m', L_f);\n", +"// For beryllium\n", +"A = 9 // Mass number\n", +"sigma_b = 57; // The value of sigma for beryllium\n", +"tau_0 = 1/(6*sigma_b^2)*(A+2/3)/(1-2/(3*A))*log(E_0/E); // Age of neutron for beryllium, Sq.m\n", +"L_f = sqrt(tau_0); // Slowing down length of neutron through graphite, m\n", +"printf('\n\nFor Beryllium, A = %d', A);\n", +"printf('\nNeutron age = %d Sq.cm', tau_0*1e+004);\n", +"printf('\nSlowing down length = %3.1e m', L_f);\n", +"// Result\n", +"// For Graphite, A = 12\n", +"// Neutron age = 362 Sq.cm\n", +"// Slowing down length = 0.190 m\n", +"// For Beryllium, A = 9\n", +"// Neutron age = 97 Sq.cm\n", +"// Slowing down length = 9.9e-002 m " + ] + } +], +"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/Nuclear_Physics_by_D_C_Tayal/13-Nuclear_Fission_and_Fusion.ipynb b/Nuclear_Physics_by_D_C_Tayal/13-Nuclear_Fission_and_Fusion.ipynb new file mode 100644 index 0000000..85cb6ed --- /dev/null +++ b/Nuclear_Physics_by_D_C_Tayal/13-Nuclear_Fission_and_Fusion.ipynb @@ -0,0 +1,326 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 13: Nuclear Fission and Fusion" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 13.1: Fission_rate_and_energy_released_during_fission_of_U235.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa13.1 : : Page-600 (2011)\n", +"clc; clear;\n", +"E = 200*1.6023e-13; // Energy released per fission, joule\n", +"E_t = 2; // Total power produced, watt\n", +"R_fiss = E_t/E; // Fission rate, fissions per sec\n", +"m = 0.5; // Mass of uranium, Kg\n", +"M = 235; // Mass number of uranium\n", +"N_0 = 6.023e+26; // Avogadro's number, per mole\n", +"N = m/M*N_0 // Number of uranium nuclei\n", +"E_rel = N*E/4.08*10^-3; // Energy released, kilocalories\n", +"printf('\nThe rate of fission of U-235 = %4.2e fissions per sec \nEnergy released = %e kcal', R_fiss, E_rel);\n", +"// Result\n", +"// The rate of fission of U-235 = 6.24e+010 fissions per sec \n", +"// Energy released = 1.006535e+010 kcal " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 13.2: Number_of_free_neutrons_in_the_reactor.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa13.2 : : Page-600 (2011)\n", +"clc; clear;\n", +"E = 200*1.6e-13; // Energy released per fission, joules per neutron\n", +"t = 10^-3; // Time, sec\n", +"P = E/t; // Power produced by one free neutron, watt per neutron\n", +"P_l = 10^9; // Power level, watt\n", +"N = P_l/P; // Number of free neutrons in the reactor, neutrons\n", +"printf('\nThe number of free neutrons in the reactor = %5.3e neutrons', N);\n", +"// Result\n", +"// The number of free neutrons in the reactor = 3.125e+016 neutrons " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 13.3: Number_of_neutrons_released_per_absorption.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa13.3 : : Page-600 (2011)\n", +"clc; clear;\n", +"N_0_235 = 1; // Number of uranium 235 per 238 \n", +"N_0_238 = 20; // Number of uranium 238 for one uranium 235 \n", +"sigma_a_235 = 683; // Absorption cross section for uranium 235, barn\n", +"sigma_a_238 = 2.73; // Absorption cross section for uranium 238, barn\n", +"sigma_f_235 = 583; // Fission cross section, barn\n", +"sigma_a = (N_0_235*sigma_a_235+N_0_238*sigma_a_238)/(N_0_235+N_0_238); //Asorption cross sec, barn\n", +"sigma_f = N_0_235*sigma_f_235/(N_0_235+N_0_238); // Fisssion cross section \n", +"v = 2.43;\n", +"eta = v*sigma_f/sigma_a; // Average number of neutron released per absorption\n", +"printf('\nThe average number of neutrons released per absorption = %5.3f', eta);\n", +"// Result\n", +"// The average number of neutrons released per absorption = 1.921 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 13.4: Excitation_energy_for_uranium_isotopes.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa13.4 : : Page-600(2011)\n", +"clc; clear;\n", +"a_v = 14.0; // Volume binding energy constant, mega electron volts\n", +"a_s = 13.0; // Surface binding energy constant, mega electron volts\n", +"a_c = 0.583; // Coulomb constant, mega electron volts\n", +"a_a = 19.3; // Asymmetric constant, mega electron volts\n", +"a_p = 33.5; // Pairing energy constant, mega electron volts\n", +"Z = 92; // Atomic number \n", +"// For U-236\n", +"A = 235; // Mass number\n", +"E_exc_236 = a_v*(A+1-A)-a_s*((A+1)^(2/3)-A^(2/3))-a_c*(Z^2/(A+1)^(1/3)-Z^2/A^(1/3))-a_a*((A+1-2*Z)^2/(A+1)-(A-2*Z)^2/A)+a_p*(A+1)^(-3/4); // Excitation energy for uranium 236, mega electron volts\n", +"// For U-239\n", +"A = 238; // Mass number\n", +"E_exc_239 = a_v*(A+1-A)-a_s*((A+1)^(2/3)-A^(2/3))-a_c*(Z^2/(A+1)^(1/3)-Z^2/A^(1/3))-a_a*((A+1-2*Z)^2/(A+1)-(A-2*Z)^2/A)+a_p*((A+1)^(-3/4)-A^(-3/4)); // Excitation energy for uranium 239\n", +"// Now calculate the rate of spontaneous fissioning for U-235\n", +"N_0 = 6.02214e+23; // Avogadro's constant, per mole\n", +"M = 235; // Mass number\n", +"t_half = 3e+17*3.15e+7; // Half life, years \n", +"lambda = 0.693/t_half; // Decay constant, per year\n", +"N = N_0/M; // Mass of uranium 235, Kg\n", +"dN_dt = N*lambda*3600; // Rate of spontaneous fissioning of uranium 235, per hour\n", +"printf('\nThe excitation energy for uranium 236 = %3.1f MeV\nThe excitation energy for uranium 239 = %3.1f MeV\nThe rate of spontaneous fissioning of uranium 235 = %4.2f per hour', E_exc_236, E_exc_239, dN_dt);\n", +"// Result\n", +"// The excitation energy for uranium 236 = 6.8 MeV\n", +"// The excitation energy for uranium 239 = 5.9 MeV\n", +"// The rate of spontaneous fissioning of uranium 235 = 0.68 per hour \n", +" " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 13.5: Total_energy_released_in_fusion_reaction.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa13.5 : : Page-601 (2011)\n", +"clc; clear; \n", +"a = 10^5; // Area of the lake, square mile\n", +"d = 1/20; // Depth of the lake, mile\n", +"V = a*d*(1.6e+03)^3; // Volume of the lake, cubic metre\n", +"rho = 10^3; // Density of water, kg per cubic metre\n", +"M_water = V*rho; // Total mass of water in the lake, Kg\n", +"N_0 = 6.02214e+26; // Avogadro's constant, per mole\n", +"A = 18; // Milecular mass of water\n", +"N = M_water*N_0/A; // Number of molecules of water, molecules\n", +"abund_det = 0.0156e-02; // Abundance of deterium\n", +"N_d = N*2*abund_det; // Number of deterium atoms\n", +"E_per_det = 43/6; // Energy released per deterium atom, mega electron volts\n", +"E_t = N_d*E_per_det; // Total energy released during fusion, mega electron volt\n", +"printf('\nThe total energy released during fusion = %4.2e MeV', E_t);\n", +"// Result\n", +"// Total energy released during fusion = 1.53e+039 MeV\n", +" " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 13.6: Maximum_temperature_attained_by_thermonuclear_device.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa13.6 : : Page-601 (2011)\n", +"clc; clear; \n", +"r = 1/2; // Radius of the tube, metre\n", +"a = %pi*r^2; // Area of the torus, square metre\n", +"V = 3*%pi*a; // Volume of the torus, cubic metre\n", +"P = 10^-5*13.6e+3*9.81; // Pressure of the gas, newton per square metre\n", +"C = 1200e-6; // Capacitance, farad\n", +"v = 4e+4; // potential, volts\n", +"T_room = 293; // Room temperature, kelvin\n", +"N_k = P*V/T_room; // From gas equation\n", +"E = 1/2*C*v^2; // Energy stored, joules\n", +"T_k = 1/6*E/(N_k*10); // Temperature attained by thermonuclear device, kelvin\n", +"printf('\nThe temperature attained by thermonuclear device = %4.2e K', T_k);\n", +"// Result\n", +"// The temperature attained by thermonuclear device = 4.75e+005 K \n", +" " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 13.7: Energy_radiated_and_the_temperature_of_the_sun.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa13.7 : : Page-601 (2011)\n", +"clc; clear; \n", +"G = 6.67e-11; // Gravitational constant, newton square m per square kg\n", +"r = 7e+08; // Radius of the sun, metre\n", +"M_0 = 2e+30; // Mass of the sun, kg\n", +"E_rel = 3/5*G*M_0^2/r; // Energy released by the sun, joule\n", +"E_dia_shrink_10 = E_rel/9; // Energy released when sun diameter shrink by 10 percent, joule\n", +"R = 8.314; // Universal gas constant, joule per kelvin per kelvin per mole\n", +"T = E_rel/(M_0*R); // Temperature of the sun, kelvin\n", +"printf('\nThe energy released by the sun = %4.2e joule \nThe energy released when sun diameter is shrinked by 10 percent = %4.2e joule \nThe temperature of the sun = %4.2e kelvin ',E_rel, E_dia_shrink_10, T);\n", +"// Result\n", +"// The energy released by the sun = 2.29e+041 joule \n", +"// The energy released when sun diameter is shrinked by 10 percent = 2.54e+040 joule \n", +"// The temperature of the sun = 1.38e+010 kelvin \n", +" " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 13.8: Estimating_the_Q_value_for_symmetric_fission_of_a_nucleus.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa13.8 : : Page-602 (2011)\n", +"clc; clear;\n", +"A_0 = 240; // Mass number of parent nucleus\n", +"A_1 = 120; // Mass number of daughter nucleus\n", +"B_120 = 8.5; // Binding energy of daughter nucleus\n", +"B_240 = 7.6; // Binding energy of parent nucleus\n", +"Q = 2*A_1*B_120-A_0*B_240; // Estimated Q-value, mega electron volts\n", +"printf('\nThe estimated Q-value is = %d MeV', Q);\n", +"// Result\n", +"// The estimated Q-value is = 216 MeV \n", +" " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 13.9: Estimating_the_asymmetric_binding_energy_term.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa13.9 : : Page-602 (2011)\n", +"clc; clear;\n", +"E = 31.7; // Energy, MeV\n", +"a_a = 5/9*2^(-2/3)*E; // Asymmetric binding energy term, mega electron volts\n", +"printf('\nThe asymmetric binding energy term = %4.1f MeV', a_a);\n", +"// Result\n", +"// The asymmetric binding energy term = 11.1 MeV \n", +" " + ] + } +], +"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/Nuclear_Physics_by_D_C_Tayal/15-Nuclear_Fission_Reactors.ipynb b/Nuclear_Physics_by_D_C_Tayal/15-Nuclear_Fission_Reactors.ipynb new file mode 100644 index 0000000..5eeb404 --- /dev/null +++ b/Nuclear_Physics_by_D_C_Tayal/15-Nuclear_Fission_Reactors.ipynb @@ -0,0 +1,306 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 15: Nuclear Fission Reactors" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 15.1: Estimation_of_the_leakage_factor_for_thermal_reactor.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa15.1 : : Page-652 (2011)\n", +"clc; clear;\n", +"N_0_235 = 1; // Number of uranium atom\n", +"N_0_c = 10^5; // Number of graphite atoms per uranium atom\n", +"sigma_a_235 = 698; // Absorption cross section for uranium, barns\n", +"sigma_a_c = 0.003; // Absorption cross section for graphite, barns\n", +"f = N_0_235*sigma_a_235/(N_0_235*sigma_a_235+N_0_c*sigma_a_c ); // Thermal utilization factor\n", +"eta = 2.08; // Number of fast fission neutron produced\n", +"k_inf = eta*f; // Multiplication factor\n", +"L_m = 0.54; // Material length, metre\n", +"L_sqr = ((L_m)^2*(1-f)); // diffusion length, metre\n", +"tau = 0.0364; // Age of the neutron\n", +"B_sqr = 3.27; // Geometrical buckling\n", +"k_eff = round (k_inf*exp(-tau*B_sqr)/(1+L_sqr*B_sqr)); // Effective multiplication factor\n", +"N_lf = k_eff/k_inf; // Non leakage factor\n", +"lf = (1-N_lf)*100; // Leakage factor, percent\n", +"printf('\n Total leakage factor = %4.1f percent',lf)\n", +"// Result\n", +"// Total leakage factor = 31.3 percent " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 15.2: Neutron_multiplication_factor_of_uranium_reactor.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa15.2 : : Page-652 (2011)\n", +"clc; clear;\n", +"N_m = 50; // Number of molecules of heavy water per uranium molecule\n", +"N_u = 1; // Number of uranium molecules \n", +"sigma_a_u = 7.68; // Absorption cross section for uranium, barns\n", +"sigma_s_u = 8.3; // Scattered cross section for uranium, barns\n", +"sigma_a_D = 0.00092; // Absorption cross section for heavy water, barns\n", +"sigma_s_D = 10.6; // Scattered cross section for uranium, barns \n", +"f = N_u*sigma_a_u/(N_u*sigma_a_u+N_m*sigma_a_D ); // Thermal utilization factor\n", +"zeta = 0.570; // Average number of collisions\n", +"N_0 = N_u*139/140; // Number of U-238 atoms per unit volume \n", +"sigma_s = N_m/N_0*sigma_s_D; // Scattered cross section, barns\n", +"sigma_a_eff = 3.85*(sigma_s/N_0)^0.415; // Effective absorption cross section, barns\n", +"p = exp(-sigma_a_eff/sigma_s); // Resonance escape probablity\n", +"eps = 1; // Fast fission factor\n", +"eta = 1.34; // Number of fast fission neutron produced\n", +"k_inf = eps*eta*p*f; // Effective multiplication factor\n", +"printf('\nNeutron multiplication factor = %4.1f ', k_inf);\n", +"// Result\n", +"// Neutron multiplication factor = 1.2 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 15.3: Multiplication_factor_for_uranium_graphite_moderated_assembly.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa15.3 : : Page-652 (2011)\n", +"clc; clear;\n", +"// For graphite\n", +"sigma_a_g = 0.0032; // Absorption cross section for graphite, barns\n", +"sigma_s_g = 4.8; // Scattered cross section for graphite, barns\n", +"zeta = 0.158; // Average number of collisions\n", +"N_m = 50; // Number of molecules of graphite per uranium molecule\n", +"// For uranium\n", +"sigma_f = 590; // Fissioning cross section, barns\n", +"sigma_a_u = 698; // Absorption cross section for U-235, barns\n", +"sigma_a_238 = 2.75; // Absorption cross section for U-238, barns\n", +"v = 2.46; // Number of fast neutrons emitted\n", +"N_u = 1 // Number of uranium atoms \n", +"f = N_u*sigma_a_u/(N_u*sigma_a_u+N_m*sigma_a_g ); // Thermal utilization factor\n", +"N_0 = N_u*(75/76); // Number of U-238 atoms per unit volume\n", +"sigma_s = N_m*76/75*sigma_s_g/N_u; // Scattered cross section, barns\n", +"sigma_eff = 3.85*(sigma_s/N_0)^0.415; // Effective cross section, barns\n", +"p = exp(-sigma_eff/sigma_s); // Resonance escape probability, barns\n", +"eps = 1; // Fast fission factor\n", +"eta = 1.34; // Number of fast fission neutron produced\n", +"k_inf = eps*eta*p*f; // Multiplication factor\n", +"printf('\nThe required multiplication factor = %3.1f ', k_inf);\n", +"// Result\n", +"// The required multiplication factor = 1.1 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 15.4: Ratio_of_number_of_uranium_atoms_to_graphite_atoms.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa15.4 : : Page-653 (2011)\n", +"clc; clear;\n", +"eta = 2.07; // Number of fast fission neutron produced\n", +"x = 1/(eta-1); \n", +"sigma_a_u = 687; // Absorption cross section for uranium, barns\n", +"sigma_a_g = 0.0045; // Absorption cross section for graphite, barns\n", +"N_ratio = x*sigma_a_g/sigma_a_u; // Ratio of number of uranium atoms to graphite atoms\n", +"printf('\nThe ratio of number of uranium atoms to graphite atoms = %4.2e ', N_ratio);\n", +"// Result\n", +"// The ratio of number of uranium atoms to graphite atoms = 6.12e-006 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 15.5: Multiplication_factor_for_LOPO_nuclear_reactor.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa15.5 : : Page-653 (2011)\n", +"clc; clear; \n", +"f = 0.754; // Thermal utilization factor\n", +"sigma_s_o = 4.2; // Scattered cross section for oxygen, barns\n", +"sigma_s_H = 20; // Scattered cross section for hydrogen, barns\n", +"N_O = 879.25; // Number of oxygen atoms\n", +"N_238 = 14.19; // Number of uranium atoms\n", +"N_H = 1573; // Number of hydrogen atoms\n", +"sigma_s = N_O/N_238*sigma_s_o+N_H/N_238*sigma_s_H; // Scattered cross section, barns\n", +"N_0 = 14.19; // Number of U-238 per unit volume\n", +"zeta_o = 0.120; // Number of collision for oxygen\n", +"zeta_H = 1; // Number of collision for hydrogen\n", +"sigma_eff = (N_0/(zeta_o*sigma_s_o*N_O+zeta_H*sigma_s_H*N_H )); // Effective cross section, barns\n", +"p = exp(-sigma_eff/sigma_s); // Resonance escape probablity\n", +"eta = 2.08; // Number of fission neutron produced.\n", +"eps = 1; // Fission factor\n", +"K_inf = eps*eta*p*f; // Multiplication factor\n", +"printf('\nThe multiplication factor for LOPO reactor = %3.1f ', K_inf);\n", +"// Result\n", +"// The multiplication factor for LOPO reactor = 1.6 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 15.6: Control_poison_required_to_maintain_the_criticality_of_U235.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa15.6 : : Page-654 (2011)\n", +"clc; clear;\n", +"r = 35; // Radius of the reactor, centi metre\n", +"B_sqr = (%pi/r)^2; // Geometrical buckling, per square centi metre\n", +"D = 0.220; // Diffusion coefficient, centi metre\n", +"sigma_a_f = 0.057; // Rate of absorption of thermal neutrons\n", +"v = 2.5; // Number of fast neutrons emitted\n", +"tau = 50; // Age of the neutron\n", +"sigma_f = 0.048; // Rate of fission\n", +"sigma_a_c = -1/(1+tau*B_sqr)*(-v*sigma_f+sigma_a_f+B_sqr*D+tau*B_sqr*sigma_a_f); // Controlled cross section\n", +"printf('\nThe required controlled cross section = %6.4f ', sigma_a_c);\n", +"// Result\n", +"// The required controlled cross section = 0.0273 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 15.7: Dimensions_of_a_reactor.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa15.7 : : Page-655 (2011)\n", +"clc; clear;\n", +"B_sqr = 65; // Geometrical buckling\n", +"a = sqrt(3*%pi^2/B_sqr)*100; // Side of the cubical reactor, centi metre\n", +"R = round(%pi/sqrt(B_sqr)*100); // Radius of the cubical reactor,centi metre\n", +"printf('\nThe side of the cubical reactor = %4.1f cm\nThe critical radius of the reactor = %d cm', a, R);\n", +"// Result\n", +"// The side of the cubical reactor = 67.5 cm\n", +"// The critical radius of the reactor = 39 cm " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 15.8: Critical_volume_of_the_spherical_reactor.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa15.8 : : Page-655 (2011)\n", +"clc; clear;\n", +"sigma_a_u = 698; // Absorption cross section for uranium, barns\n", +"sigma_a_M = 0.00092; // Absorption cross section for heavy water, barns\n", +"N_m = 10^5; // Number of atoms of heavy water\n", +"N_u = 1; // Number of atoms of uranium\n", +"f = sigma_a_u/(sigma_a_u+sigma_a_M*N_m/N_u); // Thermal utilization factor\n", +"eta = 2.08; // Number of fast fission neutron produced\n", +"k_inf = eta*f; // Multiplication factor\n", +"L_m_sqr = 1.70; // Material length, metre\n", +"L_sqr = L_m_sqr*(1-f); // Diffusion length, metre\n", +"B_sqr = 1.819/0.30381*exp(-1/12)-1/0.3038; // Geometrical buckling, per square metre\n", +"V_c = 120/(B_sqr*sqrt(B_sqr)); // Volume of the reactor, cubic metre\n", +"printf('\nThe critical volume of the reactor = %4.1f cubic metre', V_c);\n", +"// Result\n", +"// The critical volume of the reactor = 36.4 cubic metre " + ] + } +], +"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/Nuclear_Physics_by_D_C_Tayal/16-Chemical_and_Biological_Effects_of_Radiation.ipynb b/Nuclear_Physics_by_D_C_Tayal/16-Chemical_and_Biological_Effects_of_Radiation.ipynb new file mode 100644 index 0000000..b9ab71d --- /dev/null +++ b/Nuclear_Physics_by_D_C_Tayal/16-Chemical_and_Biological_Effects_of_Radiation.ipynb @@ -0,0 +1,110 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 16: Chemical and Biological Effects of Radiation" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 16.1: Radiation_dosimetry.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa16.1 : : Page-672 (2011)\n", +"clc; clear;\n", +"R_d = 25; // Radiation dose, milli rad\n", +"R_c_gy = 25e-03; // Dose in centigray\n", +"R_Sv = 25*10^-2 // Dose in milli sieverts\n", +"printf('\n25 mrad = %2.0e cGy = %4.2f mSv', R_c_gy, R_Sv);\n", +"// Results\n", +"// 25 mrad = 3e-002 cGy = 0.25 mSv " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 16.2: Conversion_of_becquerel_into_curie.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa16.2 : : Page-673 (2011)\n", +"clc; clear;\n", +"BC_conv = 100*1e+009/3.7e+10; // Becquerel curie conversion, milli curie\n", +"printf('\n100 mega becquerel = %3.1f milli curie ', BC_conv)\n", +"// Results\n", +"// 100 mega becquerel = 2.7 milli curie " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 16.4: Amount_of_liver_dose_for_a_liver_scan.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa16.4 : : Page-673 (2011)\n", +"clc; clear;\n", +"A = 80*10^6; // Activity, becquerel\n", +"t_half = 6*3600; // Half life, s\n", +"N = A*t_half/0.693; // Number of surviving radionuclei\n", +"E_released = 0.9*N*(140e+03)*1.6e-19; // Energy released, joule\n", +"m_l = 1.8; // Mass of liver of average man, Kg\n", +"liv_dose = E_released*10^2/m_l; // Liver dose, centigray\n", +"printf('\nThe requiresd liver dose = %3.1f cGy', liv_dose);\n", +"// Result\n", +"// The requiresd liver dose = 2.8 cGy " + ] + } +], +"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/Nuclear_Physics_by_D_C_Tayal/18-Elementary_Particles.ipynb b/Nuclear_Physics_by_D_C_Tayal/18-Elementary_Particles.ipynb new file mode 100644 index 0000000..8479e34 --- /dev/null +++ b/Nuclear_Physics_by_D_C_Tayal/18-Elementary_Particles.ipynb @@ -0,0 +1,544 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 18: Elementary Particles" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 18.10: Estimation_of_the_mean_life_of_tau_plus.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa18.10 : : Page-767 (2011)\n", +"clc; clear;\n", +"m_mew = 106; // Mass of mew lepton, mega electron volts per square c\n", +"m_tau = 1784; // Mass of tau lepton, mega electron volts per square c\n", +"tau_mew = 2.2e-06; // Mean life of mew lepton, sec\n", +"R = 16/100; // Branching factor\n", +"tau_plus = R*(m_mew/m_tau)^5*tau_mew; // Mean life for tau plus, sec\n", +"printf('\nThe mean life for tau plus : %3.1e sec', tau_plus);\n", +"// Result\n", +"// The mean life for tau plus : 2.6e-013 sec " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 18.13: Possible_electric_charge_for_a_baryon_and_a_meson.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa18.13 : : Page-768(2011)\n", +"clc; clear;\n", +"function s = symbol(val)\n", +" if val == 2 then\n", +" s = '++';\n", +" elseif val == 1 then\n", +" s = '+';\n", +" elseif val == 0 then\n", +" s = '0';\n", +" elseif val == -1 then\n", +" s = '-';\n", +" end\n", +"endfunction\n", +"B = 1; // Baryon number\n", +"S = 0; // Strangeness quantum number\n", +"Q = rand(1,4) // Charge\n", +"I3 = 3/2; \n", +"printf('\nThe possible charge states are');\n", +"for i = 0:1:3\n", +" Q = I3+(B+S)/2;\n", +" sym = symbol(Q);\n", +" printf(' %s', sym);\n", +" I3 = I3 - 1;\n", +"end\n", +"printf(' respectively');\n", +"// Result\n", +"// The possible charge states are ++ + 0 - respectively " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 18.15: Branching_ratio_for_resonant_decay.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa18.15 : : Page-768 (2011)\n", +"clc; clear;\n", +"I_1 = 3/2; // Isospin for delta(1232)\n", +"I_2 = 1/2; // Isospin for delta 0\n", +"delta_ratio = sqrt((2/3)^2)/sqrt((1/3)^2); // Branching ratio\n", +"printf('\nThe branching ratio for a resonance with I = 1/2 is %d', delta_ratio);\n", +"// Result\n", +"// The branching ratio for a resonance with I = 1/2 is 2 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 18.16: Ratio_of_cross_section_for_reactions.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa18.16 : : Page-768 (2011)\n", +"clc; clear;\n", +"phi = 45*%pi/180; // Phase difference\n", +"Cross_sec_ratio = 1/4*(5+4*cos(phi))/(1-cos(phi)); // Cross section ratio\n", +"printf('\nThe cross section ratio : %4.2f', Cross_sec_ratio);\n", +"// Result" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 18.18: Root_mean_square_radius_of_charge_distribution.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa18.18 : : Page-770 (2011)\n", +"clc; clear; \n", +"m_sqr = 0.71; // For proton, (GeV/c-square)^2\n", +"R_rms = sqrt(12)/(sqrt(m_sqr)*5.1); // Root mean square radius, femto metre\n", +"printf('\nThe root mean square radius of charge distribution: %4.2f fermi', R_rms);\n", +"// Result\n", +"// The root mean square radius of charge distribution: 0.81 fermi " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 18.1: Root_mean_square_radius_of_charge_distribution.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa18.1 : : Page-770 (2011)\n", +"clc; clear; \n", +"m_sqr = 0.71; // For proton, (GeV/c-square)^2\n", +"R_rms = sqrt(12)/(sqrt(m_sqr)*5.1); // Root mean square radius, femto metre\n", +"printf('\nThe root mean square radius of charge distribution: %4.2f fermi', R_rms);\n", +"// Result\n", +"// The root mean square radius of charge distribution: 0.81 fermi " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 18.3: Isospin_of_the_strange_particles.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Ex18.3 : : Page-763 (2011)\n", +"clc; clear;\n", +"p = rand(1,2); // proton\n", +"pi_minus = rand(1,2); //pi minus meson\n", +"pi_plus = rand(1,2); // pi plus meson\n", +"n = rand(1,2); // neutron\n", +"lamda_0 = rand(1,2); // lamda hyperon\n", +"K_0 = rand(1,2); // K zero (Kaons)\n", +"K_plus = rand(1,2); // K plus (Kaons)\n", +"sigma_plus = rand(1,2); // hyperon \n", +"sigma_minus = rand(1,2) // hyperon\n", +"ksi_minus = rand(1,2); // hyperon\n", +"// Allocate the value of Isospins (T and T3)\n", +"p(1,1) = 1/2;\n", +"p(1,2) = 1/2;\n", +"pi_minus(1,1) = 1;\n", +"pi_minus(1,2) = -1;\n", +"pi_plus(1,1) = 1;\n", +"pi_plus(1,2) = +1;\n", +"n(1,1) = 1/2;\n", +"n(1,2) = -1/2;\n", +"lambda_0(1,1) = 0;\n", +"lambda_0(1,2) = 0;\n", +"K_0(1,1) = pi_minus(1,1)+p(1,1);\n", +"K_0(1,2) = pi_minus(1,2)+p(1,2) ;\n", +"K_plus(1,1) = p(1,1)+p(1,1)-lambda_0(1,1)-p(1,1);\n", +"K_plus(1,2) = p(1,2)+p(1,2)-lambda_0(1,2)-p(1,2) ;\n", +"sigma_plus(1,1) = pi_plus(1,1)+p(1,1)-K_plus(1,1);\n", +"sigma_plus(1,2) = pi_plus(1,2)+p(1,2)-K_plus(1,2);\n", +"sigma_minus(1,1) = pi_minus(1,1)+p(1,1)-K_plus(1,1);\n", +"sigma_minus(1,2) = pi_minus(1,2)+p(1,2)-K_plus(1,2);\n", +"ksi_minus(1,1) = pi_plus(1,1)+n(1,1)-K_plus(1,1)-K_plus(1,1);\n", +"ksi_minus(1,2) = pi_plus(1,2)+n(1,2)-K_plus(1,2)-K_plus(1,2);\n", +"printf('\n Reaction I \n pi_minus + p ......> lambda_0 + K_0');\n", +"printf('\n The value of T for K_0 is : %3.1f ',K_0(1,1));\n", +"printf('\n The value of T3 for K_0 is : %3.1f ',K_0(1,2));\n", +"printf('\n Reaction II \n pi_plus + p -> lambda_0 + K_plus');\n", +"printf('\n The value of T for K_plus is : %3.1f ',K_plus(1,1));\n", +"printf('\n The value of T3 for K_plus is : %3.1f ',K_plus(1,2));\n", +"printf('\n Reaction III \n pi_plus + n -> lambda_0 + K_plus');\n", +"printf('\n The value of T for K_plus is : %3.1f ',K_plus(1,1));\n", +"printf('\n The value of T3 for K_plus is : %3.1f ',K_plus(1,2));\n", +"printf('\n Reaction VI \n pi_minus + p -> sigma_minus + K_plus');\n", +"printf('\n The value of T for sigma_minus is : %3.1f ',sigma_minus(1,1));\n", +"printf('\n The value of T3 for sigma_minus is : %3.1f ',sigma_minus(1,2));\n", +"printf('\n Reaction V \n pi_plus + p -> sigma_plus + K_plus');\n", +"printf('\n The value of T for sigma_plus is : %3.1f ',sigma_plus(1,1));\n", +"printf('\n The value of T3 for sigma_plus is : %3.1f ',sigma_plus(1,2));\n", +"printf('\n Reaction VI \n pi_plus + n -> ksi_minus + K_plus + K_plus');\n", +"printf('\n The value of T for Ksi_minus is : %3.1f ',ksi_minus(1,1));\n", +"printf('\n The value of T3 for Ksi_minus is : %3.1f ',ksi_minus(1,2));\n", +"// Result\n", +"// \n", +"// Reaction I \n", +"// pi_minus + p -> lambda_0 + K_0\n", +"// The value of T for K_0 is : 1.5 \n", +"// The value of T3 for K_0 is : -0.5 \n", +"// Reaction II \n", +"// pi_plus + p -> lambda_0 + K_plus\n", +"// The value of T for K_plus is : 0.5 \n", +"// The value of T3 for K_plus is : 0.5 \n", +"// Reaction III \n", +"// pi_plus + n -> lambda_0 + K_plus\n", +"// The value of T for K_plus is : 0.5 \n", +"// The value of T3 for K_plus is : 0.5 \n", +"// Reaction VI \n", +" // pi_minus + p -> sigma_minus + K_plus\n", +"// The value of T for sigma_minus is : 1.0 \n", +"// The value of T3 for sigma_minus is : -1.0 \n", +"// Reaction V \n", +"// pi_plus + p -> sigma_plus + K_plus\n", +"// The value of T for sigma_plus is : 1.0 \n", +"// The value of T3 for sigma_plus is : 1.0 \n", +"// Reaction VI \n", +" // pi_plus + n -> ksi_minus + K_plus + K_plus\n", +"// The value of T for Ksi_minus is : 0.5 \n", +"// The value of T3 for Ksi_minus is : -0.5 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 18.4: Allowed_and_forbidden_reactions_under_conservation_laws.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa18.4 : : Page-764 (2011)\n", +"clc;clear;\n", +"p = rand(1,3); // proton\n", +"pi_minus = rand(1,3); // pi minus meson\n", +"pi_plus = rand(1,3); // pi plus meson\n", +"pi_0 = rand(1,3); // pi zero meson\n", +"n = rand(1,3); // neutron\n", +"lambda_0 = rand(1,3); // lambda zero hyperon\n", +"K_0 = rand(1,3); // k zero meson\n", +"K_plus = rand(1,3); // k plus meson\n", +"K_0_bar = rand(1,3); // anti particle of k zero\n", +"sigma_plus = rand(1,3); // sigma hyperon\n", +"// Now in the following steps we allocated the value of charge(Q),baryon number(B) and strangeness number (S) \n", +"p(1,1) = 1;\n", +"p(1,2) = 1;\n", +"p(1,3) = 0;\n", +"pi_minus(1,1) = -1;\n", +"pi_minus(1,2) = 0;\n", +"pi_minus(1,3) = 0;\n", +"pi_plus(1,1) = 1;\n", +"pi_plus(1,2) = 0;\n", +"pi_plus(1,3) = 0;\n", +"n(1,1) = 0;\n", +"n(1,2) = 1;\n", +"n(1,3) = 0;\n", +"lambda_0(1,1) = 0;\n", +"lambda_0(1,2) = 1;\n", +"lambda_0(1,3) = -1;\n", +"K_0(1,1) =0 ;\n", +"K_0(1,2) = 0 ;\n", +"K_0(1,3) = 1;\n", +"K_plus(1,1) = 1;\n", +"K_plus(1,2) = 0 ;\n", +"K_plus(1,3) = 1;\n", +"sigma_plus(1,1) = 1;\n", +"sigma_plus(1,2) = 1;\n", +"sigma_plus(1,3) = -1;\n", +"K_0_bar(1,1) = 0;\n", +"K_0_bar(1,2) = 0;\n", +"K_0_bar(1,3) = -1;\n", +"pi_0(1,1) = 0;\n", +"pi_0(1,2) = 0;\n", +"pi_0(1,3) = 0;\n", +"j = 0;\n", +"k = 0;\n", +"printf('\n Reaction I \n pi_plus + n ......> lambda_0 + K_plus')\n", +"for i = 1:3\n", +" if pi_plus(1,i)+n(1,i) == lambda_0(1,i)+K_plus(1,i) then\n", +" j = j+1;\n", +" else\n", +" printf('\n Reaction I is forbidden')\n", +" if i == 1 then\n", +" printf('\n Delta Q is not zero')\n", +" elseif i == 2 then\n", +" printf('\n Delta B is not zero')\n", +" elseif i == 3 then\n", +" printf('\n Delta S is not zero')\n", +" end \n", +" end \n", +"end \n", +"if j==3 then\n", +" printf('\n Reaction I is allowed ');\n", +" printf('\n Delta Q is zero \n Delta B is zero \n Delta S is zero')\n", +"end \n", +"printf('\n Reaction II \n pi_plus + n ......> K_0 + K_plus')\n", +"j = 0;\n", +"for i = 1:3\n", +" if pi_plus(1,i)+n(1,i) == K_0(1,i)+K_plus(1,i) then\n", +" j = j+1;\n", +" else\n", +" printf('\n Reaction II is forbidden')\n", +" if i == 1 then\n", +" printf('\n Delta Q is not zero')\n", +" elseif i == 2 then\n", +" printf('\n Delta B is not zero')\n", +" elseif i == 3 then\n", +" printf('\n Delta S is not zero')\n", +" end \n", +" end \n", +"end \n", +"if j==3 then\n", +" printf('\n Reaction II is allowed ');\n", +" printf('\n Delta Q is zero \n Delta B is zero \n Delta S is zero')\n", +"end \n", +"j = 0;\n", +"printf('\n Reaction III \n pi_plus + n ......> K_0_bar + sumison_plus')\n", +"for i = 1:3\n", +" if pi_plus(1,i)+n(1,i) == K_0_bar(1,i)+sigma_plus(1,i) then\n", +" j = j+1;\n", +" else\n", +" printf('\n Reaction III is forbidden')\n", +" if i == 1 then\n", +" printf('\n Delta Q is not zero')\n", +" elseif i == 2 then\n", +" printf('\n Delta B is not zero')\n", +" elseif i == 3 then\n", +" printf('\n Delta S is not zero')\n", +" end \n", +" end \n", +"end \n", +"if j==3 then\n", +" printf('\n Reaction III is allowed ');\n", +" printf('\n Delta Q is zero \n Delta B is zero \n Delta S is zero')\n", +"end \n", +"j = 0;\n", +"printf('\n Reaction IV \n pi_plus + n ......> pi_minus + p')\n", +"for i = 1:3\n", +" if pi_plus(1,i)+n(1,i) == pi_minus(1,i)+p(1,i) then\n", +" j = j+1;\n", +" else\n", +" printf('\n Reaction IV is forbidden')\n", +" if i == 1 then\n", +" printf('\n Delta Q is not zero')\n", +" elseif i == 2 then\n", +" printf('\n Delta B is not zero')\n", +" elseif i == 3 then\n", +" printf('\n Delta S is not zero')\n", +" end \n", +" end \n", +"end \n", +"if j==3 then\n", +" printf('\n Reaction IV is allowed ');\n", +" printf('\n Delta Q is zero \n Delta B is zero \n Delta S is zero')\n", +"end \n", +"j = 0;\n", +"printf('\n Reaction V \n pi_minus + p ......> lambda_0 + K_0')\n", +"for i = 1:3\n", +" if pi_minus(1,i)+p(1,i) == lambda_0(1,i)+K_0(1,i) then\n", +" j = j+1;\n", +" else\n", +" printf('\n Reaction V is forbidden')\n", +" if i == 1 then\n", +" printf('\n Delta Q is not zero')\n", +" elseif i == 2 then\n", +" printf('\n Delta B is not zero')\n", +" elseif i == 3 then\n", +" printf('\n Delta S is not zero')\n", +" end \n", +" end \n", +"end \n", +"if j==3 then\n", +" printf('\n Reaction V is allowed ');\n", +" printf('\n Delta Q is zero \n Delta B is zero \n Delta S is zero')\n", +"end \n", +"j = 0;\n", +"printf('\n Reaction VI \n pi_plus + n ......> lambda_0 + K_plus')\n", +"for i = 1:3\n", +" if pi_minus(1,i)+p(1,i) == pi_0(1,i)+lambda_0(1,i) then\n", +" j = j+1;\n", +" else\n", +" printf('\n Reaction VI is forbidden')\n", +" if i == 1 then\n", +" printf('\n Delta Q is not zero');\n", +" elseif i == 2 then\n", +" printf('\n Delta B is not zero')\n", +" elseif i == 3 then\n", +" printf('\n Delta S is not zero')\n", +" end \n", +" end \n", +"end \n", +"if j==3 then\n", +" printf('\n Reaction VI is allowed ');\n", +" printf('\n Delta Q is zero \n Delta B is zero \n Delta S is zero');\n", +"end\n", +" \n", +"// Result\n", +"// Reaction I \n", +" // pi_plus + n ......> lambda_0 + K_plus\n", +"// Reaction I is allowed \n", +"// Delta Q is zero \n", +"// Delta B is zero \n", +"// Delta S is zero\n", +"// Reaction II \n", +" // pi_plus + n ......> K_0 + K_plus\n", +"// Reaction II is forbidden\n", +"// Delta B is not zero\n", +"// Reaction II is forbidden\n", +"// Delta S is not zero\n", +"// Reaction III \n", +"// pi_plus + n ......> K_0_bar + sumison_plus\n", +"// Reaction III is forbidden\n", +"// Delta S is not zero\n", +"// Reaction IV \n", +"// pi_plus + n ......> pi_minus + p\n", +"// Reaction IV is forbidden\n", +"// Delta Q is not zero\n", +"// Reaction V \n", +"// pi_minus + p ......> lambda_0 + K_0\n", +"// Reaction V is allowed \n", +"// Delta Q is zero \n", +"// Delta B is zero \n", +"// Delta S is zero\n", +"// Reaction VI \n", +"// pi_plus + n ......> lambda_0 + K_plus\n", +"// Reaction VI is forbidden\n", +"// Delta S is not zero " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 18.9: Decay_of_sigma_particle.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Ex18.9 : : Page-766 (2011)\n", +"clc; clear;\n", +"h_cross = 6.62e-022; // Redueced planck's constant, MeV sec\n", +"p_width = 0.88*35; // Partial width of the decay, MeV \n", +"tau = h_cross/p_width; // Life time of sigma, sec \n", +"T_pi = 1; // Isospin of pi plus particle \n", +"T_lambda = 0; // Isospin of lambda zero particle \n", +"T_sigma = T_pi+T_lambda; // Isospin of sigma particle \n", +"printf('\nThe lifetime of sigma particle = %4.2e s\nThe reaction is strong\nThe isospin of sigma particle is : %d',tau, T_sigma);\n", +"// Result\n", +"// The lifetime of sigma particle = 2.15e-023 s\n", +"// The reaction is strong\n", +"// The isospin of sigma particle is : 1 " + ] + } +], +"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/Nuclear_Physics_by_D_C_Tayal/2-Radioactivity_and_Isotopes.ipynb b/Nuclear_Physics_by_D_C_Tayal/2-Radioactivity_and_Isotopes.ipynb new file mode 100644 index 0000000..08647f7 --- /dev/null +++ b/Nuclear_Physics_by_D_C_Tayal/2-Radioactivity_and_Isotopes.ipynb @@ -0,0 +1,583 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 2: Radioactivity and Isotopes" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.10: Radioactive_disintegration_of_Bi.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa2.10 : : Page 91 (2011)\n", +"clc; clear;\n", +"lambda_t = 0.693/(60.5*60);// Total decay constant, per sec\n", +"lambda_a = 0.34*lambda_t;// Decay constant for alpha_decay, per sec\n", +"lambda_b = 0.66*lambda_t;// Decay constant for beta_decay, per sec\n", +"printf('\nThe decay constant for total emission = %4.2e /sec', lambda_t);\n", +"printf('\nThe decay constant for beta_decay lambda_b = %4.2e /sec', lambda_b);\n", +"printf('\nThe decay constant for alpha_decay lambda_a = %4.2e /sec', lambda_a);\n", +"\n", +"// Result \n", +"// The decay constant for total emission = 1.91e-004 /sec\n", +"// The decay constant for beta_decay lambda_b = 1.26e-004 /sec\n", +"// The decay constant for alpha_decay lambda_a = 6.49e-005 /sec " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.13: Half_life_of_Pu239.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa2.13 : : Page 93 (2011)\n", +"clc; clear;\n", +"M_A = 4; // Mass of alpha particle, amu\n", +"M_U = 235; //Mass of U-235, amu\n", +"M_P = 239; // Mass of P-239, amu\n", +"Amount = 120.1; // quantity of P-239, g\n", +"E_A = 5.144; // Energy of emitting alpha particles, Mev\n", +"E_R = (2*M_A)/(2*M_U)*E_A; // The recoil energy of U-235, Mev\n", +"E = E_R + E_A; // The energy released per disintegration, Mev\n", +"P = 0.231; // Evaporation rate, watt\n", +"D = P/(E*1.60218e-013); // Disintegration rate, per sec\n", +"A = 6.022137e+023; // Avagadro's number, atoms\n", +"N = Amount/M_P*A; // Number of nuclei in 120.1g of P-239\n", +"T = 0.693/(D*3.15e+07)*N; // Half life of Pu_239, years\n", +"printf('\nThe half life of Pu-239 = %3.2e years', T);\n", +"\n", +"// Result \n", +"// The half life of Pu-239 = 2.42e+004 years " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.14: Disintegration_rate_of_Au199.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa2.14 : : Page 93 (2011)\n", +"clc; clear;\n", +"T_h_1 = 2.7*24*3600; // Half life of Au-198, sec\n", +"T_h_2 = 3.15*24*3600; // Half life of Au-199, sec\n", +"S_1 = 99e-028; // Crossection for first reaction, Sq.m\n", +"S_2 = 2.6e-024; // Crossection for second reaction, Sq.m\n", +"I = 1e+018; // Intensity of radiation, per Sq.m per sec\n", +"L_1 = I*S_1; // Decay constant of Au-197, per sec\n", +"L_2 = 0.693/T_h_1+I*S_2; // Decay constant of Au-198, per sec\n", +"L_3 = 0.693/T_h_2; // Decay constant of Au-199, per sec\n", +"N_0 = 6.022137e+023; // Avogadro number\n", +"N_1 = N_0/197; // Initial number of atoms of Au-197\n", +"t = 30*3600; // Given time, sec\n", +"p = [exp(-L_1*t)]/[(L_2-L_1)*(L_3-L_1)];\n", +"q = [exp(-L_2*t)]/[(L_1-L_2)*(L_3-L_2)];\n", +"r = [exp(-L_3*t)]/[(L_1-L_3)*(L_2-L_3)];\n", +"N3 = N_1*L_1*L_2*[p+q+r];\n", +"N_199 = N3;\n", +"L = L_3*N_199; // Disintegration rate of Au-199, per sec\n", +"printf('\nThe disintegration rate of Au-199 = %3.1e ', L);\n", +"\n", +"// Result\n", +"// The disintegration rate of Au-199 = 1.9e+012 (Wrong answer in the textbook)" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.15: Activity_of_Na24.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa2.15 : : Page 94 (2011)\n", +"clc; clear;\n", +"Y = 110e-03;// Yield of Na-24, mCi/hr\n", +"T = 14.8;// Half life of Na-24, hours\n", +"t = 8;// Time after which activity to be compute, hours\n", +"lambda = 0.693/T;// Disintegration constant, hours^-1\n", +"A = 1.44*Y*T;// Maximum activity of Na-24, Ci\n", +"A_C = A*[1-%e^(-lambda*t)];// Activity after a continuous bombardment, Ci\n", +"Activity = A_C*(%e^(-lambda*t));// Activity after 8hours, Ci\n", +"printf('\nThe maximum activity of Na-24 = %5.3f Ci\nThe activity after a continuous bombardment = %6.4f Ci\nThe activity after 8hours = %7.5f Ci',A, A_C, Activity);\n", +"\n", +"// Result\n", +"// The maximum activity of Na-24 = 2.344 Ci\n", +"// The activity after a continuous bombardment = 0.7324 Ci\n", +"// The activity after 8hours = 0.50360 Ci " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.16: Radiation_dose_absorbed_in_24_hr_by_the_tissue_in_REP.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa2.16 : : Page 94 (2011)\n", +"clc; clear;\n", +"A_0 = 3.7e+07; // Initial activity, disintegrations per sec\n", +"T = 12.6; // Half life of I-130, hours\n", +"t = 24*3600; // time for dose absorbed calculation,sec\n", +"E = 0.29*1.6e-06; // Average energy of beta rays, ergs\n", +"m = 2; // Mass of iodine thyroid tissue, gm\n", +"lambda = 0.693/(T*3600); // Disintegration constant, sec^-1\n", +"N_0 = A_0/lambda; // Initial number of atoms\n", +"N = N_0*[1-%e^(-lambda*t)]; // Number of average atoms disintegrated\n", +"E_A = N*E; // Energy of beta rays emitted, ergs\n", +"E_G = E_A/(2*97.00035); // Energy of beta rays emitted per gram of tissue, REP \n", +"printf('\nThe energy of beta rays emitted per gram of tissue = %6.1f REP', E_G);\n", +"\n", +"// Result\n", +"// The energy of beta rays emitted per gram of tissue = 4245.0 REP " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.18: Activity_and_the_maximum_amount_of_Au198_produced_in_the_foil_of_Au197.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa2.18 : : Page 95 (2011)\n", +"clc; clear;\n", +"N_0 = 6.022137e+023; // Avagadro number\n", +"d = 0.02; // Thickness of the foil, cm\n", +"R = 19.3; // Density of Au,g/cc\n", +"N_1 = d*R/197*N_0; // Initial number of Au-197 nuclei per unit area of foil,cm^-2\n", +"T_H = 2.7*24*3600; // Half life of Au-198,sec\n", +"L = log(2)/T_H; // Decay constant for Au-198,sec^-1\n", +"I = 10^12; // Intensity of neutron beam,neutrons/cm^2/sec\n", +"S = 97.8e-024; // Cross section for reaction,cm^-2\n", +"t = 5*60; // Reaction time,s\n", +"A = S*I*N_1*(1-%e^(-L*t)); // Activity of Au-198,cm^-2sec^-1\n", +"N_2 = S*I*N_1/L; // The maximum amount of Au-198 produced,cm^-2\n", +"printf('\nThe activity of Au-198 = %5.3e per Sq.cm per sec\nThe maximum amount of Au-198 produced = %4.2e per Sq.cm', A, N_2);\n", +"\n", +"// Result\n", +"// The activity of Au-198 = 1.028e+008 per Sq.cm per sec\n", +"// The maximum amount of Au-198 produced = 3.88e+016 per Sq.cm " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.19: Pu238_as_power_source_in_space_flights.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa2.19 : : Page 95 (2011)\n", +"clc; clear;\n", +"N_0 = 6.022137e+023; // Avagadro number \n", +"T_P = 90*365*24*3600; // Half life of Pu-238,s\n", +"L_P = 0.693/T_P ; // Decay constant of Pu-238,s^-1\n", +"E = 5.5; // Energy of alpha particle, MeV\n", +"P =E*L_P*N_0; // Power released by the gm molecule of Pu-238,MeV/s\n", +"t = log(8)/(L_P*365*24*3600); // Time in which power reduces to 1/8 time of its initial value \n", +"printf('\nThe power released by the gm molecule of Pu-238 = %4.2e MeV/s \nThe time in which power reduces to 1/8 time of its initial value = %d yrs',P,t)\n", +"\n", +"// Result\n", +"// The power released by the gm molecule of Pu-238 = 8.09e+014 MeV/s \n", +"// The time in which power reduces to 1/8 time of its initial value = 270 yrs " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.1: Weight_of_one_Curie_and_one_Rutherford_of_RaB.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa2.1: : Page-88 (2011) \n", +"clc; clear;\n", +"T = 26.8*60; // Half life of the substance, s\n", +"C = 3.7e+010; // One curie, disintegration per sec\n", +"N = 6.022137e+026; // Avogadro number, per kmol\n", +"m = 214; // Molecular weight of RaB, kg/kmol\n", +"R = 1e+006; // One Rutherford, disintegration per sec.\n", +"W_C = C*T*m/(N*0.693); // Weight of one Curie of RaB, Kg \n", +"W_R = R*T*m/(N*0.693); // Weight of one Rutherford of RaB, Kg \n", +"printf('\nWeight of one Curie of RaB : %5.3e Kg \nWeight of one Rutherford of RaB : %5.3e Kg', W_C, W_R);\n", +"\n", +"// Result\n", +"// Weight of one Curie of RaB : 3.051e-011 Kg \n", +"// Weight of one Rutherford of RaB : 8.245e-016 Kg " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.20: Series_radioactive_decay_of_parent_isotope.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa2.20 : : Page 96 (2011)\n", +"clc; clear;\n", +"N_1 = 10^20; // Number of nuclei of parent isotopes\n", +"T_P = 10^4; // Half life of parent nucleus,years\n", +"T_D = 20; // Half life of daughter nucleus,years\n", +"T = 10^4; // Given time,years\n", +"L_P = 0.693/T_P ; // Decay constant of parent nucleus,years^-1\n", +"L_D = 0.693/T_D ; // Decay constant of daughter nucleus,years^-1\n", +"t_0 = log(0.03)/(L_P-L_D); // Required time for decay of daughter nucleus,years\n", +"N = L_P/L_D*(%e^(-L_P*T)-%e^(-L_D*T))*N_1; // Number of nuclei of daughter isotope\n", +"printf('\nThe required time for decay of daughter nucleus = %d yr \nThe number of nuclei of daughter isotope = %1.0e ', t_0, N);\n", +"\n", +"// Result\n", +"// The required time for decay of daughter nucleus = 101 yr \n", +"// The number of nuclei of daughter isotope = 1e+017 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.2: Induced_radioactivity_of_sodium_by_neutron_bombardment.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa2.2 : : Page 88 (2011)\n", +"clc; clear;\n", +"T_h = 14.8; // Half life of Na-24, hours\n", +"Q = 1e+008; // Production rate of Na-24, per sec\n", +"L = 0.693/T_h; // Decay constant, per sec\n", +"t = 2; // Time after the bombardment, hours\n", +"A = Q/3.7e+010*1000; // The maximum activity of Na-24, mCi\n", +"T = -1*log(0.1)/L; // The time needed to produced 90% of the maximum activity, hour\n", +"N = 0.9*Q*3600/L*%e^(-L*t); // Number of atoms of Na-24 left two hours after bombardment was stopped\n", +"printf('\nThe maximum activity of Na-24 = %3.1f mCi\nThe time needed to produced 90 percent of the maximum activity = %4.1f hrs \nNumber of atoms of Na-24 left two hours after bombardment was stopped = %4.2e ', A, T, N);\n", +"\n", +"// Result\n", +"// The maximum activity of Na-24 = 2.7 mCi\n", +"// The time needed to produced 90 percent of the maximum activity = 49.2 hrs \n", +"// Number of atoms of Na-24 left two hours after bombardment was stopped = 6.30e+012 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.3: Activity_of_K40_in_man_of_weight_100_Kg.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa2.3: : Page 89 (2011)\n", +"clc; clear;\n", +"T = 1.31e+09*365*24*60*60; // Half life of the substance,sec\n", +"N = 6.022137e+026; // Avogadro number.\n", +"m = 0.35*0.012*10^-2; // Mass of K-40, Kg.\n", +"A = m*N*0.693/(T*40); // Activity of K-40, disintegrations/sec. \n", +"printf('\nThe activity of K-40 = %5.3e disintegrations/sec = %5.3f micro-curie', A, A/3.7e+004);\n", +"\n", +"// Result\n", +"// The activity of K-40 = 1.061e+004 disintegrations/sec = 0.287 micro-curie " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.4: Age_of_an_ancient_wooden_boat.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa2.4 : : Page 89 (2011)\n", +"clc; clear;\n", +"T = 5568; // Half life of the C-14,years\n", +"lambda = 0.693/T; // Disintegration constant, years^-1.\n", +"N_0 = 15.6/lambda; // Activity of fresh carbon, dpm .gm\n", +"N = 3.9/lambda; // Activity of an ancient wooden boat,dpm.gm.\n", +"t = 1/(lambda)*log(N_0/N); // Age of the boat, years\n", +"printf('\nThe age of the boat : %5.3e years', t);\n", +"\n", +"// Result\n", +"// The age of the boat : 1.114e+004 years" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.5: Activity_of_the_U234.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa2.5 : : Page 90 (2011)\n", +"clc; clear;\n", +"m_0 = 3e-06;// Initial mass of the U-234, Kg\n", +"A = 6.022137e+026; //Avagadro's number, atoms\n", +"N_0 = m_0*A/234; // Initial number of atoms\n", +"T = 2.50e+05; // Half life, years\n", +"lambda = 0.693/T; // Disintegration constant\n", +"t = 150000; // Disintegration time, years\n", +"m = m_0*%e^(-lambda*t); // Mass after time t,Kg\n", +"activity = m*lambda/(365*24*60*60)*A/234; // Activity of U-234 after time t,dps\n", +"printf('\nThe activity of U-234 after %6d yrs = %5.3e disintegrations/sec', t, activity);\n", +"\n", +"// Result\n", +"// The activity of U-234 after 150000 yrs = 4.478e+005 disintegrations/sec " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.6: Number_of_alpha_decays_in_Th232.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa2.6 : : Page 90 (2011)\n", +"clc; clear;\n", +"A = 6.022137e+023; //Avagadro's number, atoms\n", +"N_0 = A/232; // Initial number of atoms\n", +"t = 3.150e+07; // Decay time, sec\n", +"lambda = 1.58e-018; // Disintegration constant,sec^-1\n", +"N = lambda*t*N_0; // Number of alpha decays in Th-232\n", +"printf('\nThe number of alpha decays in Th-232 = %5.2e ', N);\n", +"\n", +"// Result\n", +"// The number of alpha decays in Th-232 = 1.29e+011" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.7: Maximum_possible_age_of_the_earth_crust.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa2.7 : : Page 90 (2011)\n", +"clc; clear;\n", +"T_238 = 4.5e+09;// Half life of U-238, years\n", +"T_235 = 7.13e+08; // Half life of U-238, years\n", +"lambda_238 = 0.693/T_238; // Disintegration constant of U-238, years^-1\n", +"lambda_235 = 0.693/T_235; // Disintegration constant of U-235, years^-1 \n", +"N = 137.8; // Abundances of U-238/U-235\n", +"t = log(N)/(lambda_235 - lambda_238);// Age of the earth's crust, years\n", +"printf('\nThe maximum possible age of the earth crust = %5.3e years', t);\n", +"\n", +"// Result \n", +"// The maximum possible age of the earth crust = 6.022e+009 years " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.8: Number_of_radon_half_lives.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa2.8 : : Page 91 (2011)\n", +"clc; clear;\n", +"N = 10; // Number of atoms left undecayed in Rn-222\n", +"n = log(10)/log(2); // Number of half lives in Ra-222\n", +"printf('\nThe number of half lives in radon-222 = %5.3f ', n);\n", +"\n", +"// Result\n", +"// The number of half lives in radon-222 = 3.322 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 2.9: Weight_and_initial_acivity_of_Po210.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa2.9 : : Page 91 (2011)\n", +"clc; clear;\n", +"M_Po = 209.9829; // Mass of Polonium, g\n", +"M_Pb = 205.9745; // Mass of lead, g\n", +"A = 6.22137e+023; // Avogadro's number\n", +"M_He = 4.0026; // Mass of alpha particle, g\n", +"C = 3e+08; // Velocity of light, m/s\n", +"T = 138*24*3600; // Half life, sec\n", +"P = 250; // Power produced, joule/sec\n", +"Q = [M_Po-M_Pb-M_He]*931.25; // disintegration energy, MeV\n", +"lambda = 0.693/T; // Disintegration constant, per year\n", +"N = P/(lambda*Q*1.60218e-013); // Number of atoms, atom\n", +"N_0 = N*%e^(1.833); // Number of atoms present initially, atom\n", +"W = N_0/A*210; // Weight of Po-210 after one year, g\n", +"A_0 = N_0*lambda/(3.7e+010); // Initial activity, curie\n", +"printf('\nThe weight of Po-210 after one year = %5.2f g \nThe initial activity of the material = %4.2e curies', W, A_0);\n", +"\n", +"// Result\n", +"// The weight of Po-210 after one year = 10.49 g \n", +"// The initial activity of the material = 4.88e+004 curies" + ] + } +], +"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/Nuclear_Physics_by_D_C_Tayal/3-Interactions_of_Nuclear_Radiations_with_Matter.ipynb b/Nuclear_Physics_by_D_C_Tayal/3-Interactions_of_Nuclear_Radiations_with_Matter.ipynb new file mode 100644 index 0000000..2b02f93 --- /dev/null +++ b/Nuclear_Physics_by_D_C_Tayal/3-Interactions_of_Nuclear_Radiations_with_Matter.ipynb @@ -0,0 +1,273 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 3: Interactions of Nuclear Radiations with Matter" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 3.10: Average_energy_of_the_positron.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa3.10 : : Page-125(2011)\n", +"clc; clear;\n", +"m_e = 9.1e-31; // Mass of the positron, Kg\n", +"e = 1.6e-19; // Charge of the positron, coulomb\n", +"c = 3e+08; // Velocity of the light, metre per sec\n", +"eps = 8.85e-12; // Absolute permittivity of free space, per N per metre-square per coulomb square\n", +"h = 6.6e-34; // Planck's constant, joule sec\n", +"E = e^2*m_e*c/(eps*h*1.6e-13); // Average energy of the positron, mega electron volts\n", +"printf('\nThe average energy of the positron = %6.4fZ MeV', E);\n", +"\n", +"// Result\n", +"// The average energy of the positron = 0.0075Z MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 3.11: To_calculate_the_refractive_index_of_the_material.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa3.11 : : Page-125(2011)\n", +"clc; clear;\n", +"P = 1; // Momentum of the proton, GeV/c\n", +"M_0 = 0.94; // Rest mass of the proton, GeV/c-square\n", +"G = sqrt((P/M_0)^2+1) // Lorentz factor\n", +"V = sqrt(1-1/G^2); // Minimum velocity of the electron, m/s\n", +"u = 1/V; // Refractive index of the gas\n", +"printf('\nThe refractive index of the gas = %4.2f', u); \n", +"u = 1.6; // Refractive index\n", +"theta = round (acos(1/(u*V))*180/3.14); // Angle at which cerenkov radiatin is emitted,degree\n", +"printf('\nThe angle at which Cerenkov radiation is emitted = %d degree',theta) \n", +"\n", +"// Result \n", +"// The refractive index of the gas = 1.37\n", +"// The angle at which Cerenkov radiation is emitted = 31 degree " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 3.12: Minimum_kinetic_energy_of_the_electron_to_emit_Cerenkov_radiation.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa3.12 : : Page-126(2011)\n", +"clc; clear;\n", +"n = 1+1.35e-04; // Refractive index of the medium\n", +"V_min = 1/n; // Minimum velocity of the electron, m/s\n", +"p = (1+V_min)*(1-V_min); // It is nothing but just to take the product \n", +"G_min = 1/sqrt(p); // Lorentz factor\n", +"m_e = 9.10939e-031; // Mass of the electron, Kg\n", +"C = 3e+08; // Velocity of light, metre per sec\n", +"T_min = [(G_min-1)*m_e*C^2]/(1.602e-013); // Minimum kinetic energy required by an electro to emit cerenkov radiation, mega electron volts\n", +"printf('\nThe minimum kinetic energy required to electron to emit cerenkov radiation = %5.2f MeV', T_min);\n", +" \n", +"// Result \n", +"// The minimum kinetic energy required to electron to emit cerenkov radiation = 30.64 MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 3.1: Alpha_particle_impinging_on_an_aluminium_foil.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa3.1 : : Page-123 (2011)\n", +"clc; clear;\n", +"E = 9; // Energy of the alpha particle, MeV\n", +"S = 1700; // Stopping power of Al\n", +"D = 2700; // Density of Al, Kg per cubic metre\n", +"R_air = 0.00318*E^(3/2); // Range of an alpha particle in air,metre\n", +"R_Al = R_air/S; // Range of an alpha particle in Al, metre\n", +"T = D*1/S; // Thickness in Al of 1m air, Kg per square metre\n", +"printf('\nThe range of an alpha particle = %4.2e metre \nThe thickness in Al of 1 m air = %4.2f Kg per square metre', R_Al, T);\n", +"\n", +"// Result\n", +"// The range of an alpha particle = 5.05e-05 metre \n", +"// The thickness in Al of 1 m air = 1.59 Kg per square metre " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 3.4: Thickness_of_beta_absorption.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa3.4: : Page-124 (2011)\n", +"clc; clear;\n", +"E_max = 1.17; // Maximum energy of the beta particle, mega electron volts\n", +"D = 2.7; // Density of Al,gram per cubic metre\n", +"u_m = 22/E_max; // Mass absorption coefficient,centimetre square per gram\n", +"x_h = log(2)/(u_m*D); // Half value thickness for beta absorption, cm\n", +"printf('\nThe Half value thickness for beta absorption = %5.3f cm', x_h); \n", +"\n", +"// Result \n", +"// The Half value thickness for beta absorption = 0.014 cm " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 3.7: Beta_particles_passing_through_lead.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa3.7: : Page 125(2011)\n", +"clc; clear;\n", +"Z = 82; // Atomic number\n", +"E = 1; // Energy of the beta paricle, MeV\n", +"I_l = 800; // Ionisation loss, MeV\n", +"R = Z*E/I_l; // Ratio of radiation loss to ionisation loss\n", +"E_1 = I_l/Z; // Energy of the beta particle when radiation radiation loss is equal to ionisation loss, MeV\n", +"\n", +"printf('\nThe ratio of radiation loss to ionisation loss = %5.3e \nThe energy of the beta particle = %4.2f MeV ', R, E_1);\n", +"\n", +"// Result\n", +"// The ratio of radiation loss to ionisation loss = 1.025e-01 \n", +"// The energy of the beta particle = 9.76 MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 3.8: Thickness_of_gamma_absorption.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa3.8 : : Page 125(2011)\n", +"clc; clear;\n", +"x = 0.25; // Thickness of Al, metre\n", +"U_l = 1/x*log(50); // Linear absorption coefficient\n", +"d = 2700; // density of the Al, Kg per cubic centimetre \n", +"x_h = log(2)/U_l; // Half value thickness of Al, metre\n", +"U_m = U_l/d; // Mass absorption coefficient, square metre per Kg\n", +"printf('\nThe half value thickness of Al = %6.4f Kg per cubic metre \nThe mass absorption coefficient = %7.5f square metre per Kg ',x_h, U_m);\n", +"\n", +"// Result\n", +"// The half value thickness of Al = 0.0443 Kg per cubic metre \n", +"// The mass absorption coefficient = 0.00580 square metre per Kg " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 3.9: The_energy_of_recoil_electrons.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa3.9 : : Page-125(2011)\n", +"clc; clear;\n", +"E_g = 2.19*1.6e-013; // Energy of the gamma rays, joule\n", +"m_e = 9.10939e-031; // Mass of the electron, Kg\n", +"C = 3e+08; // Velocity of light, m/s\n", +"E_max = [E_g/(1+(m_e*C^2)/(2*E_g))]/(1.6e-013); // Energy of the compton recoil electron, MeV\n", +"printf('\nThe energy of the compton recoil electrons = %5.3f MeV', E_max); \n", +"\n", +"// Result \n", +"// The energy of the compton recoil electrons = 1.961 MeV" + ] + } +], +"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/Nuclear_Physics_by_D_C_Tayal/4-Detection_and_Measurement_of_Nuclear_Radiations.ipynb b/Nuclear_Physics_by_D_C_Tayal/4-Detection_and_Measurement_of_Nuclear_Radiations.ipynb new file mode 100644 index 0000000..6f10443 --- /dev/null +++ b/Nuclear_Physics_by_D_C_Tayal/4-Detection_and_Measurement_of_Nuclear_Radiations.ipynb @@ -0,0 +1,543 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 4: Detection and Measurement of Nuclear Radiations" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.10: Charge_collected_at_the_anode_of_photo_multiplier_tube.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa4.10 : : Page 180 (2011)\n", +"clc; clear;\n", +"E = 4e+006; // Energy lost in the scintillator, eV\n", +"N_pe = E/10^2*0.5*0.1; // Number of photoelectrons emitted\n", +"G = 10^6; // Gain of photomultiplier tube\n", +"e = 1.6e-019; // Charge of the electron, C\n", +"Q = N_pe*G*e; // Charge collected at the anode of photo multiplier tube, C\n", +"printf('\nThe charge collected at the anode of photo multiplier tube : %6.4e C', Q);\n", +"\n", +"// Result\n", +"// The charge collected at the anode of photo multiplier tube : 3.2000e-010 C " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.11: Charge_collected_at_the_anode_of_photo_multiplier_tube.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa11 : : Page 180 (2011)\n", +"E = 4e+06; // Energy lost in the scintillator, eV\n", +"N_pe = E/10^2*0.5*0.1; // Number of photoelectrons emitted\n", +"G = 10^6; // Gain\n", +"e = 1.6e-019; // Charge of the electron, C\n", +"Q = N_pe*G*e; // Charge collected at the anode of photo multiplier tube, C\n", +"printf('\nCharge collected at the anode of photo multiplier tube : %6.4e C',Q);\n", +"// Result\n", +"// Charge collected at the anode of photo multiplier tube : 3.2000e-010 C " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.12: Measurement_of_the_number_of_counts_and_determining_standard_deviation.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa4.12 : : Page 181 (2011)\n", +"// Defining an array\n", +"clc; clear;\n", +"n = cell (1,6); // Declare the cell matrix of 1X6 \n", +"n(1,1).entries = 10000;\n", +"n(2,1).entries = 10200;\n", +"n(3,1).entries = 10400;\n", +"n(4,1).entries = 10600;\n", +"n(5,1).entries = 10800;\n", +"n(6,1).entries = 11000;\n", +"g = 0; // \n", +"k = 6;\n", +"H = 0;\n", +"for i = 1:k;\n", +" g = g + n(i,1).entries\n", +"end;\n", +"N = g/k; // Mean of the count\n", +"D = sqrt(N);\n", +"for i = 1:k;\n", +" H = H+((n(i,1).entries-N)*(n(i,1).entries-N)) \n", +"end;\n", +"S_D = round(sqrt(H/(k-1)));\n", +"printf('\nStandard deviation of the reading : %d', S_D);\n", +"delta_N = sqrt(N);\n", +"if (S_D > delta_N) then\n", +" printf('\nThe foil cannot be considered uniform..!');\n", +"else\n", +" printf('\nThe foil can be considered uniform.');\n", +"end\n", +"\n", +"// Result\n", +"// Standard deviation of the reading : 374\n", +"// The foil cannot be considered uniform..! " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.13: Beta_particle_incident_on_the_scintillator.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa4.13 : : Page 181 (2011)\n", +"clc; clear;\n", +"V = 2e-03; // Voltage impulse, volt\n", +"C = 120e-012; // Capacitance of the capacitor, F\n", +"e = 1.6e-019; // Charge of the electron, C\n", +"n = C*V/(15*e); // No. of electons\n", +"N = n^(1/10); // No. of electrons in the output\n", +"printf('\nNo. of electrons in the output : %4.2f (approx)', N);\n", +"\n", +"// Result\n", +"// No. of electrons in the output : 3.16 (approx) " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.14: Time_of_flight_of_proton_in_scintillation_counter.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa4.14 : : Page 181 (2011)\n", +"clc; clear;\n", +"m_p = 0.938; // Mass of the proton, GeV\n", +"E = 1.4; // Total energy of proton, GeV\n", +"gama = E/m_p; // Boost parameter\n", +"bta = sqrt(1-1/gama^2); // Relativistic factor\n", +"d = 10; // Distance between two counters,m\n", +"C = 3e+08; // Velocity of light ,m/s\n", +"t_p = d/(bta*C); // Time of flight of proton ,sec\n", +"T_e = d/C; // Time of flight of electron, sec\n", +"printf('\nTime of flight of proton: %4.2f ns \nTime of flight of electron : %4.2f ns ', t_p/1e-009, T_e/1e-009);\n", +"\n", +"// Result\n", +"// Time of flight of proton: 44.90 ns \n", +"// Time of flight of electron : 33.33 ns " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.15: Fractional_error_in_rest_mass_of_the_particle_with_a_Cerenkov_Detector.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa4.15 : : Page 182 (2011)\n", +"clc; clear;\n", +"p = 100; // Momentum of the particle, GeV\n", +"n = 1+1.35e-04; // Refractive index of the gas \n", +"m_0 = 1; // Mass, GeV per square coulomb\n", +"gama = sqrt((p^2+m_0^2)/m_0); // Boost parameter\n", +"bta = sqrt (1-1/gama^2); // Relativistic parameter\n", +"d_theta = 1e-003; // Error in the emission angle, radian\n", +"theta = acos(1/(n*bta)); // Emision angle of photon, radian \n", +"F_err = (p^2*n^2*2*theta*10^-3)/(2*m_0^2); // Fractional error\n", +"printf('\nThe fractional error in rest mass of the particle = %4.2f', F_err);\n", +"\n", +"// Result \n", +"// The fractional error in rest mass of the particle = 0.13 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.16: Charged_particles_passing_through_the_Cerenkov_detector.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa4.16 : : Page 182 (2011)\n", +"clc; clear;\n", +"u = 1.49; // Refractive index\n", +"E = 20*1.60218e-019; // Energy of the electron, joule\n", +"m_e = 9.1e-031; // Mass of the electron, Kg\n", +"C = 3e-08; // Velocity of the light, m/s\n", +"bta = (1 + {1/(E/(m_e*C^2)+1)}^2 ); // Boost parameter\n", +"z = 1; // \n", +"L_1 = 4000e-010; // Initial wavelength, metre\n", +"L_2 = 7000e-010; // Final wavelength, metre\n", +"N = 2*%pi*z^2/137*(1/L_1-1/L_2)*(1-1/(bta^2*u^2)); // Number of quanta of visible light, quanta per centimetre\n", +"printf('\nThe total number of quantas during emission of visible light = %d quanta/cm', round(N/100));\n", +"\n", +"// Result \n", +"// The total number of quantas during emission of visible light = 270 quanta/cm " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.1: Resultant_pulse_height_recorded_in_the_fission_chamber.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa4.1 : : Page 178 (2011)\n", +"clc; clear;\n", +"N = 200e+006/35; // Total number of ion-pairs\n", +"e = 1.60218e-019; // Charge of an ion, coulomb\n", +"Q = N*e; // Total charge produced in the chamber, coulomb\n", +"C = 25e-012; // Capacity of the collector, farad\n", +"V = Q/C; // Resultant pulse height, volt \n", +"printf('\nThe resultant pulse height recorded in the fission chamber = %4.2e volt', V);\n", +"\n", +"// Result\n", +"// The resultant pulse height recorded in the fission chamber = 3.66e-002 volt " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.2: Energy_of_the_alpha_particles.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa4.2 : : Page 178 (2011)\n", +"clc; clear;\n", +"V = 0.8/4; // Pulse height, volt\n", +"e = 1.60218e-019; // Charge of an ion, coulomb\n", +"C = 0.5e-012; // Capacity of the collector, farad\n", +"Q = V*C; // Total charge produced, coulomb\n", +"N = Q/e; // Number of ion pairs \n", +"E_1 = 35; // Energy of one ion pair, electron volt\n", +"E = N*E_1/10^6; // Energy of the alpha particles, mega electron volt\n", +"printf('\nThe energy of the alpha particles = %4.3f MeV', E);\n", +"\n", +"// Result\n", +"// The energy of the alpha particles = 21.845 MeV (The answer is wrong in the textbook)" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.3: Height_of_the_voltage_pulse.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa4.3 : : Page 178 (2011)\n", +"clc; clear;\n", +"E = 10e+06; // Energy produced by the ion pairs, electron volts \n", +"N = E/35; // Number of ion pair produced\n", +"m = 10^3; // Multiplication factor\n", +"N_t = N*m; // Total number of ion pairs produced\n", +"e = 1.60218e-019; // Charge of an ion, coulomb\n", +"Q = N_t*e; // Total charge flow in the counter, coulomb\n", +"t = 10^-3; // Pulse time, sec\n", +"R = 10^4; // Resistance , ohm\n", +"I = Q/t; // Current passes through the resistor, ampere\n", +"V = I*R; // Height of the voltage pulse, volt\n", +" printf('\nTotal number of ion pairs produced: %5.3e \nTotal charge flow in the counter : %5.3e coulomb \nHeight of the voltage pulse : %5.3e volt', N_t, Q, V);\n", +" \n", +"// Result\n", +"// Total number of ion pairs produced: 2.857e+008 \n", +"// Total charge flow in the counter : 4.578e-011 coulomb\n", +"// Height of the voltage pulse : 4.578e-004 volt " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.4: Radial_field_and_life_time_of_Geiger_Muller_Counter.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa4.4 : : Page 178 (2011)\n", +"clc; clear;\n", +"V = 1000; // Operating voltage of Counter, volt \n", +"x = 1e-004; // Time taken, sec\n", +"b = 2; // Radius of the cathode, cm\n", +"a = 0.01; // Diameter of the wire, cm\n", +"E_r = V/(x*log(b/a)); // Radial electric field, V/m\n", +"C = 1e+009; // Total counts in the GM counter\n", +"T = C/(50*60*60*2000); // Life of the G.M. Counter, year\n", +"printf('\nThe radial electric field: %4.2eV/m\nThe life of the G.M. Counter : %5.3f years', E_r, T);\n", +"\n", +"// Result\n", +"// The radial electric field: 1.89e+006V/m\n", +"// The life of the G.M. Counter : 2.778 years " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.5: Avalanche_voltage_in_Geiger_Muller_tube.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa4.5 : : Page 178 (2011)\n", +"clc; clear; \n", +"I = 15.7; // Ionisation potential of argon, eV\n", +"b = 0.025; // Radius of the cathode, metre\n", +"a = 0.006e-02; // Radius of the wire, metre\n", +"L = 7.8e-06; // Mean free path, metre\n", +"V = round(I*a*log(b/a)/L); // Avalanche voltage in G.M. tube, volt\n", +"printf('\nThe avalanche voltage in G.M. tube = %d volt', V);\n", +"\n", +"// Result\n", +"// The avalanche voltage in G.M. tube = 729 volt " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.6: Voltage_fluctuation_in_GM_tube.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa4.6 : : Page 179 (2011)\n", +"clc; clear;\n", +"C_r = 0.1e-02; // Counting rate of GM tube\n", +"S = 3; // Slope of the curve\n", +"V = C_r*100*100/S; // Voltage fluctuation, volt\n", +"printf('\nThe voltage fluctuation GM tube = %4.2f volt', V);\n", +"\n", +"// Result\n", +"// The voltage fluctuation GM tube = 3.33 volt " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.7: Time_measurement_of_counts_in_GM_counter.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa4.7 : : Page-179 (2011)\n", +"clc; clear;\n", +"R_t = 100; // Actual count rate, per sec\n", +"R_B = 25; // Backward count rate, per sec\n", +"V_S = 0.03; // Coefficient of variation\n", +"R_S = R_t-R_B; // Source counting rate,per sec\n", +"T_t = (R_t+sqrt(R_t*R_B))/(V_S^2*R_S^2); // Time measurement for actual count, sec\n", +"T_B = T_t*sqrt(R_B/R_t); // Time measurement for backward count, sec\n", +"printf('\nTime measurement for actual count : %5.3f sec \nTime measurement for backward count : %4.1f sec', T_t, T_B);\n", +"\n", +"// Result\n", +"// Time measurement for actual count : 29.630 sec \n", +"// Time measurement for backward count : 14.8 sec" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.8: Capacitance_of_the_silicon_detector.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa4.8 : : Page-179 (2011)\n", +"clc; clear; \n", +"A = 1.5e-4; // Area of capacitor plates, square metre\n", +"K = 12; // Dielectric constant\n", +"D = K*8.8542e-012; // Electrical permittivity of the medium, per newton-metre-square coulomb square\n", +"x = 50e-06; // Width of depletion layer, metre\n", +"C = A*D/x*10^12; // Capacitance of the silicon detector, pF\n", +"E = 4.5e+06; // Energy produced by the ion pairs, eV\n", +"N = E/3.5; // Number of ion pairs\n", +"e = 1.60218e-019; // Charge of each ion, coulomb\n", +"Q = N*e; // Total charge, coulomb\n", +"V = Q/C*10^12; // Potential applied across the capacitor, volt\n", +"printf('\nThe capacitance of the detector : %6.2f pF\nThe potential applied across the capacitor : %4.2e volt', C, V);\n", +"\n", +"// Result\n", +"// The capacitance of the detector : 318.75 pF\n", +"// The potential applied across the capacitor : 6.46e-004 volt " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 4.9: Statistical_error_on_the_measured_ratio.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa4.9 : : Page-180 (2011)\n", +"clc; clear;\n", +"N_A = 1000; // Number of count observed for radiation A\n", +"N_B = 2000; // Number of count observed for radiation B\n", +"r = N_A/N_B; // Ratio of count A to the count B\n", +"E_r = sqrt(1/N_A+1/N_B); // Statistical error \n", +"printf('\nThe statistical error of the measured ratio = %4.2f', E_r*r);\n", +"\n", +"// Result\n", +"// The statistical error of the measured ratio = 0.02 (Wrong answer in the textbook)" + ] + } +], +"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/Nuclear_Physics_by_D_C_Tayal/5-Alpha_Particles.ipynb b/Nuclear_Physics_by_D_C_Tayal/5-Alpha_Particles.ipynb new file mode 100644 index 0000000..39a50ec --- /dev/null +++ b/Nuclear_Physics_by_D_C_Tayal/5-Alpha_Particles.ipynb @@ -0,0 +1,285 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 5: Alpha Particles" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.10: Degree_of_hindrance_for_alpha_particle_from_U238.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa5.10 : : Page 206 (2011)\n", +"clc; clear;\n", +"h_kt = 1.05457e-34; // Reduced Planck's constant, joule sec\n", +"e = 1.60218e-19; // Charge of an electron, coulomb\n", +"l = 2; // Orbital angular momentum\n", +"eps_0 = 8.5542e-12; // Absolute permittivity of free space, coulomb square per newton per metre square\n", +"Z_D = 90; // Atomic number of daughter nucleus\n", +"m = 6.644e-27; // Mass of alpha particle, Kg\n", +"R = 8.627e-15; // Radius of daughter nucleus, metre\n", +"T1_by_T0 = exp(2*l*(l+1)*h_kt/e*sqrt(%pi*eps_0/(Z_D*m*R))); // Hindrance factor\n", +"printf('\nThe hindrance factor for alpha particle = %5.3f' ,T1_by_T0);\n", +"\n", +"// Result\n", +"// The hindrance factor for alpha particle = 1.768 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.1: Disintegration_energy_of_alpha_particle.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa5.1 : : Page 203 (2011)\n", +"clc; clear;\n", +"E_a = 8.766; // Energy of the alpha particle, MeV\n", +"A = 212; // Atomic mass of Po-212, amu\n", +"M_a = 4; // Atomic mass of alpha particle, amu\n", +"e = 1.6e-019; // Charge of an electron, coulomb\n", +"Z = 82; // Atomic number of Po-212\n", +"R_0 = 1.4e-015; // Distance of closest approach,metre\n", +"K = 8.99e+09; // Coulomb constant\n", +"E = E_a*A/(A-M_a); // Disintegration energy, mega electron volts\n", +"B_H = 2*Z*e^2*K/(R_0*A^(1/3)*1.6*10^-13); // Barrier height for an alpha particle within the nucleus, MeV\n", +"printf('\nDisintegration energy : %5.3f MeV \nBarrier height for alpha-particle: %5.2f MeV', E,B_H);\n", +"\n", +"// Result\n", +"// Disintegration energy : 8.935 MeV \n", +"// Barrier height for alpha-particle: 28.26 MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.2: Calculation_of_the_barrier_height.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa5.2 : : Page 203 (2011)\n", +"// We have to make calculation for alpha particle and for proton\n", +"clc; clear;\n", +"E_a = 8.766; // Energy of the alpha particle, mega electron volts\n", +"A_Bi = 209; // Atomic mass of Bi-209, atomic mass unit\n", +"A_a = 4; // Atomic mass of alpha particle, atomic mass unit\n", +"A_p = 1; // Atomic mass of proton, atomic mass unit\n", +"e = 1.6e-019; // Charge of an electron, coulomb\n", +"Z = 83; // Atomic number of bismuth\n", +"R_0 = 1.4e-015; // Distance of closest approach,metre\n", +"K = 8.99e+09; // Coulomb constant\n", +"B_H_a = 2*Z*e^2*K/(R_0*1.6e-013*(A_Bi^(1/3)+A_a^(1/3))); // Barrier height for an alpha particle, mega electron volts\n", +"B_H_p = 1*Z*e^2*K/(R_0*1.6e-013*(A_Bi^(1/3)+A_p^(1/3))); // Barrier height for proton, mega electron volts\n", +"printf('\nBarrier height for the alpha particle = %5.2f MeV \nBarrier height for the proton = %5.2f MeV', B_H_a,B_H_p);\n", +"\n", +"// Result\n", +"// Barrier height for the alpha particle = 22.67 MeV \n", +"// Barrier height for the proton = 12.30 MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.3: Speed_and_BR_value_of_alpha_particles.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa5.3 : : Page 203 (2011)\n", +"// We have also calculate the value of magnetic field in a particular orbit. \n", +"clc; clear;\n", +"C = 3e+08; // Velocity of light, m/S\n", +"M_0 = 6.644e-027*(C)^2/(1.60218e-013); // Rest mass of alpha particle, MeV\n", +"T = 5.998; // Kinetic energy of alpha particle emitted by Po-218\n", +"q = 2*1.60218e-019; // Charge of alpha particle, C\n", +"V = sqrt(C^2*T*(T+2*M_0)/(T+M_0)^2); // Velocity of alpha particle,metre per sec\n", +"B_r = V*M_0*(1.60218e-013)/(C^2*q*sqrt(1-V^2/C^2)); // magnetic field in a particular orbit, Web per mtere\n", +"printf('\nThe velocity of alpha particle : %5.3e m/s\nThe magnetic field in a particular orbit : %6.4f Wb/m', V , B_r);\n", +"\n", +"// Result\n", +"// The velocity of alpha particle : 1.699e+007 m/s\n", +"// The magnetic field in a particular orbit : 0.3528 Wb/m " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.4: Transmission_probability_for_an_alpha_particle_through_a_potential_barrier.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa5.4: : Page 204 (2011)\n", +"clc; clear;\n", +"a = 10^-14; // Width of the potential barrier, m\n", +"E = 5*1.60218e-013; // Energy of the alpha particle, joule\n", +"V = 10*1.60218e-013; // Potential height, joule\n", +"M_0 = 6.644e-027; // Rest mass of the alpha particle, joule\n", +"h_red = 1.05457e-034; // Reduced value of Planck's constant,joule sec \n", +"T = 4*exp(-2*a*sqrt(2*M_0*(V-E)/h_red^2)); // Probability of leakage through through potential barrier\n", +"printf('\nThe probability of leakage of alpha-particle through potential barrier = %5.3e ',T);\n", +"\n", +"// Result\n", +"// The probability of leakage of alpha-particle through potential barrier = 1.271e-008 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.6: Difference_in_life_times_of_Polonium_isotopes.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa5.6: : Page 204 (2011)\n", +"clc; clear; \n", +"Z_D = 82; // Atomic number of Po\n", +"E_Po210 = 5.3; // Alpha-source for Po210, MeV\n", +"E_Po214 = 7.7; // Alpha-source for Po214, MeV\n", +"log_lambda_Po210 = -1*1.72*Z_D*E_Po210^(-1/2); \n", +"log_lambda_Po214 = -1*1.72*Z_D*E_Po214^(-1/2); \n", +"delta_OM_t = log_lambda_Po214 - log_lambda_Po210; // Difference in order of magnitude of life times of Po214 and Po210\n", +"printf('\nThe disintegration constant increases by a factor of some 10^%2d', delta_OM_t);\n", +"\n", +"// Result\n", +"// The disintegration constant increases by a factor of some 10^10 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.8: Half_life_of_plutonium.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa5.8: : Page 205 (2011)\n", +"clc; clear;\n", +"N = 120.1*6.023e+023/239; // Number of Pu nuclei\n", +"P_rel = 0.231; // Power released, watt\n", +"E_rel = 5.323*1.6026e-13; // Energy released, joule\n", +"decay_rate = P_rel/E_rel; // Decay rate of Pu239, per hour\n", +"t_half = N*log(2)/(decay_rate*365*86400); // Half life of Po239, sec\n", +"printf('\nThe half life of Pu = %4.2e yr', t_half);\n", +"\n", +"// Result\n", +"// The half life of Pu = 2.46e+004 yr " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 5.9: Slope_of_alpha_decay_energy_versus_atomic_number.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa5.9 : : Page 205(2011)\n", +"clc; clear;\n", +"a_v = 14; // Volume energy constant, MeV\n", +"a_s = 13; // Surface energy constant, MeV\n", +"a_c = 0.60; // Coulomb energy constant, MeV\n", +"a_a = 19; // Asymmetric energy constant, MeV\n", +"A = 202; // Mass number\n", +"Z = 82; // Atomic number \n", +"dE_by_dN = -8/9*a_s/A^(4/3)-4/3*a_c*Z/A^(4/3)*(1-4*Z/(3*A))-16*a_a*Z/A^2*(1-2*Z/A); // Slope, mega electron volts per nucleon\n", +"printf('\nThe slope of alpha decay energy versus atomic number = %7.5f MeV/nucleon', dE_by_dN);\n", +"\n", +"// Result\n", +"// The slope of alpha decay energy versus atomic number = -0.15007 MeV/nucleon " + ] + } +], +"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/Nuclear_Physics_by_D_C_Tayal/6-Beta_Decay.ipynb b/Nuclear_Physics_by_D_C_Tayal/6-Beta_Decay.ipynb new file mode 100644 index 0000000..6974466 --- /dev/null +++ b/Nuclear_Physics_by_D_C_Tayal/6-Beta_Decay.ipynb @@ -0,0 +1,544 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 6: Beta Decay" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.10: Half_life_of_tritium.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa6.10: : Page-244 (2011)\n", +"clc; clear;\n", +"tau_0 = 7000; // Time constant, sec\n", +"M_mod_sqr = 3; // Nuclear matrix\n", +"E_0 = 0.018; // Energy of beta spectrum, MeV \n", +"ft = 0.693*tau_0/M_mod_sqr; // Comparative half life\n", +"fb = 10^(4.0*log10(E_0)+0.78+0.02); //\n", +"t = 10^(log10(ft)-log10(fb)); // Half life of H3, sec\n", +"printf('\nThe half life of H3 = %4.2e sec', t);\n", +"\n", +"// Result\n", +"// The half life of H3 = 2.44e+009 sec " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.11: Degree_of_forbiddenness_of_transition.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa6.11: : Page-244 (2011)\n", +"clc; clear;\n", +"t_p = 33/0.92*365*84800; // Partial half life for beta emission, sec\n", +"E_0 = 0.51; // Kinetic energy\n", +"Z = 55; // Atomic number of cesium\n", +"log_fb = 4.0*log10(E_0)+0.78+0.02*Z-0.005*(Z-1)*log10(E_0); // Comparitive half life\n", +"log_ft1 = log_fb+log10(t_p); // Forbidden tansition\n", +"// For 8 percent beta minus emission\n", +"t_p = 33/0.08*365*84800; // Partial half life, sec\n", +"E_0 = 1.17; // Kinetic energy\n", +"Z = 55; // Atomic energy\n", +"log_fb = 4.0*log10(E_0)+0.78+0.02*Z-0.005*(Z-1)*log10(E_0); // Comparitive half life\n", +"log_ft2 = log_fb+log10(t_p); // Forbidden transition\n", +"// Check the degree of forbiddenness !!!!!\n", +"if log_ft1 <= 10 then\n", +" printf('\nFor 92 percent beta emission :')\n", +" printf('\n\tTransition is once forbidden and parity change');\n", +"end\n", +"if log_ft2 >= 10 then\n", +" printf('\nFor 8 percent beta emission :')\n", +" printf('\n\t ransition is twice forbidden and no parity change');\n", +"end\n", +"\n", +"// Result\n", +"// For 92 percent beta emission :\n", +"// Transition is once forbidden and parity change\n", +"// For 8 percent beta emission :\n", +"// Transition is twice forbidden and no parity change\n", +" " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.12: Coupling_constant_and_ratio_of_coupling_strengths_for_beta_transitons.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa6.12: : Page-244(2011)\n", +"clc; clear;\n", +"h_kt = 1.05457e-34; // Reduced planck's constant, joule sec\n", +"c = 3e+08; // velocity of light, metre per sec\n", +"m_e = 9.1e-31; // Mass of the electron, Kg\n", +"ft_O = 3162.28; // Comparative half life for oxygen\n", +"ft_n = 1174.90; // Comparative half life for neutron\n", +"M_f_sqr = 2 // Matrix element\n", +"g_f = sqrt(2*%pi^3*h_kt^7*log(2)/(m_e^5*c^4*ft_O*M_f_sqr)); // Coupling constant, joule cubic metre\n", +"C_ratio = (2*ft_O/(ft_n)-1)/3; // Ratio of coupling strength\n", +"printf('\nThe value of coupling constant = %6.4e joule cubic metre\nThe ratio of coupling constant = %5.3f', g_f, C_ratio);\n", +"\n", +"// Result\n", +"// The value of coupling constant = 1.3965e-062 joule cubic metre\n", +"// The ratio of coupling constant = 1.461 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.13: Relative_capture_rate_in_holmium_for_3p_to_3s_sublevels.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa6.13: : Page-245 (2011)\n", +"clc; clear;\n", +"Q_EC = 850; // Q value for holmium 161, keV\n", +"B_p = 2.0; // Binding energy for p-orbital electron, keV\n", +"B_s = 1.8; // Binding energy for s-orbital electron, keV\n", +"M_ratio = 0.05*(Q_EC-B_p)^2/(Q_EC-B_s)^2; // Matrix ratio\n", +"Q_EC = 2.5; // Q value for holmium 163, keV\n", +"C_rate = M_ratio*(Q_EC-B_s)^2/(Q_EC-B_p)^2*100; // The relative capture rate in holmium, percent\n", +"printf('\nThe relative capture rate in holmium 161 = %3.1f percent', C_rate);\n", +"\n", +"// Result\n", +"// The relative capture rate in holmium 161 = 9.8 percent " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.14: Tritium_isotope_undergoing_beta_decay.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa6.14: : Page-246 (2011)\n", +"clc; clear;\n", +"t_half = 12.5*365*24; // Half life of hydrogen 3, hour\n", +"lambda = log(2)/t_half; // Decay constant, per hour\n", +"N_0 = 6.023e+26; // Avogadro's number, per mole\n", +"m = 0.1e-03; // Mass of tritium, Kg\n", +"dN_by_dt = lambda*m*N_0/3; // Decay rate, per hour\n", +"H = 21*4.18; // Heat produed, joule \n", +"E = H/dN_by_dt; // The average energy of the beta particle, joule\n", +"printf('\nThe average energy of beta particles = %4.2e joule = %3.1f keV', E, E/1.6e-016);\n", +"\n", +"// Result\n", +"// The average energy of beta particles = 6.91e-016 joule = 4.3 keV \n", +" " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.15: Fermi_and_Gamow_Teller_selection_rule_for_allowed_beta_transitions.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa6.15: : Page-246 (2011)\n", +"clc; clear;\n", +"S = string(rand(2,1))\n", +"S(1,1) = 'antiparallel spin'\n", +"S(2,1) = 'parallel spin'\n", +"\n", +"for i = 1:2\n", +" if S(i,1) == 'antiparallel spin' then\n", +" printf('\nFor Fermi types :')\n", +" printf('\n\n The selection rules for allowed transitions are : \n\tdelta I is zero \n\tdelta pi is plus \nThe emited neutrino and electron have %s',S(i,1))\n", +" elseif S(i,1) == 'parallel spin' then\n", +" printf('\nFor Gamow-Teller types :')\n", +" printf('\nThe selection rules for allowed transitions are : \n\tdelta I is zero,plus one and minus one\n\tdelta pi is plus\nThe emited neutrino and electron have %s',S(i,1)) \n", +" end\n", +" end\n", +"// Calculation of ratio of transition probability\n", +"M_F = 1; // Matrix for Fermi particles\n", +"g_F = 1; // Coupling constant of fermi particles\n", +"M_GT = 5/3; // Matrix for Gamow Teller\n", +"g_GT = 1.24; // Coupling constant of Gamow Teller\n", +"T_prob = g_F^2*M_F/(g_GT^2*M_GT); // Ratio of transition probability\n", +"// Calculation of Space phase factor\n", +"e = 1.6e-19; // Charge of an electron, coulomb\n", +"c = 3e+08; // Velocity of light, metre per sec\n", +"K = 8.99e+9; // Coulomb constant\n", +"R_0 = 1.2e-15; // Distance of closest approach, metre\n", +"A = 57; // Mass number\n", +"Z = 28; // Atomic number \n", +"m_n = 1.6749e-27; // Mass of neutron, Kg\n", +"m_p = 1.6726e-27; // Mass of proton, Kg\n", +"m_e = 9.1e-31; // Mass of electron. Kg\n", +"E_1 = 0.76; // First excited state of nickel\n", +"delta_E = ((3*e^2*K/(5*R_0*A^(1/3))*((Z+1)^2-Z^2))-(m_n-m_p)*c^2)/1.6e-13; // Mass difference, mega electron volts\n", +"E_0 = delta_E-(2*m_e*c^2)/1.6e-13; // End point energy, mega electron volts\n", +"P_factor = (E_0-E_1)^5/E_0^5; // Space phase factor \n", +" printf('\nThe ratio of transition probability = %4.2f\nThe space phase factor = %4.2f', T_prob, P_factor);\n", +" \n", +"// Result\n", +"// The emited neutrino and electron have antiparallel spin\n", +"// For Gamow-Teller types :\n", +"// The selection rules for allowed transitions are : \n", +"// delta I is zero,plus one and minus one\n", +"// delta pi is plus\n", +"// The emited neutrino and electron have parallel spin\n", +"// The ratio of transition probability = 0.39\n", +"// The space phase factor = 0.62 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.1: Disintegration_of_the_beta_particles_by_Bi210.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa6.1: : Page- 240 (2011)\n", +"clc; clear;\n", +"T = 5*24*60*60; // Half life of the substance, sec\n", +"N = 6.023e+026*4e-06/210; // Number of atoms\n", +"lambda = 0.693/T; // Disintegration constant, per sec\n", +"K = lambda*N; // Rate of disintegration, \n", +"E = 0.34*1.60218e-013; // Energy of the beta particle, joule\n", +"P = E*K; // Rate at which energy is emitted, watt\n", +"printf('\nThe rate at which energy is emitted = %d watt', P);\n", +"\n", +"// Result\n", +"// The rate at which energy is emitted = 1 watt " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.2: Beta_particle_placed_in_the_magnetic_field.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa6.2 : : Page-241 (2011)\n", +"clc; clear;\n", +"M_0 = 9.10939e-031; // Rest mass of the electron, Kg\n", +"C = 2.92e+08; // Velocity of the light, metre per sec\n", +"E = 1.71*1.60218e-013; // Energy of the beta particle, joule\n", +"e = 1.60218e-019; // Charge of the electron, C \n", +"R = 0.1; // Radius of the orbit, metre\n", +"B = M_0*C*(E/(M_0*C^2)+1)*1/(R*e); // Magnetic field perpendicular to the beam of the particle, weber per square metre\n", +"\n", +"printf('\nThe magnetic field perpendicular to the beam of the particle = %5.3f Wb/square-metre', B);\n", +"\n", +"// Result\n", +"// The magnetic field perpendicular to the beam of the particle = 0.075 Wb/square-metre " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.3: K_conversion.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa6.3 : : Page-241 (2011)\n", +"clc; clear;\n", +"m_0 = 9.10963e-031; // Rest mass of the electron, Kg\n", +"e = 1.60218e-019; // Charge of the electron, C\n", +"c = 2.9979e+08; // Velocity of the light, metre per sec\n", +"BR = 3381e-006; // Field-radius product, tesla-m\n", +"E_k = 37.44; // Binding energy of k-electron\n", +"v = 1/sqrt((m_0/(BR*e))^2+1/c^2); // Velocity of the converson electron, m/s\n", +"E = m_0*c^2*(1/sqrt(1-v^2/c^2)-1)/(e*1e+003); // Energy of the electron, keV \n", +"E_C = E+E_k; // Energy of the converted gamma ray photon, KeV\n", +"printf('\nThe energy of the electron = %6.2f keV \nThe energy of the converted gamma ray photon = %6.2f keV', E, E_C);\n", +"\n", +"// Result\n", +"// The energy of the electron = 624.11 keV \n", +"// The energy of the converted gamma ray photon = 661.55 keV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.4: Average_energy_carried_away_by_neutrino_during_beta_decay_process.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa6.4 : : Page-241 (2011)\n", +"clc; clear;\n", +"E = 18.1; // Energy carried by beta particle, keV \n", +"E_av = E/3; // Average energy carried away by beta particle, keV\n", +"E_r = E-E_av; // The rest energy carried out by the neutrino, keV\n", +"\n", +"printf('\nThe rest energy carried out by the neutrino : %5.3f KeV', E_r);\n", +"\n", +"// Result\n", +"// The rest energy carried out by the neutrino : 12.067 KeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.5: Maximum_energy_available_to_the_electrons_in_the_beta_decay_of_Na24.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa6.5: : Page-242(2011)\n", +"clc; clear;\n", +"M_Na = -8420.40; // Mass of sodium 24, keV\n", +"M_Mg = -13933.567; // Mass of magnesium 24, keV\n", +"E = (M_Na-M_Mg)/1000; // Energy of the electron, MeV\n", +"printf('\nThe maximum energy available to the electrons in the beta decay = %5.3f MeV', E);\n", +"\n", +"// Result\n", +"// The maximum energy available to the electrons in the beta decay = 5.513 MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.6: Linear_momenta_of_particles_during_beta_decay_process.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa6.6: : Page-242 (2011)\n", +"clc; clear;\n", +"c = 1; // For simplicity assume speed of light to be unity, m/s\n", +"E_0 = 0.155; // End point energy, mega electron volts\n", +"E_beta = 0.025; // Energy of beta particle, mega electron volts\n", +"E_v = E_0-E_beta; // Energy of the neutrino, mega electron volts\n", +"p_v = E_v/c; // Linear momentum of neutrino, mega electron volts per c\n", +"m = 0.511; // Mass of an electron, Kg\n", +"M = 14*1.66e-27; // Mass of carbon 14,Kg\n", +"c = 3e+8; // Velocity of light, metre per sec\n", +"e = 1.60218e-19; // Charge of an electron, coulomb\n", +"p_beta = sqrt(2*m*E_beta); // Linear momentum of beta particle, MeV/c\n", +"sin_theta = p_beta/p_v*sind(45); // Sine of angle theta\n", +"p_R = p_beta*cosd(45)+p_v*sqrt(1-sin_theta^2); // Linear momemtum of recoil nucleus, MeV/c\n", +"E_R = (p_R*1.6e-13/2.9979e+08)^2/(2*M*e); // Recoil energy of product nucleus, MeV\n", +"printf('\nThe linear momentum of neutrino = %4.2f MeV/c \nThe linear momentum of beta particle = %6.4f MeV/c \nThe energy of the recoil nucleus = %4.2f eV', p_v, p_beta, E_R);\n", +"\n", +"// Result\n", +"// The linear momentum of neutrino = 0.13 MeV/c \n", +"// The linear momentum of beta particle = 0.1598 MeV/c \n", +"// The energy of the recoil nucleus = 1.20 eV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.7: Energies_during_disintergation_of_Bi210.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa6.7: : Page-242 (2011)\n", +"clc; clear;\n", +"N = 3.7e+10*60; // Number of disintegration, per sec\n", +"H = 0.0268*4.182; // Heat produced at the output, joule\n", +"E = H/(N*1.6e-013); // Energy of the beta particle, joule\n", +"M_Bi = -14.815; // Mass of Bismuth, MeV\n", +"M_Po = -15.977; // Mass of polonium, MeV\n", +"E_0 = M_Bi-M_Po; // End point energy, MeV\n", +"E_ratio = E/E_0; // Ratio of beta particle energy with end point energy\n", +"printf('\nThe energy of the beta particle = %5.3f MeV \nThe ratio of beta particle energy with end point energy = %5.3f ', E, E_ratio);\n", +"\n", +"// Result\n", +"// The energy of the beta particle = 0.316 MeV \n", +"// The ratio of beta particle energy with end point energy = 0.272 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.9: The_unstable_nucleus_in_the_nuclide_pair.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa6.9: : Page-243(2011)\n", +"clc; clear;\n", +"M = rand(4,2);\n", +"M(1,1) = 7.0182*931.5; // Mass of lithium, MeV\n", +"M(1,2) = 7.0192*931.5; // Mass of beryllium, MeV\n", +"M(2,1) = 13.0076*931.5; // Mass of carbon, MeV\n", +"M(2,2) = 13.0100*931.5; // Mass of nitrogen, MeV\n", +"M(3,1) = 19.0045*931.5; // Mass of fluorine, MeV\n", +"M(3,2) = 19.0080*931.5; // Mass of neon, MeV\n", +"M(4,1) = 33.9983*931.5; // Mass of phosphorous, MeV\n", +"M(4,2) = 33.9987*931.5; // Mass of sulphur, MeV\n", +"j = 1; \n", +"// Check the stability !!!!\n", +"for i = 1:4\n", +" if round (M(i,j+1)-M(i,j)) == 1 then\n", +" printf('\n From pair a :')\n", +" printf('\n Be(4,7) is unstable');\n", +" elseif round (M(i,j+1)-M(i,j)) == 2 then\n", +" printf('\n From pair b :')\n", +" printf('\n N(7,13) is unstable');\n", +" elseif round (M(i,j+1)-M(i,j)) == 3 then\n", +" printf('\n From pair c :')\n", +" printf('\n Ne(10,19) is unstable');\n", +" elseif round (M(i,j+1)-M(i,j)) == 0 then\n", +" printf('\n From pair d :')\n", +" printf('\n P(15,34) is unstable');\n", +" end \n", +"end\n", +"\n", +"// Result\n", +"// \n", +"// From pair a :\n", +"// Be(4,7) is unstable\n", +"// From pair b :\n", +"// N(7,13) is unstable\n", +"// From pair c :\n", +"// Ne(10,19) is unstable\n", +"// From pair d :\n", +"// P(15,34) is unstable " + ] + } +], +"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/Nuclear_Physics_by_D_C_Tayal/7-Gamma_Radiation.ipynb b/Nuclear_Physics_by_D_C_Tayal/7-Gamma_Radiation.ipynb new file mode 100644 index 0000000..3716cf5 --- /dev/null +++ b/Nuclear_Physics_by_D_C_Tayal/7-Gamma_Radiation.ipynb @@ -0,0 +1,360 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 7: Gamma Radiation" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.10: EX7_10.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa7.10: : Page-296 (2011)\n", +"clc; clear;\n", +"l = 2,3,4\n", +"printf('\nThe possible multipolarities are ')\n", +"for l = 2:4\n", +" if l == 2 then\n", +" printf('E%d,', l);\n", +" elseif l == 3 then\n", +" printf(' M%d', l);\n", +" elseif l == 4 then\n", +" printf(' and E%d', l);\n", +" end\n", +"end\n", +"for l = 2:4\n", +" if l == 2 then \n", +" printf('\nThe transition E%d dominates',l);\n", +" end\n", +"end\n", +"\n", +"// Result\n", +"// The possible multipolarities are E2, M3 and E4\n", +"// The transition E2 dominates \n", +"\n", +"" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.13: Relative_source_absorber_velocity_required_to_obtain_resonance_absorption.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa7.13: : Page-297 (2011)\n", +"clc; clear;\n", +"E_0 = 0.014*1.6022e-13; // Energy of the gamma rays, joule\n", +"A = 57; // Mass number\n", +"m = 1.67e-27; // Mass of each nucleon, Kg\n", +"c = 3e+08; // Velocity of light, metre per sec\n", +"N = 1000; // Number of atoms in the lattice\n", +"v = E_0/(A*N*m*c); // Ralative velocity, metre per sec\n", +"printf('\nThe relative source absorber velocity = %5.3f m/s', v);\n", +"\n", +"// Result\n", +"// The relative source absorber velocity = 0.079 m/s \n", +"\n", +"" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.14: Estimating_the_frequency_shift_of_a_photon.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa7.14: : Page-297 (2011)\n", +"clc; clear;\n", +"g = 9.8; // Acceleration due to gravity, metre per square sec\n", +"c = 3e+08; // Velocity of light, metre per sec\n", +"y = 20; // Vertical distance between source and absorber, metre\n", +"delta_v = g*y/c^2; // Frequency shift\n", +"printf('\nThe required frequency shift of the photon = %4.2e ', delta_v);\n", +"\n", +"// Result\n", +"// The required frequency shift of the photon = 2.18e-015 \n", +"\n", +"" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.1: Bragg_reflection_for_first_order_in_a_bent_crystal_spectrometer.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa7.1: : Page-292 (2011)\n", +"clc; clear;\n", +"h = 6.6261e-034; // Planck's constant, joule sec\n", +"C = 2.998e+08; // Velocity of light, metre per sec\n", +"f = 2; // Radius of focal circle, metre\n", +"d = 1.18e-010; // Interplaner spacing for quartz crystal, metre\n", +"E_1 = 1.17*1.6022e-013; // Energy of the gamma rays, joule\n", +"E_2 = 1.33*1.6022e-013; // Energy of the gamma rays, joule\n", +"D = h*C*f*(1/E_1-1/E_2)*1/(2*d); //Distance to be moved for obtaining first order reflection for two different energies, metre\n", +"printf('\nThe distance to be moved for obtaining first order Bragg reflection = %4.2e metre', D);\n", +"\n", +"// Result\n", +"// The distance to be moved for obtaining first order Bragg reflection = 1.08e-003 metre " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.2: Energy_of_the_gamma_rays_from_magnetic_spectrograph_data.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa7.2: : Page-293 (2011)\n", +"clc; clear;\n", +"m_0 = 9.1094e-031; // Rest mass of the electron, Kg\n", +"B_R = 1250e-06; // Magnetic field,tesla metre\n", +"e = 1.6022e-019; // Charge of the electron, coulomb\n", +"C = 3e+08; // Velocity of the light, metre per sec\n", +"E_k = 0.089; // Binding energy of the K-shell electron,MeV\n", +"v = B_R*e/(m_0*sqrt(1+B_R^2*e^2/(m_0^2*C^2))); // Velocity of the photoelectron, metre per sec\n", +"E_pe = m_0/(1.6022e-013)*C^2*(1/sqrt(1-v^2/C^2)-1); // Energy of the photoelectron,MeV\n", +"E_g = E_pe+E_k; // Energy of the gamma rays, MeV\n", +"printf('\nThe energy of the gamma rays = %5.3f MeV', E_g);\n", +"\n", +"// Result\n", +"// The energy of the gamma rays = 0.212 MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.3: Attenuation_of_beam_of_X_rays_in_passing_through_human_tissue.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa7.3: : Page-292 (2011)\n", +"clc; clear;\n", +"a_c = 0.221; // Attenuation coefficient, cm^2/g\n", +"A = (1-exp(-0.22))*100; // Attenuation of beam of X-rays in passing through human tissue\n", +"printf('\nThe attenuation of beam of X-rays in passing through human tissue = %d percent', ceil(A));\n", +"\n", +"// Result\n", +"// The attenuation of beam of X-rays in passing through human tissue = 20 percent " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.4: Partial_half_life_for_gamma_emission_of_Hg195_isomer.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa7.4: : Page-293 (2011)\n", +"clc; clear;\n", +"alpha_k = 45; // Ratio between decay constants\n", +"sum_alpha = 0.08; // Sum of alphas\n", +"P = 0.35*1/60; // Probability of the isomeric transition,per hour\n", +"lambda_g = P*sum_alpha/alpha_k; // Decay constant of the gamma radiations, per hour\n", +"T_g = 1/(lambda_g*365*24); // Partial life time for gamma emission,years\n", +"printf('\nThe partial life time for gamma emission = %5.3f years', T_g);\n", +"\n", +"// Result\n", +"// The partial life time for gamma emission = 11.008 years \n", +"\n", +"" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.5: Estimating_the_gamma_width_from_Weisskopf_model.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa7.5: : Page-294 (2011)\n", +"clc; clear;\n", +"A = 11; // Mass number of boron\n", +"E_g = 4.82; // Energy of the gamma radiation, mega electron volts\n", +"W_g = 0.0675*A^(2/3)*E_g^3; // Gamma width, mega electron volts\n", +"printf('\nThe required gamma width = %5.2f MeV', W_g);\n", +"\n", +"// Result\n", +"// The required gamma width = 37.39 MeV \n", +"\n", +"" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.8: K_electronic_states_in_indium.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa7.8: : Page-295 (2011)\n", +"clc; clear;\n", +"e = 1.6022e-19; // Charge of an electron, coulomb\n", +"BR = 2370e-06; // Magnetic field in an orbit, tesla metre\n", +"m_0 = 9.1094e-31; // Mass of an electron, Kg\n", +"c = 3e+08; // Velocity of light, metre per sec\n", +"v = 1/sqrt((m_0/(BR*e))^2+1/c^2); // velocity of the particle, metre per sec\n", +"E_e = m_0*c^2*((1-(v/c)^2)^(-1/2)-1)/1.6e-13; // Energy of an electron, MeV\n", +"E_b = 0.028; // Binding energy, MeV\n", +"E_g = E_e+E_b; // Excitation energy, MeV\n", +"alpha_k = 0.5; // K conversion coefficient\n", +"Z = 49; // Number of protons\n", +"alpha = 1/137; // Fine structure constant\n", +"L = (1/(1-(Z^3/alpha_k*alpha^4*(2*0.511/0.392)^(15/2))))/2; // Angular momentum\n", +"l = 1; // Orbital angular momentum\n", +"I = l-1/2; // Parity\n", +"printf('\nFor K-electron state:\nThe excitation energy = %5.3f MeV\nThe angular momentum = %d\nThe parity : %3.1f', E_g, ceil(L), I);\n", +"// Result\n", +"// For K-electron state:\n", +"// The excitation energy = 0.393 MeV\n", +"// The angular momentum = 5\n", +"// The parity : 0.5 \n", +"\n", +"" + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 7.9: Radioactive_lifetime_of_the_lowest_energy_electric_dipole_transition_for_F17.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa7.9: : Page-295 (2011)\n", +"clc; clear;\n", +"c = 3e+10; // Velocity of light, centimetre per sec\n", +"R_0 = 1.4e-13; // Distance of closest approach, centimetre \n", +"alpha = 1/137; // Fine scattering constant\n", +"A = 17; // Mass number\n", +"E_g = 5*1.6e-06; // Energy of gamma transition, ergs\n", +"h_cut = 1.054571628e-27; // Reduced planck constant, ergs per sec\n", +"lambda = c/4*R_0^2*alpha*(E_g/(h_cut*c))^3*A^(2/3); // Disintegration constant, per sec\n", +"tau = 1/lambda; // Radioactive lifr\e time, sec\n", +"printf('\nThe radioactive life time = %1.0e sec', tau);\n", +"\n", +"// Result\n", +"// The radioactive life time = 9e-018 sec \n", +"\n", +"" + ] + } +], +"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/Nuclear_Physics_by_D_C_Tayal/8-Beta_Decay.ipynb b/Nuclear_Physics_by_D_C_Tayal/8-Beta_Decay.ipynb new file mode 100644 index 0000000..fec2edf --- /dev/null +++ b/Nuclear_Physics_by_D_C_Tayal/8-Beta_Decay.ipynb @@ -0,0 +1,245 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 8: Beta Decay" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 6.8: Beta_decayed_particle_emission_of_Li8.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa6.8: : Page-243 (2011)\n", +"clc; clear;\n", +"l = 2; // Orbital angular momentum quantum number\n", +"P = (+1)^2*(-1)^l; // Parity of the 2.9 MeV level in Be-8\n", +"M_Li = 7.0182; // Mass of lithium, MeV\n", +"M_Be = 7.998876; // Mass of beryllium, MeV\n", +"m_n = 1; // Mass of neutron, MeV\n", +"E_th = (M_Li+m_n-M_Be)*931.5; // Threshold energy, MeV\n", +"printf('\nThe parity of the 2.9 MeV level in be-8 = +%d \nThe threshold energy for lithium 7 neutron capture = %d MeV',P, E_th);\n", +"\n", +"// Result\n", +"// The parity of the 2.9 MeV level in be-8 = +1 \n", +"// The threshold energy for lithium 7 neutron capture = 18 MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.10: Kinetic_energy_of_the_two_interacting_nucleons_in_different_frames.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa8.10 : : Page-352 (2011)\n", +"clc; clear;\n", +"r = 2e-015; // Range of nuclear force, metre\n", +"h_kt = 1.0546e-34; // Reduced value of Planck's constant, joule sec\n", +"m = 1.674e-27; // Mass of each nucleon, Kg\n", +"K = round (2*h_kt^2/(2*m*r^2*1.6023e-13)); // Kinetic energy of each nucleon in centre of mass frame, mega electron volts\n", +"K_t = 2*K; // Total kinetic energy, mega electron volts\n", +"K_inc = 2*K_t; // Kinetic energy of the incident nucleon, mega electron volts\n", +"printf('\nThe kinetic energy of each nucleon = %d MeV\nThe total kinetic energy = %d MeV\nThe kinetic energy of the incident nucleon = %d MeV', K, K_t, K_inc);\n", +"// Result\n", +"// " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.3: Neutron_and_proton_interacting_within_the_deuteron.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa8.3 : : Page-349 (2011)\n", +"clc; clear;\n", +"b = 1.9e-15; // Width of square well potential, metre\n", +"h_kt = 1.054571e-034; // Reduced planck's constant, joule sec\n", +"c = 3e+08; // Velocity of light, metre per sec\n", +"m_n = 1.67e-27; // Mass of a nucleon , Kg\n", +"V_0 = 40*1.6e-13; // Depth, metre\n", +"E_B = (V_0-(1/(m_n*c^2)*(%pi*h_kt*c/(2*b))^2))/1.6e-13; // Binding energy, mega electron volts\n", +"alpha = sqrt(m_n*c^2*E_B*1.6e-13)/(h_kt*c); // scattering co efficient, per metre\n", +"P = (1+1/(alpha*b))^-1; // Probability\n", +"R_mean = sqrt (b^2/2*(1/3+4/%pi^2+2.5)); // Mean square radius, metre\n", +"printf('\nThe probability that the proton moves within the range of neutron = %4.2f \nThe mean square radius of the deuteron = %4.2e metre', P, R_mean);\n", +"// Result\n", +"// The probability that the proton moves within the range of neutron = 0.50 \n", +"// The mean square radius of the deuteron = 2.42e-015 metre " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.5: Total_cross_section_for_np_scattering_at_neutron_energy.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa8.5 : : Page-349 (2011)\n", +"clc; clear;\n", +"a_t = 5.38e-15;\n", +"a_s = -23.7e-15;\n", +"r_ot = 1.70e-15;\n", +"r_os = 2.40e-15;\n", +"m = 1.6748e-27;\n", +"E = 1.6e-13;\n", +"h_cut = 1.0549e-34;\n", +"K_sqr = m*E/h_cut^2;\n", +"sigma = 1/4*(3*4*%pi*a_t^2/(a_t^2*K_sqr+(1-1/2*K_sqr*a_t*r_ot)^2)+4*%pi*a_s^2/(a_s^2*K_sqr+(1-1/2*K_sqr*a_s*r_os)^2))*1e+028; // Total cross-section for n-p scattering, barn\n", +"printf('\nThe total cross section for n-p scattering = %5.3f barn', sigma);\n", +"// Result\n", +"// The total cross section for n-p scattering = 2.911 barn " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.8: Possible_angular_momentum_states_for_the_deuterons_in_an_LS_coupling_scheme.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa8.8 : : Page-351 (2011)\n", +"clc; clear;\n", +"S = 1; // Spin angular momentum(s1+-s2), whereas s1 is the spin of proton and s2 is the spin of neutron.\n", +"m = 2*S+1; // Spin multiplicity\n", +"j = 1; // Total angular momentum\n", +"printf('\nThe possible angular momentum states with their parities are as follows : ');\n", +" printf('\n %dS%d has even parity ', m, j);\n", +" printf('\n %dP%d has odd parity ', m, j);\n", +" printf('\n %dD%d has even parity', m, j); \n", +"S = 0;\n", +"m = 2*S+1\n", +" printf('\n %dP%d has odd parity ', m, j);\n", +" \n", +"// Result \n", +"// The possible angular momentum states with their parities are as follows : \n", +"// 3S1 has even parity \n", +"// 3P1 has odd parity \n", +"// 3D1 has even parity\n", +"// 1P1 has odd parity " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 8.9: States_of_a_two_neutron_system_with_given_total_angular_momentum.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa8.9 : : Page-351 (2011)\n", +"clc; clear;\n", +"printf('\nThe possible states are : ');\n", +"// For s = 0\n", +"s = 0; // Spin angular momentum\n", +"m = 2*s+1; // Spin multiplicity\n", +"for j = 0:2 // Total angular momentum\n", +" l = j\n", +" if l == 0 then\n", +" printf('\n %dS%d, ', j,m); \n", +" elseif l == 2 then\n", +" printf(' %dD%d, ', j,m); \n", +" end\n", +"end\n", +"// For s = 1\n", +"s = 1;\n", +"m = 2*s+1;\n", +" l = 2\n", +"for j = 0:2 \n", +" if j == 0 then\n", +" printf(' %dP%d, ', j,m); \n", +" elseif j ==1 then\n", +" printf(' %dP%d, ', j,m);\n", +" elseif j ==2 then\n", +" printf('%dP%d and ', j,m); \n", +" end\n", +"end\n", +"for j = 2\n", +" printf(' %dF%d', j,m)\n", +"end\n", +"// Result\n", +"// Possible states are : \n", +"// The possible states are : \n", +"// 0S1, 2D1, 0P3, 1P3, 2P3 and 2F3 " + ] + } +], +"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/Nuclear_Physics_by_D_C_Tayal/9-Nuclear_Models.ipynb b/Nuclear_Physics_by_D_C_Tayal/9-Nuclear_Models.ipynb new file mode 100644 index 0000000..43f145f --- /dev/null +++ b/Nuclear_Physics_by_D_C_Tayal/9-Nuclear_Models.ipynb @@ -0,0 +1,432 @@ +{ +"cells": [ + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "# Chapter 9: Nuclear Models" + ] + }, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 9.11: Quadrupole_and_magnetic_moment_of_ground_state_of_nuclides.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa9.11 : : Page-394 (2011)\n", +"clc; clear;\n", +"R_0 = 1.2e-015; // Distance of closest approach, metre\n", +"// Mass number of the nuclei are allocated below :\n", +"N = rand(4,1)\n", +"N(1,1) = 17; // for oxygen\n", +"N(2,1) = 33; // for sulphur\n", +"N(3,1) = 63; // for copper\n", +"N(4,1) = 209; // for bismuth\n", +"for i = 1:4\n", +"\n", +" if N(i,1) == 17 then\n", +" printf('\n For Oxygen : ')\n", +" I = 5/2; // Total angular momentum\n", +" l = 2; // Orbital angular momentum\n", +" mu = -1.91; // for odd neutron and I = l+1/2\n", +" Q = -3/5*(2*I-1)/(2*I+2)*(R_0*N(i,1)^(1/3))^2*10^28; // Quadrupole moment of oxygen, barn\n", +" printf('\n The value of magnetic moment is : %4.2f \n The value of quadrupole moment is : %6.4f barn', mu, Q);\n", +" elseif N(i,1) == 33 then\n", +" printf('\n\n For Sulphur : ')\n", +" I = 3/2; // Total angular momentum\n", +" l = 2; // Orbital angular momentum\n", +" mu = 1.91*I/(I+1); // for odd neutron and I = l-1/2\n", +" Q = -3/5*(2*I-1)/(2*I+2)*(R_0*N(i,1)^(1/3))^2*10^28; // Quadrupole moment of sulphur, barn\n", +" printf('\n The value of magnetic moment is : %5.3f \n The value of quadrupole moment is : %6.4f barn', mu, Q); \n", +" elseif N(i,1) == 63 then\n", +" printf('\n\n For Copper : ')\n", +" I = 3/2; // Total angular momentum\n", +" l = 1; // Orbital angular momentum\n", +" mu = I+2.29; // for odd protons and I = l+1/2\n", +" Q = -3/5*(2*I-1)/(2*I+2)*(R_0*N(i,1)^(1/3))^2*10^28; // Quadrupole momentum of copper, barn\n", +" printf('\n The value of magnetic moment is : %4.2f \n The value of quadrupole moment is : %6.4f barn', mu, Q);\n", +" elseif N(i,1) == 209 then\n", +" printf('\n\n For Bismuth : ')\n", +" I = 9/2; // Total angular momentum\n", +" l = 5; // Orbital angular momentum\n", +" mu = I-2.29*I/(I+1); // for odd protons and I = l-1/2\n", +" Q = -3/5*(2*I-1)/(2*I+2)*(R_0*N(i,1)^(1/3))^2*10^28; // Quadrupole momentum of bismuth, barn\n", +" printf('\n The value of magnetic moment is : %4.2f \n The value of quadrupole moment is : %5.3f barn', mu, Q);\n", +" end\n", +"end\n", +"\n", +"// Result\n", +"// For Oxygen : \n", +"// The value of magnetic moment is : -1.91 \n", +"// The value of quadrupole moment is : -0.0326 barn\n", +"\n", +"// For Sulphur : \n", +"// The value of magnetic moment is : 1.146 \n", +"// The value of quadrupole moment is : -0.0356 barn\n", +"\n", +"// For Copper : \n", +"// The value of magnetic moment is : 3.79 \n", +"// The value of quadrupole moment is : -0.0547 barn\n", +"\n", +"// For Bismuth : \n", +"// The value of magnetic moment is : 2.63 \n", +"// The value of quadrupole moment is : -0.221 barn " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 9.12: Kinetic_energy_of_iron_nucleus.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa9.12 : : Page-395 (2011)\n", +"clc; clear;\n", +"h_cut = 1.054571628e-34; // Redued planck's constant, joule sec\n", +"a = 1e-014; // Distance of closest approach, metre\n", +"m = 1.67e-27; // Mass of each nucleon, Kg\n", +"KE = 14*%pi^2*h_cut^2/(2*m*a^2*1.6e-13); // Kinetic energy of iron nucleus, MeV\n", +"printf('\nThe kinetic energy of iron nuclei = %5.2f MeV', KE);\n", +"\n", +"// Result\n", +"// The kinetic energy of iron nuclei = 28.76 MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 9.14: Electric_quadrupole_moment_of_scandium.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa9.14 : : Page-396 (2011)\n", +"clc; clear;\n", +"R_0 = 1.2e-15; // Distance of closest approach, metre\n", +"j = 7/2; // Total angular momentum\n", +"A = 41; // Mass number of Scandium\n", +"Z = 20; // Atomic number of Calcium\n", +"Q_Sc = -(2*j-1)/(2*j+2)*(R_0*A^(1/3))^2; // Electric quadrupole of Scandium nucleus, Sq. m\n", +"Q_Ca = Z/(A-1)^2*abs(Q_Sc); // Electric quadrupole of calcium nucleus, Sq. m\n", +"printf('\nThe electric quadrupole of scandium nucleus = %4.2e square metre \nThe electric quadrupole of calcium nucleus = %4.2e square metre', Q_Sc, Q_Ca);\n", +"\n", +"// Result\n", +"// The electric quadrupole of scandium nucleus = -1.14e-029 square metre \n", +"// The electric quadrupole of calcium nucleus = 1.43e-031 square metre " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 9.16: Energy_of_lowest_lying_tungsten_states.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa9.16 : : Page-398 (2011)\n", +"clc; clear;\n", +"h_cut_sqr_upon_2f = 0.01667; // A constant value, joule square per sec cube\n", +"for I = 4:6\n", +" if I == 4 then\n", +" E = I*(I+1)*h_cut_sqr_upon_2f;\n", +" printf('\nThe energy for 4+ tungsten state = %5.3f MeV', E);\n", +" elseif I == 6 then\n", +" E = I*(I+1)*h_cut_sqr_upon_2f; \n", +" printf('\nThe energy for 6+ tungsten state = %5.3f MeV', E); \n", +" end\n", +"end\n", +"\n", +"// Result\n", +"// The energy for 4+ tungsten state = 0.333 MeV\n", +"// The energy for 6+ tungsten state = 0.700 MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 9.1: Estimating_the_Fermi_energies_for_neutrons_and_protons.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa9.1 : : Page-389 (2011) \n", +"clc; clear;\n", +"h_cut = 1.054e-034; // Reduced Planck's constant, joule sec\n", +"rho = 2e+044; // Density of the nuclear matter, kg per metre cube\n", +"V = 238/rho; // Volume of the nuclear matter, metre cube\n", +"// For neutron\n", +"N = 238-92; // Number of neutrons\n", +"M = 1.67482e-027; // Mass of a neutron, kg\n", +"e = 1.602e-019; // Energy equivalent of 1 eV, J/eV\n", +"E_f = (3*%pi^2)^(2/3)*h_cut^2/(2*M)*(N/V)^(2/3)/e; // Fermi energy of neutron, eV \n", +"printf('\nThe Fermi energy of neutron = %5.2f MeV', E_f/1e+006);\n", +"// For proton\n", +"N = 92; // Number of protons\n", +"M = 1.67482e-027; // Mass of a proton, kg\n", +"e = 1.602e-019; // Energy equivalent of 1 eV, J/eV\n", +"E_f = (3*%pi^2)^(2/3)*h_cut^2/(2*M)*(N/V)^(2/3)/e; // Fermi energy of neutron, eV \n", +"printf('\nThe Fermi energy of proton = %5.2f MeV', E_f/1e+006);\n", +"\n", +"// Result\n", +"// The Fermi energy of neutron = 48.92 MeV\n", +"// The Fermi energy of proton = 35.96 MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 9.3: General_propeties_of_a_neutron_star.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa9.3 : : Page-390 (2011)\n", +"clc; clear;\n", +"h_cut = 1.0545e-34; // Reduced Planck's constant, joule sec\n", +"G = 6.6e-11; // Gravitational constant, newton square metre per square Kg \n", +"m = 10^30; // Mass of the star, Kg\n", +"m_n = 1.67e-27; // Mass of the neutron, Kg\n", +"R = (9*%pi/4)^(2/3)*h_cut^2/(G*(m_n)^3)*(m_n/m)^(1/3); // Radius of the neutron star, metre\n", +"printf('\nThe radius of the neutron star = %3.1e metre', R);\n", +"\n", +"// Result\n", +"// The radius of the neutron star = 1.6e+004 metre " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 9.4: Stability_of_the_isobar_using_the_liquid_drop_model.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa9.4 : : Page-391 (2011)\n", +"clc; clear;\n", +"A = 77; // Mass number of the isotopes\n", +"Z = round (A/((0.015*A^(2/3))+2)); // Atomic number of stable isotope\n", +"// Check the stability !!!!!\n", +" if Z == 34 then\n", +" printf('\nSe( %d,%d) is stable \nAs (%d,%d) and Br(%d,%d) are unstable', Z, A, Z-1, A, Z+1, A);\n", +" elseif Z == 33 then\n", +" printf('\nAs( %d,%d) is stable \nSe (%d,%d) and Br(%d,%d) are unstable', Z, A, Z+1, A, Z+2, A);\n", +" elseif Z == 35 then\n", +" printf('\nBr( %d,%d) is stable \nSe (%d,%d) and As(%d,%d) are unstable',Z,A,Z-2,A,Z-1,A); \n", +"end\n", +"\n", +"// Result\n", +"// Se( 34,77) is stable \n", +"// As (33,77) and Br(35,77) are unstable " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 9.5: Energy_difference_between_neutron_shells.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa9.5 : : Page-391 (2011)\n", +"clc; clear;\n", +"m_40 = 39.962589; // Mass of calcium 40, atomic mass unit\n", +"m_41 = 40.962275; // Mass of calcium 41, atomic mass unit\n", +"m_39 = 38.970691; // Mass of calcium 39, atomic mass unit \n", +"m_n = 1.008665; // Mass of the neutron, atomic mass unit\n", +"BE_1d = (m_39+m_n-m_40)*931.5; // Binding energy of 1d 3/2 neutron, mega electron volts\n", +"BE_1f = (m_40+m_n-m_41)*931.5; // Binding energy of 1f 7/2 neutron, mega electron volts\n", +"delta = BE_1d-BE_1f; // Energy difference between neutron shells, mega electron volts\n", +"printf('\nThe energy difference between neutron shells = %4.2f MeV', delta);\n", +"\n", +"// Result\n", +"// The energy difference between neutron shells = 7.25 MeV " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 9.7: Angular_frequency_of_the_nuclei.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa9.7 : : Page-392 (2011)\n", +"clc; clear;\n", +"h_cut = 1.0545e-34; // Reduced Planck's constant, joule sec\n", +"R = 1.2e-15; // Distance of closest approach, metre\n", +"m = 1.67482e-27; // Mass of the nucleon, Kg\n", +"// For O-17\n", +"for A = 17:60 // Mass numbers\n", +"if A == 17 then\n", +"omega_O = 5*3^(1/3)*h_cut*17^(-1/3)/(2^(7/3)*m*R^2); // Angular frequency of oxygen \n", +"// For Ni-60\n", +"elseif A == 60 then\n", +"omega_Ni = 5*3^(1/3)*h_cut*60^(-1/3)/(2^(7/3)*m*R^2); // Angular frequency of nickel\n", +"end \n", +"end \n", +"printf('\nThe angular frequency for oxygen 17 = %4.2e \nThe angular frequency for nickel 60 = %4.2e', omega_O, omega_Ni);\n", +"\n", +"// Result\n", +"// The angular frequency for oxygen 17 = 2.43e+022 \n", +"// The angular frequency for nickel 60 = 1.60e+022 " + ] + } +, +{ + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Example 9.9: Angular_momenta_and_parities.sce" + ] + }, + { +"cell_type": "code", + "execution_count": null, + "metadata": { + "collapsed": true + }, + "outputs": [], +"source": [ +"// Scilab code Exa9.9 : : Page-393 (2011)\n", +"clc; clear;\n", +"Z = rand(5,1);\n", +"N = rand(5,1);\n", +"E = string (rand(5,1));\n", +"// Elements allocated\n", +"E(1,1) = 'Carbon'\n", +"E(2,1) = 'Boron'\n", +"E(3,1) = 'Oxygen'\n", +"E(4,1) = 'Zinc'\n", +"E(5,1) = 'Nitrogen'\n", +"Z(1,1) = 6; // Number of proton in carbon nuclei\n", +"Z(2,1) = 5; // Number of proton in boron nuclei\n", +"Z(3,1) = 8; // Number of proton in oxygen nuclei\n", +"Z(4,1) = 30; // Number of proton in zinc nuclei\n", +"Z(5,1) = 7; // Number of proton in nitrogen nuclei\n", +"N(1,1) = 6; // Mass number of carbon\n", +"N(2,1) = 6; // Mass number of boron\n", +"N(3,1) = 9; // Mass number of oxygen\n", +"N(4,1) = 37; // Mass number of zinc\n", +"N(5,1) = 9; // Mass number of nitrogem\n", +"for i = 1:5\n", +" if Z(i,1) == 8 then\n", +" printf('\nThe angular momentum is 5/2 and the parity is +1 for %s ', E(i,1));\n", +" elseif Z(i,1) == 5 then\n", +" printf('\nThe angular momentum is 3/2 and the parity is -1 for %s', E(i,1));\n", +" end\n", +" if Z(i,1) == N(i,1) then\n", +" printf('\nThe angular mometum is 0 and the parity is +1 for %s', E(i,1));\n", +" end\n", +" if N(i,1)-Z(i,1) == 2 then\n", +" printf('\nThe angular momentum is 2 and the parity is -1 for %s', E(i,1));\n", +" end\n", +" if N(i,1)-Z(i,1) == 7 then\n", +" printf('\nThe angular momentum is 5/2 and the parity is -1 for %s', E(i,1));\n", +" end\n", +"end\n", +"\n", +"// Result\n", +"// The angular mometum is 0 and the parity is +1 for Carbon\n", +"// The angular momentum is 3/2 and the parity is -1 for Boron\n", +"// The angular momentum is 5/2 and the parity is +1 for Oxygen \n", +"// The angular momentum is 5/2 and the parity is -1 for Zinc\n", +"// The angular momentum is 2 and the parity is -1 for Nitrogen " + ] + } +], +"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 +} |