Chapter 1 Introduction
——————————————————————————————————-
Two types of empherical observation-discreetness of energy (which are taken place in light matter interaction) and the nature of light as a particle and nature of particle (electron etc.) as a wave (also known as wave-particle duality) motivate towards the quantum mechanics. In 1900 Max Planck postulated that exchange of energy between atoms and electromagnetic fields occur in bundle or quanta which is the product of wave frequency and a constant known as Planck constant [1]-the idea which resolve the spectrum of black body radiation. Planck introduced his constant h (Planck’s constant ) only to satisfy the agreement between theoretical model and experiment. For the explanation of photoelectric effect Albert Einstein took this idea of quanta and in 1905 he himself considered electromagnetic wave being consist of quanta of energy [2] . At this time light was thought to have wave properties (diffraction, interference etc.) but Einstein present another bold view of the nature of light.
Neil Bohr presented a simple model of Hydrogen atom in 1913 by assuming that electron revolves around the nucleus in a way planet revolve around the sun with the assumption that angular momentum of electron should be integral multiple of reduced Planck constant ℏ=h/2, and obtained discrete spectrum of hydrogen, which leads to the discrete energies of the corresponding electron[3]. Further, transitions between these energy levels are accompanied by the absorption or emission of a photon whose frequency is E/h, where E is the energy difference of the two levels. Apparently, the quantization of light is strongly tied to the quantization within matter. Inspired by his predecessors, Louis de Broglie suggested that not only light has particle characteristics, but that classical particles, such as electrons, have wave characteristics [4]. He associated the wavelength λ of these waves with the particle momentum p through the relation p = h/λ. Interestingly, Bohr’s condition for the orbital momentum of the electron is equivalent with the demand that the length of an orbital path of the electron has to be an integer multiple of its de Broglie wavelength.
Erwin Schrodinger was very intrigued by de Broglie’s ideas and set his mind on finding a wave equation for the electron. Closely following the electromagnetic prototype of a wave equation, and attempting to describe the electron relativistically, he first arrived at what we today know as the Klein-Gordon-equation. To his annoyance, however, this equation, when applied to the hydrogen atom, did not result in energy levels consistent with Arnold Sommerfeld’s fine structure formula, a refinement of the energy levels according to Bohr. Schrodinger therefore retreated to the non-relativistic case, and obtained as the non-relativistic limit to his original equation the famous equation that now bears his name. He published his results in a series of four papers in 1926[5-8]. Therein, he emphasizes the analogy between electrodynamics as a wave theory of light, which in the limit of small electromagnetic wavelength approaches ray optics, and his wave theory of matter, which approaches classical mechanics in the limit of small de Broglie wavelengths. His theory was consequently called wave mechanics. In a wave mechanical treatment of the hydrogen atom and other bound particle systems, the quantization of energy levels followed naturally from the boundary conditions. A year earlier, Werner Heisenberg had developed his matrix mechanics[9], which yielded the values of all measurable physical quantities as eigenvalues of a matrix. Schrodinger succeeded in showing the mathematical equivalence of matrix and wave mechanics[10]; they are just two different descriptions of quantum mechanics. A relativistic equation for the electron was found by Paul Dirac in 1927[11]. It included the electron spin of 1/2, a purely quantum mechanical feature without classical analog. Schrodinger’s original equation was taken up by Klein and Gordon, and eventually turned out to be a relativistic equation for bosons, i.e. particles with integer spin. In spite of its limitation to non-relativistic particles, and initial rejection from Heisenberg and colleagues, the Schrodinger equation became eventually very popular. Today, it provides the material for a large fraction of most introductory quantum mechanics courses.
1.1 Time-dependent Schrodinger Equation
The form of the Schrödinger equation depends on the physical situation. The most general form is the time-dependent Schrödinger equation, which gives a description of a system evolving with time that is the following
ⅈℏ δΨ(r,t)/δt=Ĥ(r,t)Ψ 1.1
where i is the imaginary unit, ħ is the Planck constant divided by 2π, the symbol δ/δt indicates a partial derivative with respect to time t, Ψ (the Greek letter psi) is the wave function of the quantum system, r and t are the position vector and time respectively, and Ĥ is the Hamiltonian operator (which characterizes the total energy of any given wave function and takes different forms depending on the situation).
Putting the expression for Hamiltonian
ⅈℏ (δΨ(r,t))/δt=((-ℏ^2)/2m ∇^2+V(r,t))Ψ(r,t) 1.2
1.2 Time-independent Schrodinger Equation
The time-dependent Schrödinger equation described above predicts that wave functions can form standing waves, called stationary states (also called \”orbitals\”, as in atomic orbitals or molecular orbitals). These states are important in their own right, and if the stationary states are classified and understood, then it becomes easier to solve the time-dependent Schrödinger equation for any state. Stationary states can also be described by a simpler form of the Schrödinger equation, the time-independent Schrödinger equation. (This is only used when the Hamiltonian itself is not dependent on time explicitly. However, even in this case the total wave function still has a time dependency.)
EΨ=ĤΨ 1.3
Putting the value of Hamiltonian
EΨ(r)=((-ℏ^2)/2m ∇^2+V(r))Ψ(r) 1.4
In equation 1.4 potential function V(r) is solely a function of space variable r and hence the resulting wave function.
Chapter 02 Literature Review
2.1 Genetic Algorithm
Genetic Algorithms are the directed search algorithms which are based on the process of biological evolution. It is actually developed by John Holland, University of Michigan in 1970’s to understand the adaptive processes of natural systems and to design artificial systems software that retains the robustness of natural systems. Genetic Algorithms provide efficient and effective techniques for optimization and machine learning applications. It is widely used today in scientific, business and engineering community.
Different classes of search techniques are:
1-Calculus-based techniques
i) Direct methods
a) Fibonaci
b) Newton
ii) Indirect methods
2-Enumrative techniques
i) Dynamic programming
3-Guided random search techniques
i) Evolutionary algorithms
a) Evolutionary strategies
b) Genetic algorithms
2.2 Terminology of Genetic Algorithms
In a genetic algorithm, a population of candidate solutions (called individuals, creatures, or phenotypes) to an optimization problem is evolved toward better solutions. Each candidate solution has a set of properties (its chromosomes or genotype) which can be mutated and altered; traditionally, solutions are represented in binary as strings of 0s and 1s, but other encodings are also possible.
The evolution usually starts from a population of randomly generated individuals, and is an iterative process, with the population in each iteration called a generation. In each generation, the fitness of every individual in the population is evaluated; the fitness is usually the value of the objective function in the optimization problem being solved. The more fit individuals are stochastically selected from the current population, and each individual\’s genome is modified (recombined and possibly randomly mutated) to form a new generation. The new generation of candidate solutions is then used in the next iteration of the algorithm. Commonly, the algorithm terminates when either a maximum number of generations has been produced, or a satisfactory fitness level has been reached for the population.
A typical genetic algorithm requires:
a genetic representation of the solution domain,
a fitness function to evaluate the solution domain.
A standard representation of each candidate solution is as an array of bits [12]. Arrays of other types and structures can be used in essentially the same way. The main property that makes these genetic representations convenient is that their parts are easily aligned due to their fixed size, which facilitates simple crossover operations. Variable length representations may also be used, but crossover implementation is more complex in this case. Tree-like representations are explored in genetic programming and graph-form representations are explored in evolutionary programming; a mix of both linear chromosomes and trees is explored in gene expression programming.
Once the genetic representation and the fitness function are defined, a GA proceeds to initialize a population of solutions and then to improve it through repetitive application of the mutation, crossover, inversion and selection operators.
2.2.1 Initialization
The population size depends on the nature of the problem, but typically contains several hundreds or thousands of possible solutions. Often, the initial population is generated randomly, allowing the entire range of possible solutions (the search space). Occasionally, the solutions may be \”seeded\” in areas where optimal solutions are likely to be found.
2.2.2 Selection
During each successive generation, a proportion of the existing population is selected to breed a new generation. Individual solutions are selected through a fitness-based process, where fitter solutions (as measured by a fitness function) are typically more likely to be selected. Certain selection methods rate the fitness of each solution and preferentially select the best solutions. Other methods rate only a random sample of the population, as the former process may be very time-consuming.
The fitness function is defined over the genetic representation and measures the quality of the represented solution. The fitness function is always problem dependent. For instance, in the knapsack problem one wants to maximize the total value of objects that can be put in a knapsack of some fixed capacity. A representation of a solution might be an array of bits, where each bit represents a different object, and the value of the bit (0 or 1) represents whether or not the object is in the knapsack. Not every such representation is valid, as the size of objects may exceed the capacity of the knapsack. The fitness of the solution is the sum of values of all objects in the knapsack if the representation is valid or 0 otherwise.
2.2.3 Genetic operators
The next step is to generate a second generation population of solutions from those selected through a combination of genetic operators: crossover (also called recombination), and mutation. Population to be produced, a pair of \”parent\” solutions is selected for breeding from the pool selected previously. By producing a \”child\” solution using the above methods of crossover and mutation, a new solution is created which typically shares many of the characteristics of its \”parents\”. New parents are selected for each new child, and the process continues until a new population of solutions of appropriate size is generated. Although reproduction methods that are based on the use of two parents are more \”biology inspired\”, some research[13] suggests that more than two \”parents\” generate higher quality chromosomes.
These processes ultimately result in the next generation population of chromosomes that is different from the initial generation. Generally the average fitness will have increased by this procedure for the population, since only the best organisms from the first generation are selected for breeding, along with a small proportion of less fit solutions. These less fit solutions ensure genetic diversity within the genetic pool of the parents and therefore ensure the genetic diversity of the subsequent generation of children.
Opinion is divided over the importance of crossover versus mutation. There are many references in Fogel (2006) that support the importance of mutation-based search.
Although crossover and mutation are known as the main genetic operators, it is possible to use other operators such as regrouping, colonization-extinction, or migration in genetic algorithms[14].
It is worth tuning parameters such as the mutation probability, crossover probability and population size to find reasonable settings for the problem class being worked on. A very small mutation rate may lead to genetic drift. A recombination rate that is too high may lead to premature convergence of the genetic algorithm. A mutation rate that is too high may lead to loss of good solutions, unless elitist selection is employed.
2.2.3 Termination
This generational process is repeated until a termination condition has been reached. Common terminating conditions are:
A solution is found that satisfies minimum criteria
Fixed number of generations reached
Allocated budget (computation time/money) reached
The highest ranking solution\’s fitness is reaching or has reached a plateau such that successive iterations no longer produce better results
Manual inspection
Combinations of the above
2.3 FINITE DIFFERENCE METHOD
In finite difference method we approximate the derivatives by using their definitions as they are defined in calculus. Actually they are obtained by using Taylor series. Here we will not go into that detail, only exploit the result.
First order derivative is obtained as
(∂^2 ψ)/(∂x^2 )+2m/ℏ^2 Eψ=0 2.1
ⅆy/ⅆx=(y_(i-1)-y_(i+1))/2Δx 2.2
Second order derivative is obtained as
(ⅆ^2 y)/(ⅆx^2 )=(y_(i-1)-2y_i+y_(i+1))/〖Δx〗^2 2.3
As Schrodinger equation is an eigen value equation (Hψ=Eψ), we first try to solve in that manner using finite difference method.
-ℏ^2/2m (∂^2 ψ)/(∂x^2 )+V(x)ψ=Eψ 2.4
We will try to solve Schrodinger equation for particle in a box. For the first case V(x) is zero inside the box and infinity outside the box as shown in figure.
Figure 1: Particle in a Box Potential
So equation 3 for this case becomes
-ℏ^2/2m (∂^2 ψ)/(∂x^2 )=Eψ 2.5
After rearranging equation 4
(∂^2 ψ)/(∂x^2 )+2m/ℏ^2 Eψ=0 2.6
In equation 5 a parameter E must be known in order to solve it numerically along with boundary condition. We take E from analytical solution that is
E_n=(n^2 ℏ^2 π^2)/(2mL^2 );n=1,2,3…..
And boundary conditions are ψ(0)=ψ(L)=0 for the reason that will be clear later in chapter 03. In equation 5 m is the mass of electron ℏ is the Planck’s constant both of which are very pretty small. To get rid of the small values we will here use atomic units in which m_e and ℏ are taken to be equal to 1. Consequently, length must be measure in a_0 which is called Bohr’s radius (equal to 5.29x〖10〗^(-11)) and energy in Hartree (1 Hartree is equal to 4.36x〖10〗^(-18) Joules[15])
Equation 5 in atomic units and putting the values of E_n then becomes
(∂^2 ψ)/(∂x^2 )+n^2 π^2 ψ=0 2.7
Applying finite difference to equation 5
(ψ_(i-1)-2ψ_i+ψ_(i+1))/〖Δx〗^2 +n^2 π^2 ψ_i=0 2.8
In equation 7 I represent the node at which we have approximated the derivative. If we are considering nine points then I goes from 1 to 9. So for node 1 equation 7 after slight rearrangement becomes
-ψ_2+2ψ_1-ψ_0=n^2 π^2 ψ_i 〖Δx〗^2
But ψ(0)=ψ(L)=0 reduce above equation to
2ψ_1-ψ_2=n^2 π^2 ψ_i 〖Δx〗^2 (i)
For node 2 up to 8 equation 7 gives us following set of equations
-ψ_1+2ψ_2-ψ_3=n^2 π^2 ψ_2 〖Δx〗^2 (ii)
-ψ_2+2ψ_3-ψ_4=n^2 π^2 ψ_3 〖Δx〗^2 (iii)
-ψ_3+2ψ_4-ψ_5=n^2 π^2 ψ_4 〖Δx〗^2 (iv)
-ψ_4+2ψ_5-ψ_6=n^2 π^2 ψ_5 〖Δx〗^2 (v)
-ψ_5+2ψ_6-ψ_7=n^2 π^2 ψ_6 〖Δx〗^2 (vi)
-ψ_6+2ψ_7-ψ_8=n^2 π^2 ψ_7 〖Δx〗^2 (vii)
-ψ_7+2ψ_8-ψ_9=n^2 π^2 ψ_8 〖Δx〗^2 (viii)
At node 9 we come across again boundary condition
-ψ_8+2ψ_9-ψ_10 =n^2 π^2 ψ_9 〖Δx〗^2
After putting the boundary condition at node 10
-ψ_8+2ψ_9=n^2 π^2 ψ_9 〖Δx〗^2 (ix)
The above nine set of equation can be written in matrix form as following.
(■(2&-1&0&0&0&0&0&0@-1&2&-1&0&0&0&0&0@0&-1&2&-1&0&0&0&0@0&0&-1&2&-1&0&0&0@0&0&0&-1&2&-1&0&0@0&0&0&0&-1&2&-1&0@0&0&0&0&0&-1&2&-1@0&0&0&0&0&0&-1&2))(█(ψ_2@ψ_3@ψ_4@ψ_5@ψ_6@ψ_7@ψ_8@ψ_9 ))=n^2 〖Δx〗^2 π^2 (█(ψ_2@ψ_3@ψ_4@ψ_5@ψ_6@ψ_7@ψ_8@ψ_9 ))
Following graphs are obtained for first, second and third excited states along with graphs of probability density.
Chapter 03 Methods and Calculations
3.1 Particle in a box
Schrodinger equation involves potential energy represented by the symbol V. Particle in a box is a problem in which potential energy is infinitely large at the boundaries and zero inside some selected region and the particle is there to move with constant speed as shown in the figure 3.1. It is a prototype example used to describe some quantum effects like quantization of energy and probability density which has no classical counterparts.
Time independent Schrodingeq equation for particle in a box
-ℏ^2/2m (δ^2 ψ)/〖δx〗^2 +Vψ=Eψ 3.1
Since V is zero in the region we interested therefore
-ℏ^2/2m (δ^2 ψ)/〖δx〗^2 =Eψ 3.2
In order to get rid of the extremly small or exteremly large vales we will make use of the atomic untis in which the value of Planck’s constant, electron’mass, electric permitivity are taken to be equal to 1 by definition.
So
-1/(2〖a_0〗^2 ) (δ^2 ψ)/〖δx〗^2 =Eψ 3.3
Where a_0 is the bohr radius and is equal to one unit of length in atomic mass units. Since there is only one varaible involve so we switch from partial derivative to total dertivative. Equation (3) becomes
-1/(2〖a_0〗^2 ) (ⅆ^2 ψ)/(ⅆx^2 )=Eψ 3.4
We borrow analytical solution from literature. Boundary conditions are made from the logic that outside the box V is infinite beyond the region L and hence ψ must vanish at both the region allowing to write the boundary conditions as ψ(0)=ψ(L)=0
ψ=√(2/L) sin(nπx/L) 3.5
Here we make assumption of the unit length in atomic mass untis so L=1 meanig we have confined the particle(electron) in one Bohr distance, n is called quantum number and represent quantum state of the particle. Allowed values of n are 1,2,3,……… Here 0 is not allowed as quantum number since otherwise ψ will vanish inside the box. So equation (5) becomes as following
ψ=√2 sin(nπx) 3.6
In equation (6) distance must be measured in multiple of bohr’s radius.
Probabilty density is defind as probability of finding the particle par unit distande such that 〖(ψ(x))〗^2 dx reperesents probablity of finding the particle in a region dx. Since the particle can not go beyond the region L so particle must exist in that region. Hence normalization condition is that ∫_0^L▒〖〖(ψ(x))〗^2 ⅆx〗=1. The equation (5) is the normalized solution of the particle in a box problem and the factor √(2/L) is the normalization constant.
In analytical method the expression for energy is
E=(n^2 π^2 ℏ^2)/(2mL^2 ) Joules in SI units
Here quantum number n appears as well meaning energy E is quantized. This result is in complete contrast to classical mechanics which allows particle to have any energy. Putting our our values for L , ℏ^2and m we have the following equation
E=(n^2 π^2)/2 Hartree in atomic mass units
Where 1 Hartree is equal to 4.36x〖10〗^(-18) Joules[15].
The first few wave function and probability density plots are shown in the following figures.
Figure 3: First three wave function plot of particle in a box
Figure 4: First three density plots of particle in a box
3.2 By Genetic Algorithms
In Genetic Algorithms based methodology we formulate our fitness function by exploiting finite difference techeque. So by making approximations of the derivatives we rewrite equation (4) as following please
-(ψ_(i-1)-2ψ_i+ψ_(i+1))/(2〖a_0〗^2△x^2 )=Eψ 3.7
Rearranging equation (7), we obtain the following equation
ψ_(i-1)-2ψ_i+ψ_(i+1)+Eψ△x^2 2〖a_0〗^2=0 3.8
In the above equation E is the total energy. In numerical techniqes as is the case here(since Genetic Algorithms is numerically optimize techniques) we must provide all the parameters of the problem being in hand. So, we borrow energy from analytical ones and boundary condtions as well.
Final expression after putting energy
ψ_(i-1)-2ψ_i+ψ_(i+1)+n^2 π^2 ψ△x^2=0 3.9
In above equation (9), the parameter n will dictate which states we are searching for such that n=0 is the ground state, n=1 is the first excited states and so on.
Figure 5: Discretization of length for particle in a box
In figure 3.04 we discritize length axis so that we can apply finite difference technique for fitness function. Considring the first nine point, we apply the formerlly mentioned technique to each point.
So for point 1, equation (9) becomes
ψ_0-2ψ_1+ψ_2+1^2 π^2 ψ_1 〖0.1〗^2=0 3.10
If we are using nine points that implies that △x is 0.1. we, here, are interested in the ground state hence 1 for n. ψ_0 lies at the boundary so we will use boundary point over there. Equation 10 then becomes
-2ψ_1+ψ_2+1^2 π^2 ψ〖0.1〗^2=0 3.11
Aplying to point 2 equation (9) becomes
ψ_1-2ψ_2+ψ_2+1^2 π^2 ψ_2 〖0.1〗^2=0 3.12
Proceeding in the same manner upto point 8….
ψ_2-2ψ_3+ψ_4+1^2 π^2 ψ_3 〖0.1〗^2=0 3.13
ψ_3-2ψ_4+ψ_5+1^2 π^2 ψ_4 〖0.1〗^2=0 3.14
ψ_4-2ψ_5+ψ_6+1^2 π^2 ψ_5 〖0.1〗^2=0 3.15
ψ_5-2ψ_6+ψ_7+1^2 π^2 ψ_6 〖0.1〗^2=0 3.16
ψ_6-2ψ_7+ψ_8+1^2 π^2 ψ_7 〖0.1〗^2=0 3.17
ψ_7-2ψ_8+ψ_9+1^2 π^2 ψ_8 〖0.1〗^2=0 3.18
ψ_8-2ψ_9+ψ_10+1^2 π^2 ψ_9 〖0.1〗^2=0 3.19
In equation 19 , ψ_10 appears which again lies at the boundary we put its value which is zero. Equation 19 then becomes
ψ_8-2ψ_9+1^2 π^2 ψ_9 〖0.1〗^2=0 3.20
Now we take the absolute of each above discretized equations for the reason mention earlier in chapter no 02 in order to proceed to our fitness function and add all of them and name the added sum C.
So
C=abs(-2ψ_2+ψ_3+1^2 π^2 ψ_1 〖0.1〗^2
+ψ_1-2ψ_2+ψ_2+1^2 π^2 ψ_2 〖0.1〗^2
+ψ_2-2ψ_3+ψ_4+1^2 π^2 ψ_3 〖0.1〗^2
+ψ_3-2ψ_4+ψ_5+1^2 π^2 ψ_4 〖0.1〗^2
+ψ_4-2ψ_5+ψ_6+1^2 π^2 ψ_5 〖0.1〗^2
+ψ_5-2ψ_6+ψ_7+1^2 π^2 ψ_6 〖0.1〗^2
+ψ_6-2ψ_7+ψ_8+1^2 π^2 ψ_7 〖0.1〗^2
+ψ_7-2ψ_8+ψ_9+1^2 π^2 ψ_8 〖0.1〗^2
+ψ_8-2ψ_9+1^2 π^2 ψ_9 〖0.1〗^2 )= 0 3.21
Hence we have obtained our desired fitness function which we have to give to matlab genetic algorithm toolbox along with modified option. Matlab GA toolbox accepts fitness function as “M file”. So matlab “M file” for the above fitness function will be
Matlab M-file 01
function z=GrandC(X)
n=9;
L=1;
deltax=L/(n+1)
m=1;
E=pi^2*m^2/L^2;
C(1)=abs(-2*X(1)+X(2)+E*deltax^2*X(1));
for i=2:n-1
C(i)=abs(X(i-1)-2*X(i)+X(i+1)+E*deltax^2*X(i));
end
C(n)=abs(X(n-1)-2*X(n)+E*deltax^2*X(n));
z=0;
for i=1:n
z=z+C(i);
end
end
3.3 Harmonic Oscillator
In harmonic oscillator the potential energy V varies as the square of the distance between the particle and equilibrium that is 1/2 kx^2. It is the most important potential in physics in a way that any restoring force which gives rise to potential energy V can be expressed as a sum of Maclaurin’s series. If vibrations are small, the potential energy can be very pretty approximated as that of harmonic oscillator. This important point is proved in following.
Let any restoring force F which is a function of x is expressed in Maclaurin’s series in terms of x.
F(x)=F(0)+ⅆF/ⅆx (0) x+1/2 (ⅆ^2 F)/(ⅆx^2 ) (0) 〖 x〗^2+1/6 (ⅆ^3 F)/(ⅆx^3 ) (0) 〖 x〗^3… 3.22
Where x=0 is the equilibrium position. For small vibrations x^2 and higher order becomes smaller and smaller and so negligible. Equation 21 then becomes
F(x)=ⅆF/ⅆx (0) x 3.23
As V= V=-∫_0^x▒〖F(x)ⅆx〗
So equation 22 becomes
V=-∫_0^x▒(ⅆF/ⅆx (0)x)ⅆx 3.24
V= -ⅆF/ⅆx (0) x^2/2 3.25
In equation 24 ⅆF/ⅆx (0) is by definition should be negative (it is restoring force) and the whole thing becomes positive as a result. So -ⅆF/ⅆx(0) must be a positive constant and equal to k, the spring constant of the force. Equation 24 becomes then
V=k x^2/2 3.26
Figure below show the graph of potential energy and a classical physical realization of harmonic oscillator. Quantum realization may be a molecule of HCl in which vibration of Hydrogen atom oscillates under the influence of columbic force harmonically.
Figure 6: Harmonic oscillator potential
Schrodinger equation for above harmonic oscillator potential then becomes as following please
-ℏ^2/2m (δ^2 ψ)/〖δx〗^2 +k x^2/2 ψ=Eψ 3.27
Since again equation 26 contains only one independent variable x so we switch from partial derivative to total derivative.
-ℏ^2/2m (ⅆ^2 ψ)/(ⅆx^2 )+k x^2/2 ψ=Eψ 3.28
Using atomic units again as we did for particle in a box problem that is ℏ and m_eare set equal to one works well but here we will use another set of units that is more inherent for harmonic oscillator.
We set ℏ^2/m and k equal to zero. Equation 27 then becomes
-1/2 (ⅆ^2 ψ)/(ⅆx^2 )+x^2/2 ψ=Eψ 3.29
To see what these new choice of units leads us we note the following〖 combination〗^[16]
√(ℏ/mw)=((ℏ⁄m)/(mw^2 ))^(1⁄4)=1
The above arrangement has units of distance. And the combination
ℏw=(ℏ^2⁄m)(mw^2 )=1
has units of energy. Consequently all the distances should be measure in multiples of the above units. The relation between k ,m and w is w=√(k/m) .
Rearranging equation 28
(ⅆ^2 ψ)/(ⅆx^2 )+2(E-x^2/2)ψ=0 3.30
Applying finite difference to equation 29 and considering nine points for prototype we get the following set of equations
(ψ_0-2ψ_1+ψ_2)/〖Δx〗^2 +2(E-〖x_1〗^2/2) ψ_1=0 (i)
(ψ_1-2ψ_2+ψ_3)/〖Δx〗^2 +2(E-〖x_2〗^2/2) ψ_2=0 (ii)
(ψ_2-2ψ_3+ψ_4)/〖Δx〗^2 +2(E-〖x_3〗^2/2) ψ_3=0 (iii)
(ψ_3-2ψ_4+ψ_5)/〖Δx〗^2 +2(E-〖x_4〗^2/2) ψ_4=0 (iv)
(ψ_4-2ψ_5+ψ_6)/〖Δx〗^2 +2(E-〖x_5〗^2/2) ψ_5=0 (v)
(ψ_5-2ψ_6+ψ_7)/〖Δx〗^2 +2(E-〖x_6〗^2/2) ψ_6=0 (vi)
(ψ_6-2ψ_7+ψ_8)/〖Δx〗^2 +2(E-〖x_7〗^2/2) ψ_7=0 (vii)
(ψ_7-2ψ_8+ψ_9)/〖Δx〗^2 +2(E-〖x_8〗^2/2) ψ_8=0 (viii)
(ψ_8-2ψ_9+ψ_10)/〖Δx〗^2 +2(E-〖x_9〗^2/2) ψ_9=0 (ix)
In the above nine equation set, ψ_0 and〖 ψ〗_10 is the boundary condition which we will have to provide as these are numerically techniques. Boundary conditions are that wave functions should become negligible after 10L at each boundary.
Taking absolute of the above nine set of equations and adding them as we did before we get Cost Function for harmonic oscillator. So
C=Abs((ψ_0-2ψ_1+ψ_2)/〖Δx〗^2 +2(E-〖x_1〗^2/2)ψ_1
+(ψ_1-2ψ_2+ψ_3)/〖Δx〗^2 +2(E-〖x_2〗^2/2) ψ_2
+(ψ_2-2ψ_3+ψ_4)/〖Δx〗^2 +2(E-〖x_3〗^2/2) ψ_3
+(ψ_3-2ψ_4+ψ_5)/〖Δx〗^2 +2(E-〖x_4〗^2/2) ψ_4
+(ψ_4-2ψ_5+ψ_6)/〖Δx〗^2 +2(E-〖x_5〗^2/2) ψ_5
+(ψ_5-2ψ_6+ψ_7)/〖Δx〗^2 +2(E-〖x_6〗^2/2) ψ_6
+(ψ_6-2ψ_7+ψ_8)/〖Δx〗^2 +2(E-〖x_7〗^2/2) ψ_7
+(ψ_6-2ψ_7+ψ_8)/〖Δx〗^2 +2(E-〖x_7〗^2/2) ψ_7
+(ψ_8-2ψ_9+ψ_10)/〖Δx〗^2 +2(E-〖x_9〗^2/2)ψ_9)=0 3.31
3.4 SEPARATION OF VARAIBLES
This technique is the first attack of physicists on any partial differential equation to solve. In this technique the basic assumption is that the solution we search for may be split into the corresponding number of factor solutions such that each factor solution depends on only single variable. The number of factor solutions is determined by the independent variables the partial differential equations depend on. Later on, as we will see, some basic mathematical logics are applied to convert partial differential equation into ordinary differential equations.
In hydrogen atom the electron feels potential due to columbic force between electron and proton and is given by
V=-Ze^2/(4〖πϵ〗_0 r) 3.32
Schrodinger equation for the above potential becomes
(δ^2 ψ)/〖δx〗^2 +(δ^2 ψ)/〖δy〗^2 +(δ^2 ψ)/〖δz〗^2 +2m/ℏ^2 (E+Ze^2/(4〖πϵ〗_0 r(x,y,z) ))=0 3.33
In equation 31 potential depends upon r, so it will be natural to use spherical coordinates. In spherical coordinates equation[17] 31 reduces to
1/r^2 δR/δr (r^2 δψ/δr)+1/(r^2 sin(θ) ) δ/δθ (sin(θ) δψ/δθ)+1/(r^2 sin^2 (θ) ) (δ^2 ψ)/〖δ∅〗^2 +2m/ℏ^2 (E +Ze^2/(4〖πϵ〗_0 r(x,y,z) ))=0 3.34
Multiplying equation 32 by r^2 sin^2 (θ), we get following expression
sin^2 (θ) δR/δr (r^2 δψ/δr)+sin(θ) δ/δθ (sin(θ) δψ/δθ)+(δ^2 ψ)/〖δ∅〗^2 +r^2 sin^2 (θ) 2m/ℏ^2 (E+Ze^2/(4〖πϵ〗_0 r(x,y,z) ))=0 3.35
At this point we assume that ψ can be written as a product of three function R(r), T(θ) and P(∅) each depending on a single variable. This is an advantage of writing Schrodinger equation in spherical coordinates. Then the respective derivatives shall be calculated as
As ψ= R(r) T(θ) P(∅)
δψ/δr=PT δR/δr=PT ⅆR/ⅆr
δψ/δθ=PR δT/δθ=PR ⅆT/ⅆθ
(δ^2 ψ)/〖δ∅〗^2 =TR δP/〖δ∅〗^2 =TR ⅆP/(ⅆ∅^2 )
Putting the ψ above and their respective derivatives in equation 33 we get the following equation
PTsin^2 (θ) ⅆ/ⅆr (r^2 ⅆR/ⅆr)+PRsin(θ) ⅆ/ⅆθ (sin(θ) ⅆT/ⅆθ)+TR (ⅆ^2 P)/(ⅆ∅^2 )+r^2 sin^2 (θ) 2m/ℏ^2 (E+Ze^2/(4〖πϵ〗_0 r))PRT=0 3.36
Dividing equation 34 throughout by PTR
(sin^2 (θ))/R ⅆ/ⅆr (r^2 ⅆR/ⅆr)+sin(θ)/T ⅆ/ⅆθ (sin(θ) ⅆT/ⅆθ)+1/P (ⅆ^2 P)/(ⅆ∅^2 )+r^2 sin^2 (θ) 2m/ℏ^2 (E+Ze^2/(4〖πϵ〗_0 r))=0 3.37
Taking the third term to the other side of the equation
(sin^2 (θ))/R ⅆ/ⅆr (r^2 ⅆR/ⅆr)+sin(θ)/T ⅆ/ⅆθ (sin(θ) ⅆT/ⅆθ)+r^2 sin^2 (θ) 2m/ℏ^2 (E+Ze^2/(4〖πϵ〗_0 r))=-1/P (ⅆ^2 P)/(ⅆ∅^2 ) 3.38
Equation 36 is only valid if and if both sides are equal to the same constant since they depends on different variable. We call this constant 〖m_l〗^2 [17]. So equation 36 reduces to
(sin^2 (θ))/R ⅆ/ⅆr (r^2 ⅆR/ⅆr)+sin(θ)/T ⅆ/ⅆθ (sin(θ) ⅆT/ⅆθ)+ r^2 sin^2 (θ) 2m/ℏ^2 (E+Ze^2/(4〖πϵ〗_0 r)) =〖m_l〗^(2 ) 3.39
With
-1/P (ⅆ^2 P)/(ⅆ∅^2 )=〖m_l〗^2 3.40
After rearranging equation 37 we get the final expression
1/R ⅆ/ⅆr (r^2 ⅆR/ⅆr)+(2mr^2)/ℏ^2 (E+Ze^2/(4〖πϵ〗_0 r))=〖m_l〗^2/(sin^2 (θ) )-ⅆ/Tsin(θ)ⅆθ (sin(θ) ⅆT/ⅆθ) 3.41
Equation 39 is again of the type of equation 36 that is both sides depends on different variables which can be true[18] if and only if both sides are equal to the same constant. This time we name the constant l(l+1)[17]. Equation 39 then split into the following two equations
〖m_l〗^2/(sin^2 (θ) )-ⅆ/Tsin(θ)ⅆθ (sin(θ) ⅆT/ⅆθ)=l(l+1) 3.42
1/R ⅆ/ⅆr (r^2 ⅆR/ⅆr)+(2mr^2)/ℏ^2 (E+Ze^2/(4〖πϵ〗_0 r))=l(l+1) 3.43
Equation 41 is called the radial part of the Hydrogen atom. We will try to find the solution of this equation for the reason of typical problem in quantum mechanics.
3.5 Hydrogen Atom
Rearranging and taking first term derivative of equation 41
(ⅆ^2 R)/(ⅆr^2 )+2/r ⅆR/ⅆr+[2m/ℏ^2 (E+Ze^2/(4〖πϵ〗_0 r))-l(l+1)/r^2 ]R=0 3.44
As we know that
E_0=ℏ^2/(2ma_0^2 ) 〖,E〗_n=(-E_0)/n^2
Where
a_0=(4〖πϵ〗_0 ℏ^2)/me^2
Equation 42 after putting the expression for energy becomes
(ⅆ^2 R)/(ⅆr^2 )+2/r ⅆR/ⅆr+[-2m/ℏ^2 ℏ^2/(2mn^2 a_0^2 )+2m/ℏ^2 Ze^2/(4〖πϵ〗_0 r)-l(l+1)/r^2 ]R=0 3.45
(ⅆ^2 R)/(ⅆr^2 )+2/r ⅆR/ⅆr+[(-1)/(a_0^2 n^2 )+2/(a_0 r)-l(l+1)/r^2 ]R=0 3.46
(ⅆ^2 R)/(ⅆr^2 )+2/r ⅆR/ⅆr+[2/(a_0 r)-1/(a_0^2 n^2 )-l(l+1)/r^2 ]R=0 3.47
In order to find the boundary condition for this case, we assume the following expression
Q=rR⟹R=Q/r
Advantage of this change guarantee us to take the boundary condition at origin to be zero as Q is concerned here. The boundary condition we will fix at the far end from nucleus such that Q must be negligibly small. Other advantage of Q is that the radial probability density as defined as P(x)=R^2 (r)r^2.
To convert from R variable to Q variable we proceed as
ⅆR/ⅆr=1/r ⅆQ/ⅆr+Q ⅆ/dr (1/r)
ⅆR/ⅆr=1/r ⅆQ/ⅆr+Q(-1/r^2 )
ⅆR/ⅆr=1/r ⅆQ/ⅆr-Q(1/r^2 ) (i)
(ⅆ^2 R)/(ⅆr^2 )=1/r (ⅆ^2 Q)/(ⅆr^2 )+ⅆQ/ⅆr ⅆ/ⅆr (1/r)-1/r^2 ⅆQ/ⅆr-Q ⅆ/ⅆr (1/r^2 )
(ⅆ^2 R)/(ⅆr^2 )=1/r (ⅆ^2 Q)/(ⅆr^2 )+(-1/r^2 ) ⅆQ/ⅆr-1/r^2 ⅆQ/ⅆr+Q(2/r^3 )
(ⅆ^2 R)/(ⅆr^2 )=1/r (ⅆ^2 Q)/(ⅆr^2 )-2 1/r^2 ⅆQ/ⅆr+Q(2/r^3 ) (ii)
Putting (i) and (ii) in equation 45
1/r (ⅆ^2 Q)/(ⅆr^2 )-2 1/r^2 ⅆQ/ⅆr+Q(2/r^3 )+2/r [1/r ⅆQ/ⅆr-Q(1/r^2 )]
+[2/(a_0 r)-1/(a_0^2 n^2 )-l(l+1)/r^2 ] Q/r=0 3.47
After rearranging equation 46
1/r (ⅆ^2 Q)/(ⅆr^2 )-2 1/r^2 ⅆQ/ⅆr+Q(2/r^3 )+2 1/r^2 ⅆQ/ⅆr-Q(2/r^3 )
+(2/(a_0 r)-1/(a_0^2 n^2 )-l(l+1)/r^2 ) Q/r=0 3.48
After cancelling the terms
1/r (ⅆ^2 Q)/(ⅆr^2 )+(2/(a_0 r)-1/(a_0^2 n^2 )-l(l+1)/r^2 ) Q/r=0 3.49
After cancelling r
(ⅆ^2 Q)/(ⅆr^2 )+(2/(a_0 r)-1/(a_0^2 n^2 )-l(l+1)/r^2 )Q=0 3.50
In order to get rid of the very small value a_0, we make the following substitution. Since we are interested in length interval from 0 to 1 in some units. To find that units let our ‘r’ length varies from 0 to ma_0.
Let x=r/(ma_0 )
For first order derivative
ⅆQ/ⅆr=ⅆQ/ⅆx ⅆx/ⅆr
ⅆQ/ⅆx=ⅆQ/ⅆx (1/(ma_0 ))
ⅆQ/ⅆr=(1/(ma_0 )) ⅆQ/ⅆx (i)
For second order derivative
(ⅆ^2 Q)/(ⅆr^2 )=ⅆ/ⅆr (ⅆQ/ⅆr ⅆx/ⅆx ⅆx/ⅆx)
=ⅆ/ⅆx (ⅆQ/ⅆx) ⅆx/ⅆr ⅆx/ⅆr
=ⅆ/ⅆx (ⅆQ/ⅆx) ⅆx/ⅆr ⅆx/ⅆr
=(ⅆ^2 Q)/(ⅆx^2 ) 1/(ma_0 ) 1/(ma_0 )
=(ⅆ^2 Q)/(ⅆx^2 ) (1/(ma_0 ))^2
=(1/(ma_0 ))^2 (ⅆ^2 Q)/(ⅆx^2 ) (ii)
So putting (ii) in equation 49
(1/(ma_0 ))^2 (ⅆ^2 Q)/(ⅆx^2 )+(2/((a_0 ma_0 x) )-1/(a_0^2 n^2 )-l(l+1)/(ma_0 x)^2 )Q=0
(1/(ma_0 ))^2 (ⅆ^2 Q)/(ⅆx^2 )+(2/((a_0^2 mx) )-1/(a_0 n)^2 -l(l+1)/(ma_0 x)^2 )Q=0
(1/m)^2 (ⅆ^2 Q)/(ⅆx^2 )+(2/((mx) )-1/(n)^2 -l(l+1)/(mx)^2 )Q=0
(ⅆ^2 Q)/(ⅆx^2 )+(2m/x-m^2/(n)^2 -l(l+1)/x^2 )Q=0 3.51
Applying finite difference to equation 50
(Q_(i-1)-2Q_i+Q_(i+1))/〖Δx〗^2 +(2m/x_i -m^2/(n)^2 -l(l+1)/〖x_i〗^2 ) Q_i=0 3.52
Since our length interval is now from 0 to 1 that is xϵ[0,1], we make again nine nodes of our unit length. Starting from node 1 up to nine we have
(Q_0-2Q_1+Q_2)/〖Δx〗^2 +(2m/x_1 -m^2/(n)^2 -l(l+1)/〖x_1〗^2 ) Q_1=0 (i)
(Q_1-2Q_2+Q_3)/〖Δx〗^2 +(2m/x_2 -m^2/(n)^2 -l(l+1)/〖x_2〗^2 ) Q_2=0 (II)
(Q_2-2Q_3+Q_4)/〖Δx〗^2 +(2m/x_3 -m^2/(n)^2 -l(l+1)/〖x_3〗^2 ) Q_3=0 (iii)
(Q_3-2Q_4+Q_5)/〖Δx〗^2 +(2m/x_4 -m^2/(n)^2 -l(l+1)/〖x_4〗^2 ) Q_4=0 (iv)
(Q_4-2Q_5+Q_6)/〖Δx〗^2 +(2m/x_5 -m^2/(n)^2 -l(l+1)/〖x_5〗^2 ) Q_5=0 (v)
(Q_5-2Q_6+Q_7)/〖Δx〗^2 +(2m/x_6 -m^2/(n)^2 -l(l+1)/〖x_6〗^2 ) Q_6=0 (vi)
(Q_6-2Q_7+Q_8)/〖Δx〗^2 +(2m/x_7 -m^2/(n)^2 -l(l+1)/〖x_7〗^2 ) Q_7=0 (vii)
(Q_7-2Q_8+Q_9)/〖Δx〗^2 +(2m/x_8 -m^2/(n)^2 -l(l+1)/〖x_8〗^2 ) Q_8=0 (viii)
(Q_8-2Q_9+Q_10)/〖Δx〗^2 +(2m/x_9 -m^2/(n)^2 -l(l+1)/〖x_9〗^2 ) Q_9=0 (ix)
Taking the absolute of the above nine equation and adding them, we get our cost function as
C=abs((Q_0-2Q_1+Q_2)/〖Δx〗^2 +(2m/x_1 -m^2/(n)^2 -l(l+1)/〖x_1〗^2 )Q_1
+(Q_1-2Q_2+Q_3)/〖Δx〗^2 +(2m/x_2 -m^2/(n)^2 -l(l+1)/〖x_2〗^2 ) Q_2
+(Q_2-2Q_3+Q_4)/〖Δx〗^2 +(2m/x_3 -m^2/(n)^2 -l(l+1)/〖x_3〗^2 ) Q_3
+(Q_3-2Q_4+Q_5)/〖Δx〗^2 +(2m/x_4 -m^2/(n)^2 -l(l+1)/〖x_4〗^2 ) Q_4
+(Q_4-2Q_5+Q_6)/〖Δx〗^2 +(2m/x_5 -m^2/(n)^2 -l(l+1)/〖x_5〗^2 ) Q_5
+(Q_5-2Q_6+Q_7)/〖Δx〗^2 +(2m/x_6 -m^2/(n)^2 -l(l+1)/〖x_6〗^2 ) Q_6
+(Q_6-2Q_7+Q_8)/〖Δx〗^2 +(2m/x_7 -m^2/(n)^2 -l(l+1)/〖x_7〗^2 ) Q_7
+(Q_7-2Q_8+Q_9)/〖Δx〗^2 +(2m/x_8 -m^2/(n)^2 -l(l+1)/〖x_8〗^2 ) Q_8
+(Q_8-2Q_9+Q_10)/〖Δx〗^2 +(2m/x_9 -m^2/(n)^2 -l(l+1)/〖x_9〗^2 )Q_9)=0 3.53
In all above cases, C is the fitness which we have to optimize using matlab toolbox. Why we take the abs of the equations? Let us find the solution of simple equation f(x)= x-2=0 by genetic algorithm. Its graph is following
Figure 7: Graph of f(x)= x-2
Since genetic algorithm finds only the minimum point so we must take absolute of f(x) to convert it as optimizing problem, the graph then becomes
Figure 8: Graph of f(x)=x-2 after taking absolute
Now its minimum point lies at the solution points.
Chapter 04 Result and Discussion
4.1 Particle in a Box
For “particle in a box” and harmonic oscillator nine and eleven points are used for wave function calculations. Ground and first excited states have been studied.
4.1.1 Ground State
In ground state, system has lowest possible energy. In quantum mechanics it is called zero point energy.
For 9 points
Nine points are the internal nodes at which solution points has been calculated. In the table below serial number 1 and 11 are the boundary the boundary points.
Table 1: Analytical and GA points along with absolute error and percentage error
S. No. X Anay. Pts GA Pts. Diff. Error % Err.
1 0 0 0 0 Nil Nil
2 0.1 0.437 0.438 1.00E-03 0.0023 0.2364
3 0.2 0.8313 0.8328 1.50E-03 0.0018 0.1838
4 0.3 1.1441 1.1454 1.20E-03 0.0011 0.1186
5 0.4 1.345 1.3449 1.00E-04 0.0001 0.0017
6 0.5 1.4142 1.412 2.20E-03 0.0015 0.1536
7 0.6 1.345 1.3439 1.10E-03 0.0008 0.0801
8 0.7 1.1441 1.1445 4.00E-04 0.0004 0.0451
9 0.8 0.8313 0.8322 9.00E-04 0.0011 0.1102
10 0.9 0.437 0.4377 7.00E-04 0.0015 0.1528
11 1 0 0 0 Nil Nil
Graph of analytical and GA produced points that is column 3 and column 2 versus column 2 is following.
Figure 9: GA and analytical points plotted together
Figure 10 is the last graph of best fitness, mean fitness and best solution vector after algorithm has run.
Figure 10: Graphs of best fitness value, mean fitness value and the best individual in the last generation
The above results are for nine points only. Eleven points results are given in the following table and graphs..
For 11 points
Table 2 is for ground state and for eleven internal nodes. The first and last node points are the boundary points.
Table 2: GA produced and analytical points along with absolute and percentage error
S. No. X Anal. Pts. GA Pts. Diff. Error % Error
1 0 0 0 0 Nil Nil
2 0.0833 0.366 0.3673 1.30E-03 3.60E-03 0.3582
3 0.1667 0.7071 0.7095 2.40E-03 3.40E-03 0.3379
4 0.25 1 1.003 3.00E-03 3.00E-03 0.3028
5 0.3333 1.2247 1.2278 3.1E-3 2.50E-03 0.2504
6 0.4167 1.366 1.3684 2.40E-03 1.80E-03 0.1769
7 0.5 1.4142 1.4153 1.10E-03 8.00E-03 0.0754
8 0.5833 1.366 1.3651 9.00E-04 7.00E-03 0.0665
9 0.6667 1.2247 1.2214 3.40E-03 2.70E-03 0.2739
10 0.75 1 0.9947 5.30E-03 5.30E-03 0.5327
11 0.8333 0.7071 0.7036 3.50E-03 5.00E-03 0.4979
12 0.9167 0.366 0.3643 1.70E-03 4.80E-03 0.4778
13 1 0 0 0 Nil Nil
In table 2 column 2 and column 3 are solution points and plotted in figure 11 together.
Figure 11: GA and analytical points plotted together
Figure 12 is the GA graph at the last generation of the ground state of particle in a box
Figure 12: GA plot of best fitness, mean fitness and best individual in at the stop generation
4.1.2 First Excited State
In excited state system has non zero energy and has some gain energy. Parameter n in energy expression for particle in a box dictate the states i.e. n=1 ground state and higher than 1 are excited state.
For 9 points
Nine points are the internal nodes whereas first node and last node points are the boundary point.
Table 3: GAs produced and analytical points
S. No. x Anal. Pts. GA Pts. Diff. Error % Diff.
1 0 0 0 0 Nil Nil
2 0.1 0.83132 0.83134 2E-05 2.40581E-05 0.002406
3 0.2 1.345123 1.3451124 1.06E-05 7.88032E-06 0.000788
4 0.3 1.34557 1.34556 1E-05 7.43179E-06 0.000743
5 0.4 0.831356 0.831355 1E-06 1.20285E-06 0.00012
6 0.5 0 -0.0000001 1E-07 Nil Nil
7 0.6 -0.83139 -0.831389 1E-06 -1.2028E-06 -0.00012
8 0.7 -1.31273 -1.31274 1.1E-05 -8.3795E-06 -0.00084
9 0.8 -1.33332 -1.333325 1E-06 -7.5001E-07 -7.5E-05
10 0.9 -0.83137 -0.83138 1E-05 -1.2028E-05 -0.0012
11 1 0 0 0 Nil Nil
Graph of column 2 and column 3 verses column 1 are plotted in figure 13
Figure 13: Normalized GAs produced and analytical points plotted together
Figure 14 is the GA graph at the last generation which shows the best fitness, mean fitness and best solution vector.
Figure 14: GAs produced plot of best fitness, mean fitness and best individual in last generation
For 11 points
Eleven are the internal nodes at which solution points has been found
Table 4: GA produced and analytical points along with absoulue error and percentage error for first excited state of particle in a box
S.No. x Anal. Pts. GA Pts. Diff. Error % Error
1 0 0 0 0 Nil
2 0.0833 0.707112 0.70711 2E-06 2.82841E-06 2.80E-04
3 0.1667 1.224714 1.2247141 1E-07 8.16517E-08 8.165E-06
4 0.25 1.4142122 1.4142123 1E-07 7.07107E-08 7.071E-06
5 0.3333 1.224745 1.224744 1E-06 8.16496E-07 8.165E-05
6 0.4167 0.7071002 0.7071001 1E-07 1.41423E-07 1.414E-05
7 0.5 0 -2E-09 2.00E-09 Nil Nil
8 0.5833 -0.7071565 -0.7071567 2E-07 -2.8282E-07 -2.83E-05
9 0.6667 -1.2247654 -1.2247657 3E-07 -2.4494E-07 -2.45E-05
10 0.75 -1.4142985 -1.4142987 2E-07 -1.4141E-07 -1.41E-05
11 0.8333 -1.2247564 -1.22475643 3E-08 -2.4495E-08 -2.45E-06
12 0.9167 -0.727123 -0.7271234 4E-07 -5.5011E-07 -5.5E-05
13 1 0 0 0 Nil Nil
Figure 15 is graph of column 3 and column 4 verses column 2 in table 4.
Figure 15: GA and analytical points plotted together for 11 nodes
Figure 16 is the GA produced plot of best fitness, mean fitness and best solution vector in the last generation
Figure 16: GA produced graphs of best fitness, mean fitness and best individual (solution) in the last generation
4.2 Harmonic Ocillator
In harmonic oscillator boundary values are taken to be zero at the large x since here x is in multiple of ℏw so its value may be taken at boundary points.
4.2.1Ground State
For 9 points
Nine points are the internal node points at which solution has been tried to found.
Table 5: GA produced and analytical points with absolute and percentage error for ground state of harmonic oscillator
Essay: Schrodinger equation
Essay details and download:
- Subject area(s): Science essays
- Reading time: 21 minutes
- Price: Free download
- Published: 16 August 2019*
- Last Modified: 2 September 2024
- File format: Text
- Words: 6,112 (approx)
- Number of pages: 25 (approx)
Text preview of this essay:
This page of the essay has 6,112 words.
About this essay:
If you use part of this page in your own work, you need to provide a citation, as follows:
Essay Sauce, Schrodinger equation. Available from:<https://www.essaysauce.com/science-essays/schrodinger-equation/> [Accessed 20-11-24].
These Science essays have been submitted to us by students in order to help you with your studies.
* This essay may have been previously published on EssaySauce.com and/or Essay.uk.com at an earlier date than indicated.