summaryrefslogtreecommitdiff
path: root/Solid_State_Physics_by_P_K_Palanisamy
diff options
context:
space:
mode:
Diffstat (limited to 'Solid_State_Physics_by_P_K_Palanisamy')
-rw-r--r--Solid_State_Physics_by_P_K_Palanisamy/1-Bonding_in_Solids.ipynb133
-rw-r--r--Solid_State_Physics_by_P_K_Palanisamy/10-Superconductivity.ipynb91
-rw-r--r--Solid_State_Physics_by_P_K_Palanisamy/11-Lasers.ipynb94
-rw-r--r--Solid_State_Physics_by_P_K_Palanisamy/12-Fibre_Optics.ipynb124
-rw-r--r--Solid_State_Physics_by_P_K_Palanisamy/2-Crystal_Structure.ipynb246
-rw-r--r--Solid_State_Physics_by_P_K_Palanisamy/3-Crystal_Planes_and_Defects.ipynb386
-rw-r--r--Solid_State_Physics_by_P_K_Palanisamy/4-Line_Defects_and_Crystal_Structure_Determination.ipynb285
-rw-r--r--Solid_State_Physics_by_P_K_Palanisamy/5-Principles_of_Quantum_Mechanics.ipynb462
-rw-r--r--Solid_State_Physics_by_P_K_Palanisamy/6-Electron_Theory_of_Metals.ipynb357
-rw-r--r--Solid_State_Physics_by_P_K_Palanisamy/7-Dielectric_Properties.ipynb250
-rw-r--r--Solid_State_Physics_by_P_K_Palanisamy/8-Magnetic_Properties.ipynb257
-rw-r--r--Solid_State_Physics_by_P_K_Palanisamy/9-Semiconductors.ipynb601
12 files changed, 3286 insertions, 0 deletions
diff --git a/Solid_State_Physics_by_P_K_Palanisamy/1-Bonding_in_Solids.ipynb b/Solid_State_Physics_by_P_K_Palanisamy/1-Bonding_in_Solids.ipynb
new file mode 100644
index 0000000..5ca92b8
--- /dev/null
+++ b/Solid_State_Physics_by_P_K_Palanisamy/1-Bonding_in_Solids.ipynb
@@ -0,0 +1,133 @@
+{
+"cells": [
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "# Chapter 1: Bonding in Solids"
+ ]
+ },
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 1.1: Stability_of_gaseous_molecules.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex1.1 : Page-1.8 (2004)\n",
+"clc;clear;\n",
+"N = 6.022e+23; // Avogadro Number; /mol\n",
+"E_A = 502; // First ionization energy of A atom, kJ/mol\n",
+"E_B = -335; // Electron affinity for B atom, kJ\n",
+"r = 3e-10; // Velocity of the particle at the mean position, angstrom\n",
+"E_o = 8.85e-12; //Permittivity of free space, C/N^2-m^2\n",
+"e = 1.6e-19; // Electronic charge, C\n",
+"E_C = N*(-e^2)/(4*%pi*E_o*r)*1e-03; // The coulombic electrostatic attaction energy, kJ/mol\n",
+"E = E_A + E_B + E_C; // Net change in energy per mol, kJ/mol \n",
+"printf('\nNet change in energy per mol = %3d kJ/mol', E);\n",
+"disp('Since net change in energy is negative, the molecule A+B- is stable.');\n",
+"\n",
+"// Result\n",
+"// Net change in energy per mol = -295 kJ/mol \n",
+"// Since net change in energy is negative, the molecule A+B- is stable. \n",
+" \n",
+""
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 1.2: Energy_and_separation_in_KCl_ion_pair.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex1.2 : Page-1.8 (2004)\n",
+"clc;clear;\n",
+"A = 4.1; // Ionization energy of K, eV\n",
+"B = 3.6; // Electron affinity of Cl, eV\n",
+"C = A - B; // Net energy to produce the ion pair, eV\n",
+"E = C; // Coulomb energy, eV\n",
+"e = 1.6e-19; // Electronic charge, C\n",
+"E_o = 8.85e-12; //Permittivity of free space, C/N^2-m^2\n",
+"R = e/(4*%pi*E_o*C); // R is the separation between K and Cl , nm\n",
+"printf('\nThe coulomb energy E = %3.1f eV', E);\n",
+"printf('\nSeparation between K and Cl, R = %4.2f nm', R/1e-09);\n",
+"\n",
+"// Result \n",
+"// The coulomb energy E = 0.5 eV\n",
+"// Separation between K and Cl, R = 2.88 nm "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 1.3: Bond_energy_of_NaCl_molecule.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex1.3 : Bond energy of NaCl molecule Page-1.9 (2004)\n",
+"clc;clear;\n",
+"A = 5.14; // Ionization energy of Na, eV\n",
+"B = 3.65; // Electron affinity of Cl, eV\n",
+"r0 = 236e-12; // Inter ionic equilibrium distance, m\n",
+"e = 1.6e-19; // Electronic charge, C\n",
+"E_o = 8.85e-12; //Permittivity of free space, C/N^2-m^2\n",
+"Ue = -e/(4*%pi*E_o*r0); // Potential energy to produce the ion pair, eV\n",
+"BE = -Ue-A+B\n",
+"printf('\nThe potential energy Ue = %2.1f eV',Ue);\n",
+"printf('\nThe Binding energy BE = %4.2f eV',BE);\n",
+"\n",
+"// Result \n",
+"// The potential energy Ue = -6.1 eV\n",
+"// The Binding energy BE = 4.61 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/Solid_State_Physics_by_P_K_Palanisamy/10-Superconductivity.ipynb b/Solid_State_Physics_by_P_K_Palanisamy/10-Superconductivity.ipynb
new file mode 100644
index 0000000..2bd6884
--- /dev/null
+++ b/Solid_State_Physics_by_P_K_Palanisamy/10-Superconductivity.ipynb
@@ -0,0 +1,91 @@
+{
+"cells": [
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "# Chapter 10: Superconductivity"
+ ]
+ },
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 10.1: Critical_field.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex10.1: Page-10.3 (2004)\n",
+"clc;clear;\n",
+"Tc = 3.7; // Critical temperature, K\n",
+"Ho = 0.0306; // Critical field at zero kelvin, tesla\n",
+"T = 2; // temperature at which filed being calculated, K\n",
+"Hc = Ho*[1-(T/Tc)^2]; // Critical Magnetic field, tesla\n",
+"printf('\nThe Critical field at two kelvin = %f tesla' , Hc);\n",
+"\n",
+"// Result\n",
+"// The Critical field at two kelvin = 0.021659 tesla "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 10.2: Critical_current_and_Critical_field.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex10.2: Page-10.5 (2004)\n",
+"clc;clear;\n",
+"Tc = 7.18; // Critical temperature, K\n",
+"r = 1e-003; // diameter of wire, m\n",
+"Ho = 6.5e+004; // Critical field at zero kelvin, A/m\n",
+"T = 4.2; // temperature at which filed being calculated, K\n",
+"Hc = Ho*[1-(T/Tc)^2];\n",
+"ic = %pi*r*Hc; // critical current , A\n",
+"printf('\nThe Critical field = %e A/m' , Hc);\n",
+"printf('\nThe Critical current = %f A' , ic);\n",
+"\n",
+"// Result\n",
+"// The Critical field = 4.275855e+04 A/m\n",
+"// The Critical current = 134.329954 A "
+ ]
+ }
+],
+"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/Solid_State_Physics_by_P_K_Palanisamy/11-Lasers.ipynb b/Solid_State_Physics_by_P_K_Palanisamy/11-Lasers.ipynb
new file mode 100644
index 0000000..0dd838a
--- /dev/null
+++ b/Solid_State_Physics_by_P_K_Palanisamy/11-Lasers.ipynb
@@ -0,0 +1,94 @@
+{
+"cells": [
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "# Chapter 11: Lasers"
+ ]
+ },
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 11.1: Ratio_of_relative_populatio.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex11.1: Page-11.5(2004)\n",
+"clc;clear;\n",
+"h = 6.626e-034; // Planck's constant, Js\n",
+"c = 3e+08; // Speed of light in free space, m/s\n",
+"k = 8.61e-5; // Boltzmann constant, J/K\n",
+"T = 300; // Temperature at absolute scale, K\n",
+"lambda = 6943e-10; // Wavelength of visible light, m\n",
+"E = h*c/(lambda*1.6e-19); // Energy in eV\n",
+"rate_ratio = exp(-E/(k*T)); // Ratio of spontaneous emission to stimulated emission\n",
+"\n",
+"printf('\nThe ratio of relative population = %3.2e', rate_ratio);\n",
+"printf('\nEnergy = %3.2f eV', E);\n",
+"\n",
+"// Results\n",
+"// The ratio of relative population = 8.20e-31\n",
+"// Energy = 1.79 eV "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 11.2: Energy_of_excited_state_of_laser_system.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex11.2: Page-11.16 (2004)\n",
+"clc;clear;\n",
+"a1 = 4; // diameter of laser beam for distance first, m\n",
+"a2 = 6; // diameter of laser beam from second distance\n",
+"d1 = 1; // First distance from laser to output beam spot, m\n",
+"d2 = 2; // Second distance from laser to output beam spot, m\n",
+"Div = (a2-a1)/(2*(d2-d1));\n",
+"printf('\nDivergence in radian = %d milliradian', Div);\n",
+"\n",
+"// Result\n",
+"// Divergence in radian = 1 milliradian "
+ ]
+ }
+],
+"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/Solid_State_Physics_by_P_K_Palanisamy/12-Fibre_Optics.ipynb b/Solid_State_Physics_by_P_K_Palanisamy/12-Fibre_Optics.ipynb
new file mode 100644
index 0000000..d1fdb50
--- /dev/null
+++ b/Solid_State_Physics_by_P_K_Palanisamy/12-Fibre_Optics.ipynb
@@ -0,0 +1,124 @@
+{
+"cells": [
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "# Chapter 12: Fibre Optics"
+ ]
+ },
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 12.1: Numerical_aperture_and_acceptance_angle_of_optical_fibre.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex12.1: Page-12.6 (2004)\n",
+"clc;clear;\n",
+"n1 = 1.54; // Refractive index of fibre core\n",
+"n2 = 1.50; // Refractive index of fibre cladding\n",
+"NA = sqrt(n1^2 - n2^2); // Numerical aperture for optical fibre\n",
+"// As sin(theta_a) = sqrt(n1^2 - n2^2), solving for theta_a\n",
+"theta_a = asind(sqrt(n1^2 - n2^2)); // acceptance angle of optical fibre, degrees\n",
+"printf('\nNumerical aperture for optical fibre = %5.3f', NA);\n",
+"printf('\nThe acceptance angle of optical fibre = %4.1f degrees', theta_a);\n",
+"\n",
+"// Result\n",
+"// Numerical aperture for optical fibre = 0.349\n",
+"// The acceptance angle of optical fibre = 20.4 degrees \n",
+""
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 12.2: V_and_mode_of_optical_fibre.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex12.2: Page-12.13 (2004)\n",
+"clc;clear;\n",
+"n1 = 1.53; // Refractive index of fibre core\n",
+"n2 = 1.50; // Refractive index of fibre cladding\n",
+"lamb = 1e-6; // absolute wavelength. m\n",
+"d = 50e-6; // radius of core in m\n",
+"V = 2*%pi/lamb*d*sqrt(n1^2 - n2^2); // volume of opical fibre\n",
+"N = V^2/2; // no. of possible modes\n",
+"printf('\nV of opical fibre = %6.2f ', V);\n",
+"printf('\nNo. of possible modes = %5.3f ', N);\n",
+"\n",
+"// Results\n",
+"// V of opical fibre = 94.72 \n",
+"// No. of possible modes = 4485.735 "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 12.3: Loss_in_signal.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex12.3: Page-12.20 (2004)\n",
+"clc;clear;\n",
+"po = 40; // Refractive index of fibre core\n",
+"pi = 100; // Refractive index of fibre cladding\n",
+"p = po/pi; // ratio of powers\n",
+"L = -10*(log(po/pi)); // Refractive index of medium\n",
+"\n",
+"printf('\nLoss in dB = %f dB', L);\n",
+"\n",
+"// Result\n",
+"// Loss in dB = 9.162907 dB"
+ ]
+ }
+],
+"metadata": {
+ "kernelspec": {
+ "display_name": "Scilab",
+ "language": "scilab",
+ "name": "scilab"
+ },
+ "language_info": {
+ "file_extension": ".sce",
+ "help_links": [
+ {
+ "text": "MetaKernel Magics",
+ "url": "https://github.com/calysto/metakernel/blob/master/metakernel/magics/README.md"
+ }
+ ],
+ "mimetype": "text/x-octave",
+ "name": "scilab",
+ "version": "0.7.1"
+ }
+ },
+ "nbformat": 4,
+ "nbformat_minor": 0
+}
diff --git a/Solid_State_Physics_by_P_K_Palanisamy/2-Crystal_Structure.ipynb b/Solid_State_Physics_by_P_K_Palanisamy/2-Crystal_Structure.ipynb
new file mode 100644
index 0000000..b4feca7
--- /dev/null
+++ b/Solid_State_Physics_by_P_K_Palanisamy/2-Crystal_Structure.ipynb
@@ -0,0 +1,246 @@
+{
+"cells": [
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "# Chapter 2: Crystal Structure"
+ ]
+ },
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 2.1: Maximum_radius_of_interstitial_sphere_in_BCC.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex2.1 Page-2.21 (2004)\n",
+"clc;clear;\n",
+"r = 1; // For simplicity assume radius of atom to be unity, unit\n",
+"a = 4*r/sqrt(3); // Lattice constant, unit\n",
+"R = (a-2*r)/2; // R be the radius of interstitial sphere that can fit into void, unit\n",
+"\n",
+"printf ('\nRadius of interstitial sphere that can fit into void R = %5.3fr', R);\n",
+"\n",
+"// Result\n",
+"// Radius of interstitial sphere that can fit into void R = 0.155r "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 2.2: Volume_Phase_change_BCC_to_FCC.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex2.2 : Page-2.22 (2004)\n",
+"clc;clear;\n",
+"r1 = 1.258e-10; // Radius of atom for BCC, m\n",
+"a = 4*r1/(3^(0.5)); // Lattice constant for BCC atom, m\n",
+"V_bcc = a^3; // Volume of unit cell of BCC , in m^3\n",
+"V_one = V_bcc/2; // Volume occupied by one atom in BCC, in m^3\n",
+"r2 = 1.292e-10; // Radius of atom for FCC, m\n",
+"b = 2*(sqrt(2))*r2 // Lattice constant for FCC atom\n",
+"V_fcc = b^3; // Volume of unit cell of FCC , in m^3\n",
+"V_two = V_bcc/4; // Volume occupied by one atom in FCC, in m^3\n",
+"DV = (V_one-V_two)/V_one; // Change in volume , percentage\n",
+"\n",
+"printf('\nChange in volume DV =%3.1f percentage.', DV);\n",
+"\n",
+"// Result \n",
+"// Change in volume DV =0.5 percentage. "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 2.3: Calculation_of_volume_and_density_of_Zinc.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex2.3 : Page-2.23 (2004)\n",
+"clc;clear;\n",
+"a = 0.27e-9; // Nearest neighbour distance, m\n",
+"c = 0.494e-9; // Height of unit cell, m\n",
+"V = 3*(sqrt(3))*(a^2)*c/2; // Volume of unit cell of HCP , in metre cube\n",
+"N = 6.023e+26; // Avodagro number , per k-mol \n",
+"M = 65.37; // Atomic weight of zinc, \n",
+"rho = 6*M/(V*N); // Density of zinc, kg per metre cube\n",
+"printf('\nVolume = %4.3e metre cube', V);\n",
+"printf('\nDensity of zinc = %d kg per metre cube', rho);\n",
+"\n",
+"// Result \n",
+"// Volume = 9.356e-29 metre cube\n",
+"// Density of zinc = 6960 kg per metre cube"
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 2.4: Maximum_radius_of_interstitial_sphere_in_FCC.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex2.4 : Page-2.23 (2004)\n",
+"clc;clear;\n",
+"r = 1; // For simplicity assume radius of atom to be unity, unit\n",
+"a = 4*r/sqrt(2); // Lattice constant, unit\n",
+"R = (a/2)-r; // R be the radius of interstitial sphere that can fit into void, unit\n",
+"\n",
+"printf ('\nMaximum Radius of interstitial sphere that can fit into FCC = %5.3fr', R);\n",
+"\n",
+"// Result\n",
+"// Maximum Radius of interstitial sphere that can fit into FCC = 0.414r "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 2.5: Density_of_diamond.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex2.5 : Page-2.24 (2004)\n",
+"clc;clear;\n",
+"a = 0.356e-9; // Cube edge of diamond, m\n",
+"n = 8/a^3; // Number of atoms per unit volume, per metre cube\n",
+"M = 12.01; // Atomic weight of Carbon, g per mol\n",
+"N = 6.023e+26; // Avagadro number, per kmol\n",
+"m = M/N; // Mass of one carbon atom, kg\n",
+"rho = m*n; // Density of diamond, kg per metre cube\n",
+"printf('\nDensity of diamond = %4.0f kg per metre cube', round(rho));\n",
+"\n",
+"// Result \n",
+"// Density of diamond = 3536 kg per metre cube "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 2.6: Distance_between_two_adjacent_atoms_in_NaCl.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex2.6 : Page-2.25 (2004)\n",
+"clc;clear;\n",
+"M = 58.5; // Molecular weight of Carbon, g per mol\n",
+"N = 6.023e+23; // Avagadro number, per mol\n",
+"m = M/N; // Mass of one NaCl molecule, g\n",
+"n = 2.18/m; // Number of NaCl molecules per unit volume, molecules per cm cube\n",
+"n1 = 2*n; // Since NaCl is a diatomic, number of atoms per unit volume is twice\n",
+"a = 1/n1^(1/3); // Distance between two adjacent atoms in NaCl, angstrom\n",
+"\n",
+"printf('\nDistance between two adjacent atoms in NaCl = %4.2f angstrom', a/1e-8);\n",
+"\n",
+"// Result \n",
+"// Distance between two adjacent atoms in NaCl = 2.81 angstrom "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 2.7: Density_of_copper_crystal.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex2.7: Page-2.25 (2004)\n",
+"clc;clear;\n",
+"M = 63.5; // Atomic weight of Copper, g per mol\n",
+"N = 6.023e+23; // Avagadro number, per mol\n",
+"r = 1.278e-8; // Atomic radius of copper, cm\n",
+"m = M/N; // Mass of one Cu atom, kg\n",
+"a = (4*r)/sqrt(2); // Distance between two adjacent atom in Cu, angstrom\n",
+"n1 = 4*m; // Since number of atom per unit cell is 4\n",
+"d = n1/a^3; // Density of copper, kg per metre cube\n",
+"\n",
+"printf('\nDensity of copper = %4.2f g per cm cube', d);\n",
+"\n",
+"// Result \n",
+"// Density of copper = 8.93 g per cm cube "
+ ]
+ }
+],
+"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/Solid_State_Physics_by_P_K_Palanisamy/3-Crystal_Planes_and_Defects.ipynb b/Solid_State_Physics_by_P_K_Palanisamy/3-Crystal_Planes_and_Defects.ipynb
new file mode 100644
index 0000000..85fe5eb
--- /dev/null
+++ b/Solid_State_Physics_by_P_K_Palanisamy/3-Crystal_Planes_and_Defects.ipynb
@@ -0,0 +1,386 @@
+{
+"cells": [
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "# Chapter 3: Crystal Planes and Defects"
+ ]
+ },
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 3.10: Average_energy_required_to_create_Schottky_defect.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex3.10 :Page-3.16 (2004)\n",
+"T = 273+25; // Temperature , K\n",
+"r = 2.82e-10; // Interionic distance, m\n",
+"N = 4/((2*r)^3); // Density of ion pairs, ion pairs\n",
+"k = 8.625e-5; // Boltzmann constant, J/K\n",
+"n = 5e+11; // Density od Schottky effects, per unit volume\n",
+"E_s = 2*k*T*2.303*log10(N/n); // Average energy required to creat Schottky defect\n",
+"printf('\nAverage energy required to create Schottky defect = %5.3f eV', E_s);\n",
+"\n",
+"// Result \n",
+"// Average energy required to create Schottky defect = 1.971 eV "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 3.11: Ratio_of_vacancies_in_metal_to_create_Frenkel_defect.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex3.11 : Ratio of vacancies in metal to create Frenkel defect:Page-3.18 (2004)\n",
+"N = 1; // For simplicity assume total number of metal ions to be unity\n",
+"Ni = 1; // For simplicity assume total number of metal ions to be unity\n",
+"k = 8.625e-5; // Boltzmann constant, J/K\n",
+"T1 = 273+20; // First temperature for metal, K\n",
+"T2 = 300+273; // Second temperature for metal, K\n",
+"E_v = 1.4; // Average energy required to create a vacancy in metal, eV \n",
+"n_293 = N*exp(-E_v/(2*k*T1)); // Number of vacancies at 500 K\n",
+"n_573 = N*exp(-E_v/(2*k*T2)); // Number of vacancies at 500 K\n",
+"n_ratio1 = n_573/n_293; // Ratio of vacancies in metal \n",
+"n_ratio2 = n_293/n_573; // Ratio of vacancies in metal \n",
+"\n",
+"printf('\nThe ratio 1 of vacancies in metal to create Frenkel defect = %5.3e', n_ratio1);\n",
+"printf('\nThe ratio 2 of vacancies in metal to create Frenkel defect = %5.3e', n_ratio2);\n",
+"\n",
+"// Result \n",
+"// The ratio 1 of vacancies in metal to create Frenkel defect = 7.558e+05\n",
+"// The ratio 2 of vacancies in metal to create Frenkel defect = 1.323e-06 "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 3.1: Number_of_atoms_per_square_mm_in_SC.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex3.1 : Page-3.4 (2004)\n",
+" // In a SC structure number of planes are having three arrangement (100),(110) and (111)\n",
+" clc;clear;\n",
+"a = 1; // For simplicity lattice constant is taken to be unity\n",
+"A_100 = a^2; // Area of the plane (100), mm^2\n",
+"N_100 = 1/A_100; // Number of atoms along (100) plane, atoms per square mm\n",
+"A_110 = sqrt(2)*a^2; // Area of the plane (110), mm^2\n",
+"N_110 = 1/A_110; // // Number of atoms along (110) plane, atoms per square mm\n",
+"A_111 = 1/2*a*sqrt(2)*sqrt(2)*a^2*cosd(30); // Area of the plane (110), mm^2\n",
+"A_111t = 0.5; // Total no of atoms in (111) plane\n",
+"N_111 = A_111t/A_111; // // Number of atoms along (110) plane, atoms per square mm\n",
+"printf('\nNumber of atoms along (100) plane= %d /a^2 atoms per square mm', N_100);\n",
+"printf('\nNumber of atoms along (110) plane= %f atoms per square mm', N_110);\n",
+"printf('\nNumber of atoms along (111) plane= %5.3f /a^2 atoms per square mm', N_111);\n",
+"// Result \n",
+"// Number of atoms along (100) plane= 1 /a^2 atoms per square mm\n",
+"// Number of atoms along (110) plane= 0.707107 atoms per square mm\n",
+"// Number of atoms along (111) plane= 0.577 /a^2 atoms per square mm "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 3.2: Maximum_radius_of_sphere_in_BCC_lattice.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex3.2 : Page-3.5(2004)\n",
+"clc;clear;\n",
+"r = 1; // For simplicity assume radius of atom to be unity, unit\n",
+"a = 4*r/sqrt(3); // Lattice constant, unit\n",
+"R = (a/2)-r; // R be the radius of interstitial sphere that can fit into void, unit\n",
+"printf ('\nMaximum Radius of sphere that can fit into BCC = %5.3fr', R);\n",
+"\n",
+"// Result\n",
+"// Maximum Radius of sphere that can fit into BCC = 0.155r "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 3.3: Volume_change_during_BCC_to_FCC.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex3.3 : Page-3.6 (2010)\n",
+"clc;clear;\n",
+"r1 = 1.258e-10; // Atomic radius in BCC, metre\n",
+"a1 = 4*r1/sqrt(3); // Lattice constant for BCC, metre \n",
+"V1 = a1^3; // Volume of unit cell in BCC, metre cube\n",
+"Vpa = V1/2; // Volume occupied by one atom in BCC, metre cube\n",
+"r2 = 1.292e-10; // Atomic radius in FCC, metre \n",
+"a2 = 2*r2*sqrt(2); // Lattice constant for F CC, cube\n",
+"V2 = a2^3; // Volume of unit cell in FCC, meter cube\n",
+"Vpa1 = V2/4; // Volume occupied by one atom in FCC, metre cube\n",
+"dV = (Vpa-Vpa1)/Vpa*100; // Change in volume, percentage\n",
+"printf('\nChange in volume in percentage = %4.3f percentage', dV);\n",
+"\n",
+"// Result \n",
+"// Change in volume in percentage = 0.493 percentage"
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 3.4: Volume_and_density_of_unit_cell_in_HCP_Zn_structure.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex3.4 : Page-3.7 (2010)\n",
+"clc;clear;\n",
+"a = 0.27e-9; // Lattice constant for BCC, metre \n",
+"c = 0.494e-9; // Height of the unit cell, metre\n",
+"M = 65.37; // Atomic weight of zn, kg\n",
+"N = 6.02e+26; // Avogadro number per k mol\n",
+"m = 6*M/N; // Mass per unit cell in HCP structure, kg\n",
+"V = 3*sqrt(3)*a^2*c/2; // Volume of unit cell in HCP, metre cube\n",
+"rho = m/V; // Density of HCP Zn structure, kg per metrecube\n",
+"\n",
+"printf('\nVolume of HCP Zn structure = %4.3e metrecube', V);\n",
+"printf('\nDensity of HCP Zn structure = %4.0f kg per metrecube', rho);\n",
+"\n",
+"// Result \n",
+"// Volume of HCP Zn structure = 9.356e-29 metrecube\n",
+"// Density of HCP Zn structure = 6963 kg per metrecube "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 3.5: Interplanar_spacing_in_110_and_212_planes_in_FCC_lattice.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"/// Scilab Code Ex3.5 : Page-3.5 (2004)\n",
+"clc;clear;\n",
+"r = 0.1278; // Atomic radius, nm\n",
+"a = 4*r/sqrt(2); // Lattice constant, nm\n",
+"h1 = 1, k1 = 1, l1 = 0; // Miller Indices of (110) planes\n",
+"d_110 = a/sqrt(h1^2 + k1^2 + l1^2); // Interplanar spacing for (110) planes, nm\n",
+"h2 = 2, k2 = 1, l2 = 2; // Indices of third set of parallel planes\n",
+"d_212 = a/sqrt(h2^2 + k2^2 + l2^2); // Interplanar spacing for (111) planes, nm\n",
+"printf('\nInterplanar spacing for (110) planes = %6.4f nm', d_110);\n",
+"printf('\nInterplanar spacing for (212) planes = %6.4f nm', d_212);\n",
+"\n",
+"// Result \n",
+"// Interplanar spacing for (110) planes = 0.2556 nm\n",
+"// Interplanar spacing for (212) planes = 0.1205 nm "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 3.6: Ratio_of_interplanar_spacing_in_SC_lattice.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex3.6 : Page-3.8 (2004)\n",
+"clc;clear;\n",
+"a = 1; // For simplicity we assume a to be unity, unit\n",
+"h1 = 1, k1 = 0, l1 = 0; // Indices of first set of parallel planes\n",
+"d_100 = a/sqrt(h1^2 + k1^2 + l1^2); // Interplanar spacing for (100) planes, unit\n",
+"h2 = 1, k2 = 1, l2 = 0; // Indices of second set of parallel planes\n",
+"d_110 = a/sqrt(h2^2 + k2^2 + l2^2); // Interplanar spacing for (110) planes, unit\n",
+"h3 = 1, k3 = 1, l3 = 1; // Indices of third set of parallel planes\n",
+"d_111 = a/sqrt(h3^2 + k3^2 + l3^2); // Interplanar spacing for (111) planes, unit\n",
+"printf('\nd_100 : d_110 : d_111 = %1d : %4.2f : %4.2f', d_100, d_110, d_111);\n",
+"\n",
+"// Result \n",
+"// d_100 : d_110 : d_111 = 1 : 0.71 : 0.58 "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 3.7: Miller_indices_of_a_plane_in_SC_lattice.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex3.7 : Page-3.8 (2004)\n",
+"clc;clear;\n",
+"m = 1; n = 1/2; p = 3; // Coefficients of intercepts along three axes\n",
+"m_inv = 1/m; // Reciprocate the first coefficient\n",
+"n_inv = 1/n; // Reciprocate the second coefficient\n",
+"p_inv = 1/p; // Reciprocate the third coefficient\n",
+"mul_fact = double(lcm(int32([1, 1, 3]))); // Find l.c.m. of 1, 1 and 3\n",
+"m1 = m_inv*mul_fact; // Clear the first fraction\n",
+"m2 = n_inv*mul_fact; // Clear the second fraction\n",
+"m3 = p_inv*mul_fact; // Clear the third fraction\n",
+"printf('\nThe required miller indices are : (%d %d %d) ', m1,m2,m3);\n",
+"\n",
+"// Result \n",
+"// The required miller indices are : (3 6 1)"
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 3.8: Ratio_of_vacancies_in_metal.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex3.8 : Page-3.13 (2004)\n",
+"clc;clear;\n",
+"N = 1; // For simplicity assume total number of metal ions to be unity\n",
+"e = 1.6e-019; // Electronic charge, C\n",
+"k = 1.38e-023/e; // Boltzmann constant, eV/K\n",
+"T1 = 500; // First temperature for metal, K\n",
+"T2 = 1000; // Second temperature for metal, K\n",
+"E_v = 1; // Average energy required to create a vacancy in metal, eV \n",
+"n_500 = N*exp(-E_v/(k*T1)); // Number of vacancies at 500 K\n",
+"n_1000 = N*exp(-E_v/(k*T2)); // Number of vacancies at 500 K\n",
+"n_ratio = n_1000/n_500; // Ratio of vacancies in metal \n",
+"printf('\nThe ratio of vacancies in metal = %5.3e', n_ratio);\n",
+"\n",
+"// Result \n",
+"// The ratio of vacancies in metal = 1.085e+05 "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 3.9: Fraction_of_vacancy_sites_in_metal.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex3.9 : Page-3.14 (2004)\n",
+"clc;clear;\n",
+"T1 = 500+273; // First temperature for metal, K\n",
+"T2 = 1000+273; // Second temperature for metal, K\n",
+"frac_vac = 1e-010; // n1/N, the fraction of vacancy sites at 500 degree celsius\n",
+"e = 1.6e-019; // Electronic charge, C\n",
+"k = 1.38e-023/e; // Boltzmann constant, eV/K\n",
+"// n1 = N*exp(-E_f/(k*T1)); // Number of vacancies at 500 K\n",
+"// n2 = N*exp(-E_f/(k*T2)); // Number of vacancies at 500 K, solving for n2/N = x\n",
+"x = exp((T1/T2)*log(frac_vac));\n",
+"printf('\nThe fraction of vacancy sites in metal = %6.4e', x);\n",
+"\n",
+"// Result \n",
+"// The fraction of vacancy sites in metal = 8.4670e-07 "
+ ]
+ }
+],
+"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/Solid_State_Physics_by_P_K_Palanisamy/4-Line_Defects_and_Crystal_Structure_Determination.ipynb b/Solid_State_Physics_by_P_K_Palanisamy/4-Line_Defects_and_Crystal_Structure_Determination.ipynb
new file mode 100644
index 0000000..91d3697
--- /dev/null
+++ b/Solid_State_Physics_by_P_K_Palanisamy/4-Line_Defects_and_Crystal_Structure_Determination.ipynb
@@ -0,0 +1,285 @@
+{
+"cells": [
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "# Chapter 4: Line Defects and Crystal Structure Determination"
+ ]
+ },
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 4.1: Wavelength_of_X_ray_and_order_of_diffraction.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex4.1 : Page-4.13 (2004)\n",
+"clc;clear;\n",
+"function thet = degree_minute (d, m)\n",
+" thet = d + m/60; \n",
+"endfunction\n",
+"deg = 8, minutes = 35; // Given glancing angle, degrees-minutes\n",
+"theta = degree_minute (deg, minutes); // Convert degree-minutes to degrees\n",
+"d = 0.282; // lattice spacing for NaCl crystal, nm\n",
+"n = 1; // Order of diffraction\n",
+"lambda = 2*d*sind(theta)/n; // Wavelength from Bragg's law, nm\n",
+"printf('\nWavelength of X rays = %6.4f nm ', lambda);\n",
+"theta = 90; // maximum possible value for theta for maximum order of diffraction\n",
+"n = 2*d*sind(theta)/lambda; // order of diffraction from Bragg's law\n",
+"printf('\nMaximum possible order of diffraction = %1d', n);\n",
+"\n",
+"// Result \n",
+"// Wavelength of X rays = 0.0842 nm \n",
+"// Maximum possible order of diffraction = 6 "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 4.2: Ratio_of_interplanar_spacing_in_simple_cube.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex4.2 : Page-4.13 (2004)\n",
+"clc;clear;\n",
+"a = 1; // For simplicity we assume a to be unity, unit\n",
+"h1 = 1, k1 = 0, l1 = 0; // Indices of first set of parallel planes\n",
+"d_100 = a/sqrt(h1^2 + k1^2 + l1^2); // Interplanar spacing for (100) planes, unit\n",
+"h2 = 1, k2 = 1, l2 = 0; // Indices of second set of parallel planes\n",
+"d_110 = a/sqrt(h2^2 + k2^2 + l2^2); // Interplanar spacing for (110) planes, unit\n",
+"h3 = 1, k3 = 1, l3 = 1; // Indices of third set of parallel planes\n",
+"d_111 = a/sqrt(h3^2 + k3^2 + l3^2); // Interplanar spacing for (111) planes, unit\n",
+"printf('\nd_100 : d_110 : d_111 = %1d : %4.2f : %4.2f', d_100, d_110, d_111);\n",
+"\n",
+"// Result \n",
+"// d_100 : d_110 : d_111 = 1 : 0.71 : 0.58 "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 4.3: Wavelength_of_X_ray_from_Bragg_Law.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex4.3 : Page-4.14 (2004)\n",
+"clc;clear;\n",
+"function thet = degree_minute (d, m)\n",
+" thet = d + m/60; \n",
+"endfunction\n",
+"\n",
+"degr = 8, minutes = 35; // Given glancing angle, degrees-minutes\n",
+"theta = degree_minute (degr, minutes); // Convert degree-minutes to degrees\n",
+"d = 0.282; // lattice spacing for NaCl crystal, nm\n",
+"n = 1; // Order of diffraction\n",
+"lambda = 2*d*sind(theta)/n; // Wavelength from Bragg's law, nm\n",
+"\n",
+"printf('\nWavelength of X rays = %6.4f nm ', lambda);\n",
+"\n",
+"// Result \n",
+"// Wavelength of X rays = 0.0842 nm \n",
+""
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 4.4: Interatomic_spacing.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex4.4 : Page-4.14 (2004)\n",
+"clc;clear;\n",
+"theta = 30; // bragg's angle, degree\n",
+"lambda = 1.5418e-10; // X-ray wavelength, m\n",
+"n = 1; // Order of diffraction\n",
+"d = (n*lambda)/(2*sind(theta)); // Wavelength from Bragg's law, nm\n",
+"h = 1, k = 1, l = 1; // plane\n",
+"a = d*(h^2+k^2+l^2)^(1/2); // interatomic spacing, angstrom\n",
+"printf('\nWavelength of X rays = %6.4e m ', d);\n",
+"printf('\nInteratomic spacing = %5.3f angstrom', a/1e-10);\n",
+"\n",
+"// Result \n",
+"// Wavelength of X rays = 1.5418e-10 m \n",
+"// Interatomic spacing = 2.670 angstrom "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 4.5: Glancing_angle_for_second_order_diffraction.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex4.5 : Page-4.14 (2004)\n",
+"clc;clear;\n",
+"lambda = 0.071; // X-ray wavelength, nm\n",
+"n = 2; // Second order of diffraction\n",
+"d_100 = 0.28; // Interplanar spacing for (100) plane, nm\n",
+"d_110 = d_100/sqrt(2); // Interplanar spacing for (110) plane, nm\n",
+"x = n*lambda/(2*d_110); // sine of angle , degree\n",
+"theta = asind(x); // Glancing angle for second order diffraction \n",
+"\n",
+"printf('\nGlancing angle for second order diffraction = %d degree ', round(theta));\n",
+"\n",
+"// Result \n",
+"// Glancing angle for second order diffraction = 21 degree "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 4.6: Distance_between_two_adjacent_atoms_in_NaCl.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex4.6 : Page-4.15 (2004)\n",
+"clc;clear;\n",
+"n = 4; // Second order of diffraction\n",
+"M = 58.5; // Molecular weight of crystal\n",
+"d = 2180; // Density of crystal, kg per cm cube\n",
+"N = 6.02e+26; // Avogadro number , k / mol\n",
+"a = ((n*M)/(d*N))^(1/3); // Distance between two adjacent atoms of same kind, nm\n",
+"b = a/2; // Distance between two adjacent atoms of different kind, nm\n",
+"printf('\nDistance between two adjacent atoms of same kind = %5.3f nm ', a/1e-9);\n",
+"printf('\nDistance between two adjacent atoms of different kind = %5.3f nm ', b/1e-9);\n",
+"// Result \n",
+"\n",
+"// Distance between two adjacent atoms of same kind = 0.563 nm \n",
+"// Distance between two adjacent atoms of different kind = 0.281 nm "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 4.7: Distance_between_110_plane.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex4.7 Page-4.16 (2004)\n",
+"clc;clear;\n",
+"a = 0.38; // Lattice constant of copper, nm\n",
+"h =1, k = 1, l = 0; // Miller Indices (hkl)= (110)\n",
+"d = a/sqrt(h^2 + k^2 + l^2); // Interplanar spacing for (110) plane, unit\n",
+"printf('\nInterplanar spacing for (110) plane = %4.2f nm', d);\n",
+"\n",
+"// Result \n",
+"// Interplanar spacing for (110) plane = 0.27 nm "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 4.8: Density_of_Iron.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex4.8 : Page-4.16 (2004)\n",
+"clc;clear;\n",
+"r = 0.123e-9; // Atomic radius of iron, m\n",
+"n = 4; // Second order of diffraction\n",
+"M = 55.8; // Molecular weight of crystal\n",
+"a = 2*r*sqrt(2); // lattice constant, m\n",
+"N = 6.023e+26; // Avogadro number , k / mol\n",
+"d = n*M/(N*a^3); // Density of iron, kg /m-cube\n",
+"printf('\nDensity of iron = %5.4d kg/metrecube ', d);\n",
+"\n",
+"// Result \n",
+"// Density of iron = 8800 kg/metrecube "
+ ]
+ }
+],
+"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/Solid_State_Physics_by_P_K_Palanisamy/5-Principles_of_Quantum_Mechanics.ipynb b/Solid_State_Physics_by_P_K_Palanisamy/5-Principles_of_Quantum_Mechanics.ipynb
new file mode 100644
index 0000000..602a991
--- /dev/null
+++ b/Solid_State_Physics_by_P_K_Palanisamy/5-Principles_of_Quantum_Mechanics.ipynb
@@ -0,0 +1,462 @@
+{
+"cells": [
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "# Chapter 5: Principles of Quantum Mechanics"
+ ]
+ },
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 5.10: Minimum_Energy.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex 5.10 : Page-5.24 (2004)\n",
+"clc;clear;\n",
+"h = 6.626e-34; // Planck's const, Js\n",
+"m = 9.1e-31; // Mass of electron, kg\n",
+"L = 4e-10; // Side of the box, m\n",
+"n1 = 1; // nx box lowest quantum number\n",
+"E = (h^2)/(8*m*(L^2))*((n1)^2); //Lowest Energy level for electron confinement , in eV\n",
+"printf('\nMinimum Energy = %2.3e joule', E);\n",
+"\n",
+"// Results\n",
+"// Minimum Energy = 3.769e-19 joule"
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 5.11: Energy_of_ground_and_first_and_second_state.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex 5.11 : Page-5.24 (2004)\n",
+"clc;clear;\n",
+"h = 6.626e-34; // Planck's const, Js\n",
+"m = 9.1e-31; // Mass of electron in kg\n",
+"L = 1e-10; // Side of the box in m\n",
+"n1 = 1; // Ground state quantum number\n",
+"n2 = 2; // first quantum number\n",
+"n3 = 3; // second quantum number\n",
+"e = 1.6e-19; // charge on electron, C\n",
+"E1 = (h^2)/(8*m*(L^2))*((n1)^2); //Ground state Energy , joule\n",
+"E2 = (h^2)/(8*m*(L^2))*((n2)^2); //first state Energy , joule\n",
+"E3 = (h^2)/(8*m*(L^2))*((n3)^2); //second state Energy , joule\n",
+"\n",
+"printf('\nGround state Energy = %2.3e joule', E1);\n",
+"printf('\nFirst state Energy = %2.3e joule', E2);\n",
+"printf('\nSecond state Energy = %2.3e joule', E3);\n",
+"\n",
+"\n",
+"// Results\n",
+"// Ground state Energy = 6.031e-18 joule\n",
+"// First state Energy = 2.412e-17 joule\n",
+"// Second state Energy = 5.428e-17 joule"
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 5.12: Velocity_and_energy_of_electron.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex5.12 : Page-5.25 (2004)\n",
+"clc;clear;\n",
+"h = 6.626e-34; // Planck's const in Js\n",
+"m = 9.1e-31; // Mass of the electron in kg\n",
+"lam = 1.66e-10; // de Broglie wavelength, m\n",
+"e = 1.6e-19; // Charge on electron, C\n",
+"v = h/(m*lam); // Velocity of electron, m/s\n",
+"E = (m*v^2)/(2*e); // Kinetic energy of the electron in eV\n",
+"\n",
+"printf('\nVelocity of electron = %d km/s', v/1000);\n",
+"printf('\nKinetic energy of the electron = %5.2f eV', E);\n",
+"\n",
+"// Result \n",
+"// Velocity of electron = 4386 km/s\n",
+"// Kinetic energy of the electron = 54.71 eV "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 5.13: Wavelength_of_electron_waves.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex5.13 : Page-5.25 (2004)\n",
+"clc;clear;\n",
+"V = 15000; // Accelerating potential, volts\n",
+"lam = 12.26/sqrt(V); // de Broglie wavelength, angstrom\n",
+"printf('\nde Broglie wavelength of electron wave = %5.1f angstrom', lam);\n",
+"\n",
+"// Result \n",
+"// de Broglie wavelength of electron wave = 0.1 angstrom"
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 5.14: Uncertainty_in_momentum_of_electron.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex5.14 : Page-5.26 (2004)\n",
+"clc;clear;\n",
+"h = 6.62e-34 // Planck's const, Js\n",
+"delx = 1e-8 // Uncertainity in position, m\n",
+"m = 9.1e-31; // Mass of electron, kg\n",
+"delv = h/(m*delx); // Uncertainty in velocity, km/s\n",
+"\n",
+"printf('\nUncertainty in velocity = %3.2f km/sec', delv/1000);\n",
+"\n",
+"//Results\n",
+"// Uncertainty in velocity = 72.75 km/sec\n",
+"\n",
+""
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 5.1: de_Broglie_wavelength_of_proton.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex5.1 : Page-5.7 (2004)\n",
+"clc;clear;\n",
+"h = 6.626e-34; // Planck's const in Js\n",
+"m = 1.67e-27; // Mass of the proton in kg\n",
+"c = 3e+8; // Charge of electron in C\n",
+"v = c/10; // Proton velocity 1/10th of c\n",
+"E = 0.025; // Kinetic energy of the neutron in J\n",
+"lam = h/(m*v); // de Broglie wavelength in m\n",
+"printf('\nde Broglie wavelength = %5.3e m', lam);\n",
+"\n",
+"// Result \n",
+"// de Broglie wavelength = 1.323e-14 m "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 5.2: de_Broglie_wavelength_of_electron.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex5.2 : de Broglie wavelength of electron: Page-5.8 (2004)\n",
+"clc;clear;\n",
+"V = 400; // Accelerating potential, volts\n",
+"lam = 12.26/sqrt(V); // de Broglie wavelength, angstrom\n",
+"printf('\nde Broglie wavelength = %5.3f angstrom', lam);\n",
+"\n",
+"// Result \n",
+"// de Broglie wavelength = 0.613 angstrom \n",
+" "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 5.3: de_Broglie_wavelength_of_neutron.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex5.3 : Page-5.8 (2004)\n",
+"clc;clear;\n",
+"h = 6.626e-34; // Planck's const in Js\n",
+"m = 1.67e-27; // Mass of the neutron in kg\n",
+"e = 1.6e-19; // charge of electron in C\n",
+"E = 0.025; // kinetic energy of the neutron in J\n",
+"lam = h/(sqrt(2*m*E*e)); // de Broglie wavelength in m\n",
+"printf('\nde Broglie wavelength = %5.3f nm', lam/1e-9);\n",
+"\n",
+"// Result \n",
+"// de Broglie wavelength = 0.181 nm "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 5.4: Uncertainty_in_momentum_of_electron.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex5.4 : Uncertainty in momentum of electron: Page-5.13 (2004)\n",
+"clc;clear;\n",
+"h = 6.62e-34 // Planck's const, Js\n",
+"delx = 4e-10 // Uncertainty in position, m\n",
+"delp = h/(delx); // Uncertainity principle\n",
+"\n",
+"printf('\nUncertainty in momentum = %5.3e kg m/sec', delp);\n",
+"\n",
+"//Results\n",
+"// Uncertainty in momentum = 1.655000e-24 kg m/sec \n",
+""
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 5.5: Uncertainty_in_velocity_of_electron.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex5.5 : Page-5.13 (2004)\n",
+"clc;clear;\n",
+"h = 6.62e-34; // Planck's const, Js\n",
+"me = 9.1e-31; //Mass of electron, kg\n",
+"delx = 1e-9; // Uncertainty in position, m\n",
+"delp = h/(delx); // Uncertainty principle\n",
+"delv = (delp/me); // Uncertainty in velocity, m/sec\n",
+"\n",
+"printf ('\nUncertainty in velocity = %4.2e m/sec', delv)\n",
+"\n",
+"// Result\n",
+"// Uncertainty in velocity=7.2747e+05 m/sec "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 5.6: Uncertainty_in_time.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex 5.6 : Uncertainty in time : Page-5.13 (2004)\n",
+"clc;clear;\n",
+"h = 6.62e-34; // planck's const, Js\n",
+"n1 = 1; // first state\n",
+"n2 = 2; // second state\n",
+"En = (-13.6/n2^2)+(13.6/n1); //Energy for transition, in eV\n",
+"e = 1.6e-19; // Charge of electron , C\n",
+"E2 = e*En; // Energy for transition, J\n",
+"delE = E2/100; // Uncertainty in position, m\n",
+"delt = h/(delE); // Uncertainty principle\n",
+"printf('\nUncertainty in time = %1.3e sec', delt);\n",
+"\n",
+"// Results\n",
+"// Uncertainity in time = 4.056e-14 sec "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 5.7: Lowest_Energy_for_electron_confinement.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex 5.7 : Lowest Energy for electron confinement: Page-5.22 (2004)\n",
+"clc;clear;\n",
+"h = 6.62e-34; // Planck's const, Js\n",
+"m = 9.1e-31; // Mass of electron in kg\n",
+"L = 0.1e-9; // Side of the box in m\n",
+"n1 = 1; // nx box lowest quantum number\n",
+"n2 = 1; // ny box lowest quantum number\n",
+"n3 = 1; // nz box lowest quantum number\n",
+"e = 1.6e-19; // Charge on electron in C\n",
+"E = (h^2)/(8*e*m*L^2)*((n1)^2+(n2)^2+(n3)^2); //Lowest Energy for electron confinement , in eV\n",
+"printf('\nLowest Energy for electron confinement = %5.1f eV', E);\n",
+"\n",
+"\n",
+"// Results\n",
+"// Lowest Energy for electron confinement = 112.9 eV "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 5.8: Next_Lowest_Energy_level_for_electron_confinement.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex 5.8 : Page-5.22 (2004)\n",
+"clc;clear;\n",
+"h = 6.62e-34; // Planck's constant, Js\n",
+"m = 9.1e-31; // Mass of electron, kg\n",
+"L = 0.1e-9; // Side of the box, m\n",
+"n1 = 1; // nx box lowest quantum number\n",
+"n2 = 1; // ny box lowest quantum number\n",
+"n3 = 2; // nz box lowest quantum number\n",
+"e = 1.6e-19; // Charge on electron, C\n",
+"E = (h^2)/(8*e*m*L^2)*((n1)^2+(n2)^2+(n3)^2); //Lowest Energy level for electron confinement , in eV\n",
+"\n",
+"printf('\nLowest Energy level for electron confinement = %6.2f eV', E);\n",
+"\n",
+"// Result\n",
+"// Lowest Energy level for electron confinement = 225.74 eV "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 5.9: de_Broglie_wavelength_from_energy.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex5.9 : Page-5.23 (2004)\n",
+"clc;clear;\n",
+"h = 6.626e-34; // Planck's const in Js\n",
+"m = 9.1e-31; // Mass of the neutron in kg\n",
+"e = 1.6e-19; // Charge of electron in C\n",
+"E = 2000; // Kinetic energy of the neutron in eV\n",
+"lam = h/(sqrt(2*m*E*e)); // de Broglie wavelength in m\n",
+"printf('\nde Broglie wavelength of electron = %6.4f nm', lam/1e-9);\n",
+"\n",
+"// Result \n",
+"// de Broglie wavelength of electron = 0.0275 nm "
+ ]
+ }
+],
+"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/Solid_State_Physics_by_P_K_Palanisamy/6-Electron_Theory_of_Metals.ipynb b/Solid_State_Physics_by_P_K_Palanisamy/6-Electron_Theory_of_Metals.ipynb
new file mode 100644
index 0000000..6044dfa
--- /dev/null
+++ b/Solid_State_Physics_by_P_K_Palanisamy/6-Electron_Theory_of_Metals.ipynb
@@ -0,0 +1,357 @@
+{
+"cells": [
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "# Chapter 6: Electron Theory of Metals"
+ ]
+ },
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 6.10: Temperature_for_occupation_of_a_state_above_Fermi_level.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex 6.10: Page-6.18 (2004)\n",
+"clc;clear;\n",
+"k = 1.38e-23; // Boltzmann constant, joule per kelvin\n",
+"T = 300; // For simplicity room temperature is taken, kelvin\n",
+"e = 1.6e-19; // Charge on electron, C\n",
+"EF = 5.5; // Fermi Energy, eV\n",
+"E = EF+(EF/100); // New energy, eV\n",
+"F_E = 0.1; // Fermi function, unitless\n",
+"T = e*(E-EF)/(k*log((1-F_E)/F_E)); //Temperature for 10% probabilty that electron in silver have an energy 1% above the fermi energy, kelvin\n",
+"\n",
+"printf('\nTemperature = %5.1f kelvin', T);\n",
+"\n",
+"// Results\n",
+"// Temperature = 290.2 kelvin "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 6.11: Number_of_energy_state_in_unit_volume.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex 6.11: Page-6.22 (2004)\n",
+"clc;clear;\n",
+"h = 6.62e-34; // Planck's constant, Js\n",
+"m = 9.14e-31; // Mass of the electron, kg\n",
+"e = 1.6e-19; // Charge on electron, C\n",
+"E1=3.22*e; // First state energy, joules\n",
+"E2=3.24*e; // Second state energy, joules\n",
+"n = 8*%pi*(2*m)^(3/2)*(E2^(3/2)-E1^(3/2))/(3*h^3); // Number of energy state in unit volume\n",
+"printf('\nNumber of energy state in unit volume= %4.3e ', n);\n",
+"//Result\n",
+"// Number of energy state in unit volume= 2.463e+26 "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 6.12: Temperature_needed_to_fill_a_state_above_Fermi_level.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex 6.12: Page-6.22 (2004)\n",
+"clc;clear;\n",
+"k = 1.38e-23; // Boltzmann constant, joule per kelvin\n",
+"T = 300; // For simplicity room temperature is taken, kelvin\n",
+"e = 1.6e-19; // Charge on electron, C\n",
+"EF = 1; // For simplicity Fermi Energy is taken as unity, eV\n",
+"E = EF+0.5; // New energy, eV\n",
+"F_E = 0.01; // Fermi function, unitless\n",
+"T = e*(E-EF)/(k*log((1-F_E)/F_E)); //Temperature for 1% probabilty that electron have an energy 0.5eV above the fermi energy, kelvin\n",
+"\n",
+"printf('\nTemperature = %d kelvin', round(T));\n",
+"\n",
+"// Results\n",
+"// Temperature = 1262 kelvin "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 6.1: Electron_Density_and_mobility_in_silver.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex6.1 : Page-6.8 (2004)\n",
+"clc;clear;\n",
+"M = 107.9; // Molecular weight of silver, kg\n",
+"d = 10.5e+03; // Density of of silver, kg per metrecube\n",
+"N = 6.023D+26; // Avogadro's Number., atoms/k-mol\n",
+"a = 6.8e+07; // conductivity of silver, per ohm per sec\n",
+"e = 1.6e-19; // charge of electron, C\n",
+"n = d*N/M; // Density of electron\n",
+"mu = a/(n*e); // Mobility of electron\n",
+"printf('\nDensity of electron = %4.2e ', n);\n",
+"printf('\nMobility of electron = %5.3e metersquare per volt per sec', mu);\n",
+"\n",
+"// Result \n",
+"// Density of electron = 5.86e+28 \n",
+"// Mobility of electron = 7.251e-03 metersquare per volt per sec "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 6.2: Mobility_and_average_time_of_collision_in_copper.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex6.2 : Page-6.9 (2004)\n",
+"clc;clear;\n",
+"M = 63.5; // Molecular weight of copper, kg\n",
+"d = 8.92e+03; // Density of of copper, kg per metrecube\n",
+"rho = 1.73e-8; // Resistivity of copper, ohm m\n",
+"m = 9.1e-31; // Mass of electron, kg\n",
+"N = 6.023D+26; // Avogadro's No., atoms/k-mol\n",
+"e = 1.6e-19; // Charge of electron, C\n",
+"n = d*N/M; // Density of electron\n",
+"mu = 1/(rho*n*e); // Mobility of electron\n",
+"t = m/(n*(e^2)*rho); // Average time of collision, sec\n",
+"printf('\nNumber Density of electron = %4.2e ', n);\n",
+"printf('\nMobility of electron = %3.3e meter per volt per sec', mu);\n",
+"printf('\naverage time of collision = %3.2e sec', t);\n",
+"\n",
+"// Result \n",
+"// Number Density of electron = 8.46e+28 \n",
+"// Mobility of electron = 4.270e-03 meter per volt per sec\n",
+"// average time of collision = 2.429e-14 sec "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 6.3: Electrical_resistivity_in_Sodium_metal.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex6.3 : Page-6.10 (2004)\n",
+"clc;clear;\n",
+"t = 3e-14; // Mean free time, sec\n",
+"m = 9.1e-31; // Mass of electron, kg\n",
+"e = 1.6e-19; // Charge of electron, C\n",
+"r = 1.85e-10; // Radius of sodium atom, m \n",
+"a = 4*r/sqrt(3); // Sodium has BCC structure\n",
+"n = 2/(a^3); // Number of electron per unit volume\n",
+"rho = m/(n*(e^2)*t); // Electrical resistivity, ohm m\n",
+"\n",
+"printf('\nElectrical resistivity = %3.3e ohm m', rho);\n",
+"\n",
+"// Result \n",
+"// Electrical resistivity = 4.620e-08 ohm m "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 6.4: Resistivity_of_sodium_at_zero_degree_Celsius.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex6.4: Page-6.11 (2004)\n",
+"clc;clear;\n",
+"t = 3.1e-14; // Mean free time, sec\n",
+"m = 9.1e-31; // Mass of electron, kg\n",
+"e = 1.6e-19; // Charge of electron, C\n",
+"r = 0.429e-9; // Side of the unit cell. m \n",
+"n = 2/(r^3); // Number of electron per unit cubemetre\n",
+"rho = m/(n*(e^2)*t); // Electrical resistivity, ohm m\n",
+"printf('\nElectrical resistivity of sodium at zero degree Celsius = %2.3e ohm m', rho);\n",
+"\n",
+"// Result \n",
+"// Electrical resistivity of sodium at zero degree Celsius = 4.527e-08 ohm m "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 6.5: Next_Lowest_Energy_level_for_electron_confinement.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex 6.5 : Page-6.15 (2004)\n",
+"clc;clear;\n",
+"h = 6.62e-34; // Planck's const, Js\n",
+"m = 9.1e-31; // Mass of electron in kg\n",
+"L = 0.1e-9; // Side of the box in m\n",
+"n1 = 1; // nx box lowest quantum number\n",
+"n2 = 1; // ny box lowest quantum number\n",
+"n3 = 1; // nz box lowest quantum number\n",
+"e = 1.6e-19; // Charge on electron, C\n",
+"E = (h^2)/(8*e*m*L^2)*((n1)^2+(n2)^2+(n3)^2); //Lowest Energy level for electron confinement , in eV\n",
+"printf('\nLowest Energy level for electron confinement = %2.1f eV', E);\n",
+"\n",
+"// Results\n",
+"// Lowest Energy level for electron confinement = 112.9 eV \n",
+""
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 6.7: Energy_level_for_electron_confinement_and_equivalent_temperature.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex 6.7: Page-6.17 (2004)\n",
+"clc;clear;\n",
+"h = 6.62e-34; // Planck's const, Js\n",
+"m = 9.1e-31; // Mass of electron in kg\n",
+"L = 1e-9; // length of cube box , m\n",
+"n1 = 1; // nx box quantum number\n",
+"n2 = 1; // ny box lowest quantum number\n",
+"n3 = 2; // nz box quantum number\n",
+"k = 1.38e-23; // Boltzmann constant, joule per kelvin\n",
+"e = 1.6e-19; // Charge on electron, C\n",
+"E = (h^2)/(8*m*L^2)*((n1)^2+(n2)^2+(n3)^2); //Lowest Energy level for electron confinement , in joule\n",
+"T = 2*E/(3*k); // Equivalent temperature of the molecules, kelvin\n",
+"\n",
+"printf('\nEnergy for electron confinement = %5.3e joule', E);\n",
+"printf('\nEquivalent temperature of the molecules = %5.3e kelvin', T);\n",
+"\n",
+"// Results\n",
+"// Energy for electron confinement = 3.61e-19 joule\n",
+"// Equivalent temperature of the molecules = 1.74e+04 kelvin "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 6.9: Temperature_from_Fermi_function.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex 6.9: Page-6.18 (2004)\n",
+"clc;clear;\n",
+"k = 1.38e-23; // Boltzmann constant, joule per kelvin\n",
+"T = 300; // For simplicity room temperature is taken, kelvin\n",
+"e = 1.6e-19; // Charge on electron, C\n",
+"E = k*T; // Given Energy, eV\n",
+"F_E = 1/(1+exp(E/(k*T))); //Fermi function , unitless\n",
+"T = 300; // For simplicity room temperature is taken, kelvin\n",
+"printf('\nFermi fucntion = %5.3f ', F_E);\n",
+"\n",
+"// Results\n",
+"// Fermi fucntion = 0.269 \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/Solid_State_Physics_by_P_K_Palanisamy/7-Dielectric_Properties.ipynb b/Solid_State_Physics_by_P_K_Palanisamy/7-Dielectric_Properties.ipynb
new file mode 100644
index 0000000..787e582
--- /dev/null
+++ b/Solid_State_Physics_by_P_K_Palanisamy/7-Dielectric_Properties.ipynb
@@ -0,0 +1,250 @@
+{
+"cells": [
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "# Chapter 7: Dielectric Properties"
+ ]
+ },
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 7.1: Net_energy_stored_in_capacitor.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex7.1: Page-7.23 (2004)\n",
+"clc;clear;\n",
+"C = 2e-6; // Capacitance, farad\n",
+"V = 1000; // Applied Voltage, volt\n",
+"W = C*V^2/2; // Energy stored in capacitor, joule\n",
+"er = 100; //Electric permittivity\n",
+"Co = C/er; // New Capacitance without dielectric, farad\n",
+"Wo = Co*V^2/2; // New Energy without dielectric, farad\n",
+"Wt = W-Wo; // Net energy stored in capacitor, joules\n",
+"printf('\nNet energy stored in capacitor = %3.2f joules', Wt);\n",
+"\n",
+"// Result\n",
+"// Net energy stored in capacitor = 0.99 joules "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 7.2: Ratio_of_polarizatio.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex7.2: Page-7.24 (2004)\n",
+"clc;clear;\n",
+"er = 4.94; //Electric permittivity\n",
+"n = sqrt(2.69); // Index of refration, unitless\n",
+"a = (n^2-1)/(n^2+2); // Variable 1\n",
+"b = (er-1)/(er+2); // Variable 2 \n",
+"alpha = (b/a)-1; // Ratio between ionic and electrical polarization\n",
+"alp = 1/alpha; //Ratio between electrical and ionic polarization\n",
+"\n",
+"printf('\nRatio between ionic and electrical polarization = %3.3f ', alpha);\n",
+"printf('\nRatio between electrical and ionic polarization = %3.3f ', alp);\n",
+"\n",
+"// Result\n",
+"// Ratio between ionic and electrical polarization = 0.576 \n",
+"// Ratio between electrical and ionic polarization = 1.738 "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 7.3: Parallel_loss_resistance_and_capacitance.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex7.3: Page-7.25 (2004)\n",
+"clear;clc;\n",
+"er = 2.56; // Relative permittivity\n",
+"tan_deta = 0.7e-4; // Loss tangent\n",
+"f = 1e+6; // frequency, Hz\n",
+"er2 = er*tan_deta; // Imaginary part of relative permittivity\n",
+"A = 8e-4; // Area between plates, squaremetre\n",
+"eo = 8.854e-12; //Permittivity of the free space, farad per metre\n",
+"w = 2*%pi*f; // angular frequency, Hz\n",
+"d = 0.08e-3; // Distance between plates, m\n",
+"Rp = d/(w*eo*er2*A); // Parallel loss resistance, ohm\n",
+"Cp = A*eo*er/d; // Capacitance , farad\n",
+"\n",
+"printf('\nParallel loss resistance = %3.3e ohm', Rp);\n",
+"printf('\nCapacitance = %3.3e farad', Cp);\n",
+"\n",
+"// Result\n",
+"//Parallel loss resistance = 1.003e+07 ohm\n",
+"//Capacitance = 2.267e-10 farad "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 7.4: Dielectric_constant_of_the_material.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex7.4: Page-7.26 (2004)\n",
+"clc;clear;\n",
+"N = 3e+28; // Number density, atoms per metrecube\n",
+"eo = 8.854e-12; //Permittivity of the free space, farad per metre\n",
+"alpha = 10e-40; // Electrical polarization, farad metresquare\n",
+"er = 1+(N*alpha/eo); // Dielectric constant of the material\n",
+"printf('\nDielectric constant of the material = %3.3f ', er);\n",
+"\n",
+"\n",
+"// Result\n",
+"// Dielectric constant of the material = 4.388 "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 7.5: Electric_polarizability_of_He_atoms.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex7.5: Page-7.26 (2004)\n",
+"clc;clear;\n",
+"N = 2.7e+25; // Number density, atoms per metrecube\n",
+"eo = 8.854e-12; //Permittivity of the free space, farad per metre\n",
+"er = 1.0000684; // Dielectric constant of the material\n",
+"alpha = eo*(er-1)/N; // Electrical polarization, farad metresquare\n",
+"\n",
+"printf('\nElectrical polarization = %3.3e farad metresquare', alpha);\n",
+"\n",
+"// Result\n",
+"// Electrical polarization = 2.243e-41 farad metresquare"
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 7.6: Capacitance_and_charge_on_the_plates.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex7.6: Page-7.27 (2004)\n",
+"clc;clear;\n",
+"A = 100e-4; // Area of parallel plates, squaremetre\n",
+"d = 1e-2; // Distance between plates, metre\n",
+"eo = 8.854e-12; // Permittivity of the free space, farad per metre\n",
+"V = 100; // Potential, volt\n",
+"C = eo*A/d; // Capacitance, farad\n",
+"Q = C*V; // Charge on the plates of capacitor, C\n",
+"printf('\nCapacitance = %5.3e F ', C);\n",
+"printf('\nCharge on the plates of capacitor = %3.3e C', Q);\n",
+"\n",
+"// Result\n",
+"// Capacitance = 8.854e-12 F\n",
+"// Charge on the plates of capacitor = 8.854e-10 C "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 7.7: Electric_polarizability_of_sulphur_atoms.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex7.7: Page-7.28 (2004)\n",
+"clc;clear;\n",
+"N = 385.66e+26; // Number density, atoms per metrecube\n",
+"eo = 8.854e-12; //Permittivity of the free space, farad per metre\n",
+"er = 3.75; // Dielectric constant of the material\n",
+"alpha = 3*eo*(er-1)/(N*(er+2)); // Electric polarizability of sulphur atoms\n",
+"printf('\nElectric polarizability of sulphur atoms = %3.3e farad metresquare', alpha);\n",
+"\n",
+"// Result\n",
+"// Electric polarizability of sulphur atoms = 3.294e-40 farad metresquare "
+ ]
+ }
+],
+"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/Solid_State_Physics_by_P_K_Palanisamy/8-Magnetic_Properties.ipynb b/Solid_State_Physics_by_P_K_Palanisamy/8-Magnetic_Properties.ipynb
new file mode 100644
index 0000000..4543ef1
--- /dev/null
+++ b/Solid_State_Physics_by_P_K_Palanisamy/8-Magnetic_Properties.ipynb
@@ -0,0 +1,257 @@
+{
+"cells": [
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "# Chapter 8: Magnetic Properties"
+ ]
+ },
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 8.1: Relative_permeability.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex8.1: Page-8.33 (2004)\n",
+"clc;clear;\n",
+"M = 3300; // Magnetization of ferromagnetic material, amp/metre\n",
+"H = 220; // Magnetic field strength, amp/metre\n",
+"mu_r = M/H+1; // Relative permeability, unitless\n",
+"printf('\nRelative permeability = %d', mu_r);\n",
+"\n",
+"// Result\n",
+"// Relative permeability = 16 "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 8.2: Magnetization_and_flux_density_of_ferromagnetic_material.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex8.2: Page-8.33 (2004)\n",
+"clc;clear;\n",
+"H = 10^6; // Magnetic field strength, amp/metre\n",
+"ki = 1.5e-3; // Magnetic susceptibility, units\n",
+"M = ki*H; // Magnetization of ferromagnetic material, amp/metre\n",
+"muo = 4*%pi*1e-7; // Magnetic permeability, henry/metre\n",
+"B = muo*(M+H); // Flux density,tesla\n",
+"printf('\nMagnetization of ferromagnetic material, = %3.1e amp/metre', M);\n",
+"printf('\nFlux density of ferromagnetic material, = %5.3f tesla', B);\n",
+"\n",
+"// Result\n",
+"\n",
+"// Magnetization of ferromagnetic material, = 1.5e+03 amp/metre\n",
+"// Flux density of ferromagnetic material, = 1.259 tesla "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 8.3: Magnetization_and_flux_density.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex8.3 : Page-8.34 (2004)\n",
+"clc;clear;\n",
+"H = 10^4; // Magnetic field strength, amp/metre\n",
+"ki = 3.7e-3; // Magnetic susceptibility, units \n",
+"M = ki*H; // Magnetization of ferromagnetic material, amp/metre\n",
+"muo = 4*%pi*1e-7; // Magnetic perbeability, henry/metre\n",
+"B = muo*(M+H); // Flux density, weber/square meter\n",
+"printf('\nMagnetization of ferromagnetic material, = %d amp/metre', M);\n",
+"printf('\nFlux density of ferromagnetic material, = %3.4f weber/squaremetre ', B);\n",
+"\n",
+"// Result\n",
+"\n",
+"// Magnetization of ferromagnetic material, = 37 amp/metre\n",
+"// Flux density of ferromagnetic material, = 0.0126 weber/squaremetre"
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 8.4: Magnetic_moment.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex8.4: Page-8.34 (2004)\n",
+"clc;clear;\n",
+"d = 8906; // Density of nickel, kg metrecube\n",
+"An = 6.025e+26; // Avogadro number, per kmol\n",
+"W = 58.7; // Atomic weight, kg\n",
+"N = d*An/W; // Number of nickel atom, per cubemetre\n",
+"Bs = 0.65; // Saturation magnetic, weber per squaremetre\n",
+"muo = (4*%pi*1e-7); // Magnetic perbeability, henry/metre\n",
+"mum = Bs/(N*muo); // Magnetic moment, ampere per sqauremetre\n",
+"X = mum/(9.27e-24); // magnetic moment, bohr magneton\n",
+"\n",
+"printf('\nNumber of nickel atom per cubemetre = %3.3e /cubemetre', N);\n",
+"printf('\nMagnetic moment = %1.2e bohr magneton', X);\n",
+"\n",
+"// Result\n",
+"\n",
+"// Number of nickel atom per cubemetre = 9.141e+28 /cubemetre\n",
+"// Magnetic moment = 6.10e-01 bohr magneton "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 8.5: Calculation_of_temperature_using_classical_statistics.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex8.5: Page-8.35 (2004)\n",
+"clc;clear;\n",
+"mu = 9.4e-24; // Magnetic moment, ampere metre square\n",
+"H = 2; // Magnetic field , weber per squaremetre \n",
+"k = 1.38e-23; // Boltzmann Constant, joule per kelvin\n",
+"T = (2*mu*H)/(log(2)*k); //Temperature using classical statistics, K\n",
+"\n",
+"printf('\nTemperature using classical statistics = %3.1f K', T);\n",
+"\n",
+"// Result\n",
+"// Temperature using classical statistics = 3.9 K "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 8.6: Saturation_magnetization.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex8.6: Page-8.36 (2004)\n",
+"clc;clear;\n",
+"A = 6.025e+26; // Avogadro number, per k mol\n",
+"W = 157.26; // Atomic weight, kg\n",
+"d = 7.8e+3; // Density of nickel,kg metrecube\n",
+"N = d*A/(W*1000); // No of atoms, per gm metrecube\n",
+"muo = 4*%pi*1e-7; // Magnetic perbeability, henry per m\n",
+"mum = N*7.1*(9.27e-24); // Magnetic moment, ampere metersquare\n",
+"Bs = mum*muo; // Saturation magnetization, weber/squaremetre\n",
+"printf('\nMagnetic moment = %6.4e ampere meter square', mum);\n",
+"printf('\nSaturation magnetization = %6.4e weber/squaremetre', Bs);\n",
+"\n",
+"// Result\n",
+"// Magnetic moment = 1.9669e+03 ampere meter square\n",
+"// Saturation magnetization = 2.4716e-03 weber/squaremetre \n",
+""
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 8.7: Magnetic_moment_of_nickel_in_Bohr_Magneton.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex8.7: Page-8.36 (2004)\n",
+"clc;clear;\n",
+"d = 8906; // Density of nickel, kg per metrecube\n",
+"An = 6.025e+26; // Avogadro number, per k mol\n",
+"W = 58.7; // Atomic weight, kg\n",
+"N = d*An/W; // Number density of nickel atom, per cubemetre\n",
+"Bs = 0.65; // Saturation magnetization, wb per squaremetre\n",
+"muo = (4*%pi*1e-7); // magnetic perbeability, henry/metre\n",
+"mum = Bs/(N*muo); // magnetic moment, ampere per squaremetre\n",
+"X = mum/(9.27e-24); // magnetic moment, bohr magneton\n",
+"\n",
+"printf('\nNumber density of nickel atom = %3.3e /cubemetre', N);\n",
+"printf('\nMagnetic moment = %1.2f bohr magneton', X);\n",
+"\n",
+"// Result\n",
+"\n",
+"// Number density of nickel atom per cubemetre = 9.141e+28 /cubemetre\n",
+"// Magnetic moment = 6.10e-01 bohr magneton "
+ ]
+ }
+],
+"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/Solid_State_Physics_by_P_K_Palanisamy/9-Semiconductors.ipynb b/Solid_State_Physics_by_P_K_Palanisamy/9-Semiconductors.ipynb
new file mode 100644
index 0000000..a43d9b7
--- /dev/null
+++ b/Solid_State_Physics_by_P_K_Palanisamy/9-Semiconductors.ipynb
@@ -0,0 +1,601 @@
+{
+"cells": [
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "# Chapter 9: Semiconductors"
+ ]
+ },
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 9.10: Conductivity_and_Position_of_Ef_above_the_intrinsic_level.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex9.10: Page-9.31 ; (2004)\n",
+"clc;clear;\n",
+"ni = 1.5e+16; // Intrinsic Carrier concentration at room temperature\n",
+"mu_e = 0.135; // Mobility of electron; m^2V^-1s^-1\n",
+"e = 1.6e-19; // Electronic charge, C\n",
+"Nd = 1e+23; // Impurity atoms , per metrecube\n",
+"T = 300; // Temperature, Kelvin \n",
+"k = 1.38e-23; // Boltzman constant,joule per kelvin\n",
+"mu_h = 0.048; // Mobility of holes, m^2V^-1s^-1\n",
+"sigma = ni*e*(mu_e+mu_h); // Conductivity, mho per meter\n",
+"p = ni^2/Nd; // Hole concentration, per metrecube\n",
+"sigma_ex = Nd*e*mu_e; // Conductivity with donor type impurities, mho per meter\n",
+"E_F =(3/(4*e))*k*T*(log(0.135/0.048)); // Position of fermi level above the intrinsic level, eV \n",
+"// mu is inversely propotional to mass \n",
+"printf('\nConductivity of silicon = %3.2e mho per meter', sigma);\n",
+"printf('\nHole concentration = %4.2e per metrecube', p);\n",
+"printf('\nConductivity with donor type impurities = %4.2e mho per meter', sigma_ex);\n",
+"printf('\nPosition of fermi level above the intrinsic level = %4.2f eV', E_F);\n",
+"\n",
+"//Results\n",
+"// Conductivity of silicon = 4.39e-04 mho per meter\n",
+"// Hole concentration = 2.25e+09 per metrecube\n",
+"// Conductivity with donor type impurities = 2.16e+03 mho per meter\n",
+"// Position of fermi level above the intrinsic level = 0.02 eV "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 9.11: Intrinsic_carrier_concentration_and_conductivity_in_germanium.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex9.11: Page-9.32 ; (2004)\n",
+"clc;clear;\n",
+"e = 1.6e-19; // Electronic charge, C\n",
+"Eg = 0.7*e; // Band gap energy, joules\n",
+"mu_e = 0.4; // Mobility of electron; m^2V^-1s^-1\n",
+"mu_h = 0.2; // Mobility of holes, m^2V^-1s^-1\n",
+"m = 9.1e-31; // Mass of electron, kg\n",
+"h = 6.63e-34; // Plancks Constant, Js\n",
+"T = 300; // Temperature, Kelvin \n",
+"k = 1.38e-23; // Boltzman constant,joule per kelvin\n",
+"C = 2*(2*%pi*T*m*k/h^2)^(3/2); // Constant parameter\n",
+"ni = C*exp((-Eg)/(2*k*T)); // Carrier concentration at room temperature\n",
+"sigma = ni*e*(mu_e+mu_h); // Conductivity, mho per meter\n",
+"printf('\nCarrier concentration at room temperature = %4.2e per metrecube', ni);\n",
+"printf('\nConductivity of silicon = %3.2f mho per meter', sigma);\n",
+"\n",
+"\n",
+"//Results\n",
+"// Carrier concentration at room temperature = 3.34e+19 per metrecube\n",
+"// Conductivity of silicon = 3.20 mho per meter "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 9.12: Forbidden_energy_band_gap.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex9.12: Page-9.32 ; (2004)\n",
+"clc;clear;\n",
+"e = 1.6e-19; // Electronic charge, C\n",
+"mu_e = 0.36; // Mobility of electron; m^2V^-1s^-1\n",
+"mu_h = 0.17; // Mobility of holes, m^2V^-1s^-1\n",
+"rho = 2.12; // Resistivity of sample, ohm metre \n",
+"sigma = 1/rho; // Conductivity of sample, mho per meter\n",
+"m = 9.1e-31; // Mass of electron, kg\n",
+"h = 6.63e-34; // Plancks Constant, Js\n",
+"T = 300; // Temperature, Kelvin \n",
+"k = 1.38e-23; // Boltzman constant,joule per kelvin\n",
+"// But ni = C*exp((-Eg)/(2*k*T)); // Carrier concentration at room temperature, therefore\n",
+"C = 2*(2*%pi*T*m*k/h^2)^(3/2); // Constant parameter\n",
+"ni = sigma/(e*(mu_e+mu_h)); // Carrier concentration, per metercube\n",
+"b = C/ni; // Ratio for simplicity\n",
+"Eg = 2/e*k*T*log(b); // Band gap energy, joules\n",
+"\n",
+"printf('\nBand gap energy = %5.4f eV', Eg);\n",
+"\n",
+"//Result\n",
+"// Band gap energy= 0.7927 eV "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 9.13: Hall_Voltage_of_a_semiconductor.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex9.13: Page-9.45 ; (2004)\n",
+"clc;clear;\n",
+"RH = 3.66e-4; // Hall coefficent, meter cube/C\n",
+"t = 1e-03; // thickness of the specimen, m\n",
+"Bz = 0.5; // Magnetic flux density, wb per meter square\n",
+"Ix = 1e-2; // Current , A\n",
+"VH = RH*Ix*Bz/t; // Voltage across specimen, volt\n",
+"printf('\nVoltage across specimen = %3.2f millivolt', VH/1e-3);\n",
+"\n",
+"// Result\n",
+"// Voltage across specimen = 1.83 millivolt"
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 9.14: Hall_coefficient_of_a_semiconductor.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex9.14: Hall coefficent of a semiconductor : Page-9.46 ; (2004)\n",
+"clc;clear;\n",
+"Vy = 37e-06; // Voltage across specimen, volt\n",
+"t = 1e-03; // thickness of the specimen, m\n",
+"Bz = 0.5; // Magnetic flux density, wb per meter square\n",
+"Ix = 20e-3; // Current , A\n",
+"RH = Vy*t/(Ix*Bz); // Hall coefficent, meter cube/C\n",
+"printf('\nHall coefficent, meter cube/C = %3.1e meter cube/C', RH);\n",
+"\n",
+"// Result\n",
+"// Hall coefficent, meter cube/C = 3.7e-06 meter cube/C "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 9.15: Mobility_density_and_nature_of_semiconductor.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex9.15: Page-9.46 ; (2004)\n",
+"clc;clear;\n",
+"e = 1.6e-19; // Electronic charge, C\n",
+"RH = -7.35e-5; // Hall coefficent, meter cube/C\n",
+"sigma = 200; // Conductivity of the Si specimen, per ohm per metre\n",
+"n = -1/(RH*e); // Electron density, per metre cube\n",
+"mu = sigma/(n*e); // Mobility of the charge carriers, square meter per voly per sec\n",
+"printf('\nElectron density = %3.3e per metre cube', n);\n",
+"printf('\nMobility = %3.3f square meter per volt per sec', mu);\n",
+"printf('\nAs the RH is negative, so specimen is n-type');\n",
+"\n",
+"//Result\n",
+"// Electron density = 8.503e+22 per metre cube\n",
+"// Mobility = 0.015 square meter per volt per sec\n",
+"// As the RH is negative, so specimen is n-type "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 9.16: Hall_Voltage.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex9.16: Page-9.47 ; (2004)\n",
+"clc;clear;\n",
+"e = 1.6e-19; // Electronic charge, C\n",
+"B = 1.5; // Magnetic field, tesla\n",
+"I = 50; // Current, ampere\n",
+"n = 8.4e+28; // Electron density, per metre cube\n",
+"t = 0.5e-2; // thickness of slab, metre\n",
+"RH = 1/(n*e); // Hall coefficent\n",
+"V_H = RH*I*B/t; // Hall voltage, volt \n",
+"printf('\nHall Voltage = %3.3f micro volt', V_H/1e-6);\n",
+"\n",
+"//Result\n",
+"// Hall Voltage = 1.116 micro volt "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 9.17: Mobility_and_number_of_Charge_carrier.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex9.17: Mobility and no of Charge carrier : Page-9.48 ; (2004)\n",
+"clc;clear;\n",
+"RH = 3.66e-4; // Hall Coefficient, metrcube/C\n",
+"e = 1.6e-19; // Electronic charge, C\n",
+"rho = 8.93e-3; // Resistivity of sample, ohm meter \n",
+"n = 1/(RH*e); // Number of charge carrier, per metre cube\n",
+"mu_e = RH/rho; // Mobility of electron, m^2 per volt per sec\n",
+"printf('\nNumber of charge carrier = %3.3e per metre cube', n);\n",
+"printf('\nMobility of electron = %4.5f squaremetre per volt per sec', mu_e);\n",
+"\n",
+"//Results\n",
+"// Number of charge carrier = 1.708e+22 per metre cube\n",
+"// Mobility of electron = 0.04099 m^2 per volt per sec "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 9.1: Resistivity.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex9.1: Page-9.24 ; (2004)\n",
+"clc;clear;\n",
+"ni = 2.37e+19; // Carrier concentration at room temperature\n",
+"mu_e = 0.38; // mobility of electron; m^2V^-1s^-1\n",
+"e = 1.6e-19; // electronic charge, C\n",
+"mu_h = 0.18; // mobility of holes; m^2V^-1s^-1\n",
+"sigma = ni*e*(mu_e+mu_h); // conductivity, mho.m^-1\n",
+"rho = 1/sigma; // Resistivity in Ge, ohm.m\n",
+"printf('\nConductivity in Ge = %4.2f mho.per m', sigma);\n",
+"printf('\nResistivity in Ge = %5.3f ohm.m', rho);\n",
+"\n",
+"//Results\n",
+"// Conductivity in Ge = 2.12 mho.per m\n",
+"// Resistivity in Ge = 0.471 ohm.m "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 9.2: Determination_of_Fermi_level.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex9.2: Page-9.24 (2004)\n",
+"clc;clear;\n",
+"Eg = 1.12; // Bandgap of silicon, eV\n",
+"me = 0.12*9.1e-031; // Effective Mass of the electron, kg\n",
+"e = 1.6e-19; // Electronic charge, C\n",
+"mh = 0.28*9.1e-031; // Effective Mass of the hole, kg\n",
+"k = 1.38e-23; // Boltzman constant, joule per kelvin\n",
+"T = 300; // temperature, K\n",
+"EF = (Eg/2)+3/4*k*T*(log(2.333))/e; // EF = E(Eg/2)+3/4*k*T*(log(2.333))/e; Formula\n",
+"\n",
+"printf('\nThe position of Fermi Level = %4.3f eV', EF);\n",
+"\n",
+"// Result\n",
+"// The position of Fermi Level = 0.576 eV "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 9.3: Number_of_intrinsic_carriers_at_300K.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex9.3: Number of intrinsic carriers at 300K: Page-9.26 ; (2004)\n",
+"clc;clear;\n",
+"e = 1.6e-19; // Electronic charge, C\n",
+"m = 9.1e-31; // Mass of electron, kg\n",
+"T = 300; // Room temperature, K\n",
+"k = 1.38e-23; // Boltzmann Constant, joule per kelvin \n",
+"Eg = 0.7*e; // Energy band gap of silicon, J\n",
+"h = 6.626e-34; // Plancks Constant, Js\n",
+"C = 2*(2*%pi*m*k/h^2)^(3/2); // A constant \n",
+"ni = C*T^(3/2)*exp((-Eg)/(2*k*T)); // formula for carrier concentration at room temperature\n",
+"printf('\nNumber of intrinsic carriers at 300K = %3.1e per cubemetre ', ni);\n",
+"\n",
+"//Results\n",
+"// Number of intrinsic carriers at 300K = 3.3e+19 per cubemetre "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 9.4: Resistivity_of_Ge_sample.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex9.4: Page-9.26 ; (2004)\n",
+"clc;clear;\n",
+"ni = 2.4e+19; // Carrier concentration at room temperature\n",
+"mu_e = 0.39; // Mobility of electron; m^2V^-1s^-1\n",
+"e = 1.6e-19; // Electronic charge, C\n",
+"mu_h = 0.19; // Mobility of holes, m^2V^-1s^-1\n",
+"sigma = ni*e*(mu_e+mu_h); // Conductivity, mho.m^-1\n",
+"rho = 1/sigma; // Resistivity in Ge, ohm.m\n",
+"printf('\nConductivity in Ge = %4.4f mho.per m', sigma);\n",
+"printf('\nResistivity in Ge = %5.3f ohm.m', rho);\n",
+"\n",
+"\n",
+"//Results\n",
+"// Conductivity in Ge = 2.2272 mho.per m\n",
+"// Resistivity in Ge = 0.449 ohm.m "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 9.5: Resistance_of_Ge_rod.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex9.5: Page-9.26 ; (2004)\n",
+"clc;clear;\n",
+"ni = 2.5e+19; // Carrier concentration at room temperature\n",
+"mu_e = 0.39; // Mobility of electron; m^2V^-1s^-1\n",
+"e = 1.6e-19; // Electronic charge, C\n",
+"l = 1e-2; // length of Ge rod, m\n",
+"w = 1e-3; // width of Ge rod,m\n",
+"t = 1e-3; // thickness of Ge rod, m\n",
+"A = w*t; // Area of Ge rod, meter square \n",
+"mu_h = 0.19; // Mobility of holes, m^2V^-1s^-1\n",
+"sigma = ni*e*(mu_e+mu_h); // Conductivity, mho.m^-1\n",
+"R = l/(sigma*A); // Resistivity in Ge, ohm.m\n",
+"printf('\nResistance of Ge rod = %4.2e ohm', R);\n",
+"\n",
+"//Results\n",
+"// Resistance of Ge rod = 4.31e+03 ohm "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 9.6: Conductivity_of_Si.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex9.6: Page-9.27 ; (2004)\n",
+"clc;clear;\n",
+"mu_e = 0.48; // Mobility of electron; m^2V^-1s^-1\n",
+"e = 1.6e-19; // Electronic charge, C\n",
+"m = 9.1e-31; // Mass of electron, kg\n",
+"mu_h = 0.013; // Mobility of holes, m^2V^-1s^-1\n",
+"T = 300; // Room temperature, K\n",
+"k = 1.38e-23; // Boltzmann Constant, joule per kelvin \n",
+"Eg = 1.1*e; // Energy band gap of silicon, J\n",
+"h = 6.626e-34; // Plancks Constant, Js\n",
+"C = 2*(2*%pi*m*k/h^2)^(3/2); // A constant \n",
+"ni = C*T^(3/2)*exp((-Eg)/(2*k*T)); // formula for carrier concentration at room temperature\n",
+"sigma = ni*e*(mu_e+mu_h); // Conductivity, mho per metre\n",
+"\n",
+"printf('\nConductivity = %3.1e mho per metre ', sigma);\n",
+"\n",
+"//Results\n",
+"// Conductivity = 1.2e-03 mho per metre "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 9.7: Electron_and_hole_concentration_in_silicon.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex9.7: Page-9.27 ; (2004)\n",
+"clc;clear;\n",
+"Na = 5e+23; // Concentration of boron atoms, per metrecube\n",
+"Nd = 3e+23; // Concentration of arsenic atoms, per metrecube\n",
+"p = Na-Nd; // Hole concentration, per metrecube\n",
+"ni = 2e+16; // Intrinsic concentration ,per metrecube\n",
+"n = ni^2/p; // Electron concentration, per metrecube\n",
+"\n",
+"printf('\nHole concentration = %3.1e per metrecube ', p);\n",
+"printf('\nElectron concentration = %3.1e per metrecube ', n);\n",
+"\n",
+"//Results\n",
+"// Hole concentration = 2.0e+23 per metrecube \n",
+"// Electron concentration = 2.0e+09 per metrecube "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 9.8: Temperature_that_shift_the_fermi_level.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex9.8: Page-9.28 (2004)\n",
+"clc;clear;\n",
+"Eg = 1; // Bandgap of silicon, eV\n",
+"e = 1.6e-19; // Electronic charge, C\n",
+"k = 1.38e-23; // Boltzman constant,joule per kelvin\n",
+"E_F = (0.6-0.5)*e; // Fermi energy, joules\n",
+"// E_F =((Ev+Ec)/2)+3/4*k*T1*(log(4)); // Ev & Ec= valance and conduction band energies (formula) \n",
+"T = 4*E_F/(3*k*log(4)); //Temperature that shift the fermi level, K\n",
+"\n",
+"printf('\nTemperature that shift the fermi level = %4.3d K', T);\n",
+"\n",
+"// Result\n",
+"// Temperature that shift the fermi level = 1115 K "
+ ]
+ }
+,
+{
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Example 9.9: Conductivity_of_intrinsic_silicon_at_300_K.sce"
+ ]
+ },
+ {
+"cell_type": "code",
+ "execution_count": null,
+ "metadata": {
+ "collapsed": true
+ },
+ "outputs": [],
+"source": [
+"// Scilab Code Ex9.9: Page-9.29 ; (2004)\n",
+"clc;clear;\n",
+"ni = 1.5e+16; // Intrinsic Carrier concentration at room temperature\n",
+"mu_e = 0.13; // Mobility of electron; m^2V^-1s^-1\n",
+"e = 1.6e-19; // Electronic charge, C\n",
+"Nd = 4.99e+20; // Impurity atoms , per metrecube\n",
+"mu_h = 0.05; // Mobility of holes, m^2V^-1s^-1\n",
+"sigma = ni*e*(mu_e+mu_h); // Conductivity, mho per meter\n",
+"sigma_d = Nd*e*mu_e; // Conductivity with donor type impurities, mho per meter\n",
+"sigma_a = Nd*e*mu_h; // Conductivity with acceptor type impurities, mho per meter\n",
+"printf('\nConductivity of silicon = %3.2e mho per meter', sigma);\n",
+"printf('\nConductivity with donor type impurities = %4.2f mho per meter', sigma_d);\n",
+"printf('\nConductivity with acceptor type impurities= %4.2f mho per meter', sigma_a);\n",
+"\n",
+"//Results\n",
+"// Conductivity of silicon = 4.32e-04 mho per meter\n",
+"// Conductivity with donor type impurities = 10.38 mho per meter\n",
+"// Conductivity with acceptor type impurities= 3.99 mho per meter "
+ ]
+ }
+],
+"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
+}