SlideShare a Scribd company logo
1 of 9
Chapter 2
Convergence




The usage of computational electromagnetics in engineering and science more or
less always originates from a physical situation that features a particular problem.
Here, some examples of such situations could be to determine the radiation pattern
of an antenna, the transfer function of a frequency selective surface, the scattering
from small particles or the influence of a cell phone on its user. The physical problem
is then described as a mathematical problem that involves Maxwell’s equations. In a
very limited number of cases, the mathematical problem can be solved analytically
such that we have an exact solution in closed form. If there exists a solution
to the problem that can not be calculated analytically, we can approximate the
mathematical problem and pursue an approximate solution. In the context of CEM,
such an approximate solution is often referred to as a numerical solution, since it
typically involves extensive numerical computations in combination with relatively
simple analytical expressions. These simple analytical expressions are normally
applied to small subdomains of the original problem-domain, where the subdomain
solutions are related to each other such that they collectively correspond to the
solution to the original problem. The difference between an approximate solution
and the exact solution is referred to as the error. It is desirable that the error can be
reduced to an arbitrary low level such that the approximate solution converge to the
exact solution, i.e. the accuracy of the numerical solution improves.
    Thus, one must keep in mind that numerical tools never give the exact answer.
The accuracy of the numerical result depends on the so-called resolution. Resolution
may mean the number of grid points per wavelength in microwave problems, or how
well the geometry of an electrical motor is represented by a finite element mesh.
If the method works correctly, the computed answer will converge to the exact result
as the resolution increases. However, with finite resolution, the error is nonzero, and
one must estimate it to ensure that its magnitude is acceptable. This is particularly
true for large systems, where it may be hard to resolve details of the geometry or to
afford a sufficient number of points per wavelength. Examples of this state of affairs
are found in 3D-modeling of electrical motors and generators, large array antennas,
and computation of the radar cross sections of aircrafts.

T. Rylander et al., Computational Electromagnetics, Texts in Applied                  11
Mathematics 51, DOI 10.1007/978-1-4614-5351-2 2,
© Springer Science+Business Media New York 2013
12                                                                                                          2 Convergence


   Applied mathematicians have derived a posteriori error estimates, which can be
evaluated after an approximate numerical solution has been computed. However,
such error estimates are only beginning to be established for Maxwell’s equations,
and discussion of these would take us far beyond an introductory course. For further
information on this topic, see, e.g., [48, 69]. Nevertheless, error estimates are useful
because they can be exploited for adaptive mesh refinement in regions that give
large contributions to the error. A simpler method to estimate the error of a given
computation is to do a convergence test by increasing the resolution uniformly,
finding out the order of convergence, and then extrapolating the computed results to
infinite resolution. That is the approach we will follow.
   In general, one does not know the order of convergence of a computational
method for a given problem a priori. Even though standard centered finite differ-
ences or linear finite elements converge with an error of order h2 (where h is the
grid spacing or the cell size) for regular problems, singular behavior of the solution
decreases the order of convergence in most application problems. Singularities
are introduced by sharp edges and tips of objects such as metallic conductors,
dielectrics, and magnetic materials.



2.1 Extrapolation to Zero Cell Size

We will use a very simple problem, namely to calculate the electrostatic potential on
the symmetry axis of a uniformly charged square, to illustrate how computed results
can be extrapolated to zero cell size. The square is the region a < x < a; a <
y < a; z D 0, the surface charge density s .x; y/ D s0 is constant, and we seek
the potential at two points on the symmetry axis: .0; 0; a/ and .0; 0; 0/. Using the
symmetry, we can write the potential from this charge distribution as
                                  Z                     Z
                                       a                     a
                                                                                   dy 0
                                                dx 0
                         s0                                                                                s0
       .0; 0; z/ D                                                                                 D            I.z; a/;
                     4        0       x0D a                 y0 D a        .x 0 2 C y 0 2 C z2 /1=2          0


with
                                           Z                     Z
                                                a
                                                             0
                                                                      a
                                                                                       dy 0
                     I.z; a/ Á                          dx                                             :                   (2.1)
                                               x 0 D0                y 0 D0   .x 0 2 C y 0 2 C z2 /1=2
   To do the integral I.z; a/ numerically, we split the square into n2 smaller squares
of side h D a=n, and on each square, apply a simple integration rule such as
midpoint integration
                           Z xCh                 Â         Ã
                                                         h
                                 f .x/dx hf x C                                  (2.2)
                             x                           2
2.1 Extrapolation to Zero Cell Size                                         13


or Simpson’s rule
              Z       xCh               Ä          Â      Ã
                                      h                 h
                            f .x/dx      f .x/ C 4f x C     C f .x C h/   (2.3)
                  x                   6                 2

in two dimensions. The integration can be written as a MATLAB function.
% --------------------------------------------------------------
% Compute potential on symmetry axis of square plate
% --------------------------------------------------------------
function pot = integr(z, a, n, rule)

% Arguments:
%    z     = the height over the plate
%    a     = the side of the square
%    n     = the number of elements along each side of the plate
%    rule = a string ’midpoint’ or ’simpson’ that specifies
%            the integration rule
% Returns:
%    pot = the potential at the point (0,0,z)

x    =   linspace(0, a, n+1);
y    =   linspace(0, a, n+1);
h    =   a/n;
zs   =   zˆ2;

if (strcmp(rule, ’midpoint’))

     % Midpoint integration
     xs(1:n) = (x(1:n) + h/2).ˆ2;
     ys(1:n) = (y(1:n) + h/2).ˆ2;
     [xxs, yys] = meshgrid(xs,ys);

     int = sum(sum(1./sqrt(xxs + yys + zs)));

elseif (strcmp(rule, ’simpson’))

     % Simpson’s rule
     int = 0;
     for i = 1:n
       x1 = x(i)ˆ2; x2 = (x(i) + h/2)ˆ2; x3 = (x(i) + h)ˆ2;
       y1(1:n) = y(1:n).ˆ2;
       y2(1:n) = (y(1:n) + h/2).ˆ2;
       y3(1:n) = (y(1:n) + h).ˆ2;
       int = int + sum( 1./sqrt(x1+y1+zs) + 1./sqrt(x1+y3+zs) ...
                         + 1./sqrt(x3+y1+zs) + 1./sqrt(x3+y3+zs)...
                         + 4./sqrt(x2+y1+zs) + 4./sqrt(x2+y3+zs)...
                         + 4./sqrt(x1+y2+zs) + 4./sqrt(x3+y2+zs)...
                         + 16./sqrt(x2+y2+zs))/36;
     end
14                                                                        2 Convergence


Table 2.1 Integral I.1; 1/
from numerical integration           n [-]   h [m]     Imidp .1; 1/ [m]   ISimpson .1; 1/ [m]
with different cell sizes            5       0.20000   0.79432 30171      0.79335 94378
                                     7       0.14286   0.79385 04952      0.79335 92042
                                     10      0.10000   0.79359 97873      0.79335 91413
                                     15      0.06667   0.79346 60584      0.79335 91252
                                     20      0.05000   0.79341 92684      0.79335 91225


else

     error([’Only midpoint integration and Simpson’’s rule are ’ ...
            ’implemented’])

end

pot = int*hˆ2;


    We call this function with z D a D 1 [integr(1,1,n,rule)] and different
numbers of grid points n for rule = ’simpson’ and ’midpoint’, and then
extrapolate the results to zero cell size to get as accurate an answer as possible. The
first step is to establish the order of convergence. Table 2.1 shows some results of
calling the function for different cell sizes h D 1=n.
    We can carry out the extrapolation using MATLAB routines, by collecting the
values of h, Imidp , and ISimpson in vectors. Plotting Imidp versus h to some power
p, we find an almost straight line for p D 2, as shown in Fig. 2.1. This indicates
that the midpoint rule gives quadratic convergence, i.e., Imidp .h/ D I0 C I2 h2 C
where I0 is the extrapolated result. The term I2 h2 in the Taylor expansion of Imidp
is the dominant contribution to the error when h is sufficiently small, and for such
resolutions the higher-order terms in the Taylor expansion can be neglected.
    We extrapolate the computed results as a polynomial fit in h2 using the MATLAB
command
pfit = polyfit(h.ˆ2,I,m)
Here, m is the order of the polynomial, and the extrapolated value of the integral
is the coefficient for h0 . [With the MATLAB convention for storing polynomials,
this is the (m C 1)th component of pfit]. A first-order fit (m D 1) gives the
extrapolation I.1; 1/ 0.79335 88818, second-order (m D 2) gives 0.79335 91208,
and a third-order fit gives 0.79335 91213.
    The results from the Simpson integration fall on an almost straight line when
plotted against h4 , and we conclude that the dominant error scales as h4 . A fit of
ISimpson .1; 1/ to a linear polynomial in h4 gives the extrapolation 0.79335 91207,
and quadratic and cubic fits give 0.79335 91202.
    The correct answer to eight digits is 0.79335 912. Extrapolation allows us to
establish this degree of accuracy with a rather moderate effort: a second-order fit
of the low-order midpoint rule versus h2 , using data computed for rather coarse
grids h 0:05. This gives eight-digit accuracy of the extrapolation even though the
2.1 Extrapolation to Zero Cell Size                                                          15


                     0.7945




                         0.794
             Imidp [m]




                     0.7935




                         0.793
                                 0       0.01      0.02              0.03          0.04
                                                  h2 [m2]

Fig. 2.1 Values of the integral I.1; 1/ computed by the midpoint rule, plotted versus h2


computed data has only three to four correct digits. Thus, extrapolation can bring
very significant improvements of accuracy. Another advantage of extrapolation is
that it makes us aware of how good the accuracy is. The example shows that good
accuracy can also be obtained by using the higher-order Simpson integration, even
without extrapolation, on a grid of moderate size.
   A simple way to estimate the order of convergence is to carry out computations
for a geometric sequence of cell sizes such that hi = hi C1 D hi C1 = hi C2 . Assuming
that the lowest-order term in the expansion of the error is sufficient, i.e. I.h/ D
I0 C Ip hp , and that the cell sizes form a geometric series, one can then estimate the
order of convergence as
                                     Ä                      ,        Ä
                                     I.hi / I.hi C1 /                     hi
                             p D ln                             ln             :           (2.4)
                                    I.hi C1 / I.hi C2 /                  hi C1

When applied to the computed results for h D 0:2; 0:1 and 0.05, this formula gives
p D 2:002 for the midpoint rule and p D 3:985 for Simpson, indicating that the
convergence is quadratic and quartic, respectively, for the two methods.



2.1.1 A Singular Problem

It is instructive to consider a more singular problem, such as the potential on the
midpoint of the plate, z D 0. Now, the integrand is singular, but the integral is
nevertheless convergent. For this problem, Simpson integration gives a divergent
result and cannot be used. (This illustrates the fact that high-order methods often
16                                                                      2 Convergence


experience difficulties in the presence of singularities.) However, the midpoint
integration still works, and for the cell sizes above we find the following val-
ues for Imidp .0; 1/: 1.684320, 1.706250, 1.722947, 1.736083, 1.742700. Plots of
Imidp versus hp reveal that the order of convergence is now lower, p D 1.
Nevertheless, we can still extrapolate using fits to polynomials in h. The results
are linear, 1.762015; quadratic, 1.762745; cubic, 1.762748. This integral can be
                                            p
done analytically: I.0; 1/ D 2 ln.1 C 2/              1:762747. Thus, despite the
singularity, the midpoint rule gives six-figure accuracy with h 0:05 and quadratic
extrapolation.



Review Questions

2.1-1 What is meant by resolution in the context of numerical computations? Give
   some examples.
2.1-2 How can the error in a computation be estimated?
2.1-3 What influences the error and the order of convergence?
2.1-4 Give a couple of examples of numerical integration rules and provide a
   simple comparison. Especially consider the differences for smooth and singular
   integrands.



2.2 Practical Procedures

The example we have just studied is very simple. Real application problems have
more complex geometry than a square, but on the other hand, six-digit accuracy
is very rarely needed, or even possible to achieve. Furthermore, numerical results
converge in the very regular way we found here only if the grid can be refined
uniformly over the whole computational region. When this is not possible, the con-
vergence may be oscillatory, and the extrapolation to zero cell size becomes more
difficult. In practice, it is often possible to extract a main power of convergence with
the number of grid cells, but the remainder is too oscillatory to be convincingly fit
by higher-order polynomials. A more robust and practical procedure for such cases
is to use a linear fit of the computed results to hp , where p is the estimated order
of convergence. When the converged answer is not known, but the convergence
is sufficiently regular, the order of convergence can be estimated from results for
three different resolutions. To ascertain that the estimated order of convergence is
not accidental, at least four different resolutions should be used. Once the order of
convergence is established, extrapolation to zero cell size can be made by fitting a
lowest-order expansion
                                 I.h/ D I0 C Ip hp                               (2.5)
to the computed results.
2.2 Practical Procedures                                                           17


Review Question

2.2-1 Why can extrapolation to zero cell size be difficult for nonuniformly refined
   grids?



Summary

• The accuracy of a numerical result depends on resolution. For example, a domain
  of integration can be divided into segments of size h, and a numerical evaluation
  of the integral I is then expressed as I.h/ D I0 CIp hp C , where I0 is the exact
  result, Ip hp is the dominant error term (provided that h is sufficiently small), and
  p is the order of convergence.
• The order of convergence p can be estimated from
                             Ä                      ,        Ä
                              I.hi / I.hi C1 /                    hi
                      p D ln                            ln             ;
                             I.hi C1 / I.hi C2 /                 hi C1

  which requires at least three computations and where hi = hi C1 D hi C1 = hi C2 .
  The result should preferably be verified for at least four resolutions to ascertain
  that the estimated p is not accidental.
• A simple method to estimate the error of a given computation is to (i) do a
  convergence test by uniform grid refinement, (ii) find the order of convergence,
  and (iii) extrapolate the computed results to zero cell size.
• The order of convergence depend on the method and the regularity of the
  solution. Singular behavior of the solution decreases the order of convergence
  p in many real-world problems.



Problems

P.2-1 Derive the order of convergence for midpoint integration (2.2) and Simp-
   son’s rule (2.3) under the assumption that the integrand is regular. How does a
   singular integrand influence your derivation?
P.2-2 Show that (2.4) gives an estimate for p. Under what conditions is this
   estimate accurate?
18                                                                 2 Convergence


Computer Projects

C.2-1 Repeat the calculations of I.1; 1/ and I.0; 1/, where I.z; a/ is defined in
   (2.1), using two-point Gaussian integration
     Z       xCh               Ä Â     Â         ÃÃ     Â     Â      ÃÃ
                             h       h      1               h     1
                   f .x/dx D    f xC    1   p         Cf xC    1C p
         x                   2       2       3              2      3

   and find the order of convergence.
                               R1
C.2-2 Calculate the integral 0 x ˛ dx, with a singular integrand, numerically by
   dividing the interval into equal elements and applying midpoint integration on
   each. Investigate the cases ˛ D 0:5 and 0.8, find the order of convergence, and
   extrapolate to zero cell size. The exact integral is 1=.1 ˛/.
http://www.springer.com/978-1-4614-5350-5

More Related Content

What's hot

Think Like Scilab and Become a Numerical Programming Expert- Notes for Beginn...
Think Like Scilab and Become a Numerical Programming Expert- Notes for Beginn...Think Like Scilab and Become a Numerical Programming Expert- Notes for Beginn...
Think Like Scilab and Become a Numerical Programming Expert- Notes for Beginn...ssuserd6b1fd
 
Complex Numbers
Complex NumbersComplex Numbers
Complex NumbersArun Umrao
 
Principle of Function Analysis - by Arun Umrao
Principle of Function Analysis - by Arun UmraoPrinciple of Function Analysis - by Arun Umrao
Principle of Function Analysis - by Arun Umraossuserd6b1fd
 
The Delta Of An Arithmetic Asian Option Via The Pathwise Method
The Delta Of An Arithmetic Asian Option Via The Pathwise MethodThe Delta Of An Arithmetic Asian Option Via The Pathwise Method
The Delta Of An Arithmetic Asian Option Via The Pathwise MethodAnna Borisova
 
Principle of Integration - Basic Introduction - by Arun Umrao
Principle of Integration - Basic Introduction - by Arun UmraoPrinciple of Integration - Basic Introduction - by Arun Umrao
Principle of Integration - Basic Introduction - by Arun Umraossuserd6b1fd
 
Simplextabular
SimplextabularSimplextabular
Simplextabularhushgas
 
Ch 05 MATLAB Applications in Chemical Engineering_陳奇中教授教學投影片
Ch 05 MATLAB Applications in Chemical Engineering_陳奇中教授教學投影片Ch 05 MATLAB Applications in Chemical Engineering_陳奇中教授教學投影片
Ch 05 MATLAB Applications in Chemical Engineering_陳奇中教授教學投影片Chyi-Tsong Chen
 
Simplex method
Simplex methodSimplex method
Simplex methodtatteya
 
03 truncation errors
03 truncation errors03 truncation errors
03 truncation errorsmaheej
 
Principle of Definite Integra - Integral Calculus - by Arun Umrao
Principle of Definite Integra - Integral Calculus - by Arun UmraoPrinciple of Definite Integra - Integral Calculus - by Arun Umrao
Principle of Definite Integra - Integral Calculus - by Arun Umraossuserd6b1fd
 
Stochastic methods for uncertainty quantification in numerical aerodynamics
Stochastic methods for uncertainty quantification in numerical aerodynamicsStochastic methods for uncertainty quantification in numerical aerodynamics
Stochastic methods for uncertainty quantification in numerical aerodynamicsAlexander Litvinenko
 
Accuracy
AccuracyAccuracy
Accuracyesraz
 
Second derivative and graphing
Second derivative and graphingSecond derivative and graphing
Second derivative and graphingmcftay15
 
Multivariate Regression Analysis
Multivariate Regression AnalysisMultivariate Regression Analysis
Multivariate Regression AnalysisKalaivanan Murthy
 

What's hot (16)

Think Like Scilab and Become a Numerical Programming Expert- Notes for Beginn...
Think Like Scilab and Become a Numerical Programming Expert- Notes for Beginn...Think Like Scilab and Become a Numerical Programming Expert- Notes for Beginn...
Think Like Scilab and Become a Numerical Programming Expert- Notes for Beginn...
 
Two phase method lpp
Two phase method lppTwo phase method lpp
Two phase method lpp
 
Complex Numbers
Complex NumbersComplex Numbers
Complex Numbers
 
Principle of Function Analysis - by Arun Umrao
Principle of Function Analysis - by Arun UmraoPrinciple of Function Analysis - by Arun Umrao
Principle of Function Analysis - by Arun Umrao
 
The Delta Of An Arithmetic Asian Option Via The Pathwise Method
The Delta Of An Arithmetic Asian Option Via The Pathwise MethodThe Delta Of An Arithmetic Asian Option Via The Pathwise Method
The Delta Of An Arithmetic Asian Option Via The Pathwise Method
 
Principle of Integration - Basic Introduction - by Arun Umrao
Principle of Integration - Basic Introduction - by Arun UmraoPrinciple of Integration - Basic Introduction - by Arun Umrao
Principle of Integration - Basic Introduction - by Arun Umrao
 
Simplextabular
SimplextabularSimplextabular
Simplextabular
 
Ch 05 MATLAB Applications in Chemical Engineering_陳奇中教授教學投影片
Ch 05 MATLAB Applications in Chemical Engineering_陳奇中教授教學投影片Ch 05 MATLAB Applications in Chemical Engineering_陳奇中教授教學投影片
Ch 05 MATLAB Applications in Chemical Engineering_陳奇中教授教學投影片
 
Simplex method
Simplex methodSimplex method
Simplex method
 
03 truncation errors
03 truncation errors03 truncation errors
03 truncation errors
 
Principle of Definite Integra - Integral Calculus - by Arun Umrao
Principle of Definite Integra - Integral Calculus - by Arun UmraoPrinciple of Definite Integra - Integral Calculus - by Arun Umrao
Principle of Definite Integra - Integral Calculus - by Arun Umrao
 
ilovepdf_merged
ilovepdf_mergedilovepdf_merged
ilovepdf_merged
 
Stochastic methods for uncertainty quantification in numerical aerodynamics
Stochastic methods for uncertainty quantification in numerical aerodynamicsStochastic methods for uncertainty quantification in numerical aerodynamics
Stochastic methods for uncertainty quantification in numerical aerodynamics
 
Accuracy
AccuracyAccuracy
Accuracy
 
Second derivative and graphing
Second derivative and graphingSecond derivative and graphing
Second derivative and graphing
 
Multivariate Regression Analysis
Multivariate Regression AnalysisMultivariate Regression Analysis
Multivariate Regression Analysis
 

Viewers also liked

Децентралізація. Будуємо Україну разом
Децентралізація. Будуємо Україну разомДецентралізація. Будуємо Україну разом
Децентралізація. Будуємо Україну разомСерафим Погребнов
 
PLANO HOJA MANO ALZADA
PLANO HOJA MANO ALZADAPLANO HOJA MANO ALZADA
PLANO HOJA MANO ALZADACarol Castro
 
APPELLANTS_REPLY_BRIEF_AND_EXCERPT_OF.ver1
APPELLANTS_REPLY_BRIEF_AND_EXCERPT_OF.ver1APPELLANTS_REPLY_BRIEF_AND_EXCERPT_OF.ver1
APPELLANTS_REPLY_BRIEF_AND_EXCERPT_OF.ver1abby ovitsky
 
Parque Nacional Campos del Tuyú 11
Parque Nacional Campos del Tuyú 11Parque Nacional Campos del Tuyú 11
Parque Nacional Campos del Tuyú 11graasuncion
 
Data Analysis of Roulette Wheel
Data Analysis of Roulette WheelData Analysis of Roulette Wheel
Data Analysis of Roulette WheelAditya Chimbalkar
 
DRU-VERBAL RESUME 2016
DRU-VERBAL RESUME 2016DRU-VERBAL RESUME 2016
DRU-VERBAL RESUME 2016Dru Verbal
 
Presentación1
Presentación1Presentación1
Presentación1rociofs1
 
Cuándo es necesario ferulizar dientes
Cuándo es necesario ferulizar dientesCuándo es necesario ferulizar dientes
Cuándo es necesario ferulizar dientesmacagr2
 
Saranggola ni Efren R. Abueg
Saranggola ni Efren R. AbuegSaranggola ni Efren R. Abueg
Saranggola ni Efren R. AbuegAlex Jose
 
The Newest in Session Types
The Newest in Session TypesThe Newest in Session Types
The Newest in Session TypesRoland Kuhn
 

Viewers also liked (13)

Pdhpe powerpoint
Pdhpe powerpointPdhpe powerpoint
Pdhpe powerpoint
 
Децентралізація. Будуємо Україну разом
Децентралізація. Будуємо Україну разомДецентралізація. Будуємо Україну разом
Децентралізація. Будуємо Україну разом
 
PLANO HOJA MANO ALZADA
PLANO HOJA MANO ALZADAPLANO HOJA MANO ALZADA
PLANO HOJA MANO ALZADA
 
APPELLANTS_REPLY_BRIEF_AND_EXCERPT_OF.ver1
APPELLANTS_REPLY_BRIEF_AND_EXCERPT_OF.ver1APPELLANTS_REPLY_BRIEF_AND_EXCERPT_OF.ver1
APPELLANTS_REPLY_BRIEF_AND_EXCERPT_OF.ver1
 
Qasim Rajih_WPW
Qasim Rajih_WPWQasim Rajih_WPW
Qasim Rajih_WPW
 
Parque Nacional Campos del Tuyú 11
Parque Nacional Campos del Tuyú 11Parque Nacional Campos del Tuyú 11
Parque Nacional Campos del Tuyú 11
 
Data Analysis of Roulette Wheel
Data Analysis of Roulette WheelData Analysis of Roulette Wheel
Data Analysis of Roulette Wheel
 
DRU-VERBAL RESUME 2016
DRU-VERBAL RESUME 2016DRU-VERBAL RESUME 2016
DRU-VERBAL RESUME 2016
 
Presentación1
Presentación1Presentación1
Presentación1
 
Filipino 9 Parabula
Filipino 9 ParabulaFilipino 9 Parabula
Filipino 9 Parabula
 
Cuándo es necesario ferulizar dientes
Cuándo es necesario ferulizar dientesCuándo es necesario ferulizar dientes
Cuándo es necesario ferulizar dientes
 
Saranggola ni Efren R. Abueg
Saranggola ni Efren R. AbuegSaranggola ni Efren R. Abueg
Saranggola ni Efren R. Abueg
 
The Newest in Session Types
The Newest in Session TypesThe Newest in Session Types
The Newest in Session Types
 

Similar to Computational electromagnetics

Problem Solving by Computer Finite Element Method
Problem Solving by Computer Finite Element MethodProblem Solving by Computer Finite Element Method
Problem Solving by Computer Finite Element MethodPeter Herbert
 
“Electric Flux Density & Applications3.1.-converted.pptx
“Electric Flux Density & Applications3.1.-converted.pptx“Electric Flux Density & Applications3.1.-converted.pptx
“Electric Flux Density & Applications3.1.-converted.pptxHASNAINNAZIR1
 
Capitulo 3, 7ma edición
Capitulo 3, 7ma ediciónCapitulo 3, 7ma edición
Capitulo 3, 7ma ediciónSohar Carr
 
Numerical Analysis Assignment Help
Numerical Analysis Assignment HelpNumerical Analysis Assignment Help
Numerical Analysis Assignment HelpMath Homework Solver
 
Solving the Poisson Equation
Solving the Poisson EquationSolving the Poisson Equation
Solving the Poisson EquationShahzaib Malik
 
Robotics_Final_Paper_Folza
Robotics_Final_Paper_FolzaRobotics_Final_Paper_Folza
Robotics_Final_Paper_FolzaAlex Folz
 
Sparse data formats and efficient numerical methods for uncertainties in nume...
Sparse data formats and efficient numerical methods for uncertainties in nume...Sparse data formats and efficient numerical methods for uncertainties in nume...
Sparse data formats and efficient numerical methods for uncertainties in nume...Alexander Litvinenko
 
A Rapid Location Independent Full Tensor Gravity Algorithm
A Rapid Location Independent Full Tensor Gravity AlgorithmA Rapid Location Independent Full Tensor Gravity Algorithm
A Rapid Location Independent Full Tensor Gravity AlgorithmPioneer Natural Resources
 
Calculate_distance_and_bearing_between Latitude_Longitude_Points.docx
Calculate_distance_and_bearing_between Latitude_Longitude_Points.docxCalculate_distance_and_bearing_between Latitude_Longitude_Points.docx
Calculate_distance_and_bearing_between Latitude_Longitude_Points.docxssuserd02b23
 
Calculate_distance_and_bearing_between Latitude_Longitude_Points.docx
Calculate_distance_and_bearing_between Latitude_Longitude_Points.docxCalculate_distance_and_bearing_between Latitude_Longitude_Points.docx
Calculate_distance_and_bearing_between Latitude_Longitude_Points.docxssuserd02b23
 
Double_Integral.pdf
Double_Integral.pdfDouble_Integral.pdf
Double_Integral.pdfd00a7ece
 
matlab program for Smith chart
matlab program for Smith chartmatlab program for Smith chart
matlab program for Smith chartDnyanesh Patil
 

Similar to Computational electromagnetics (20)

DCT
DCTDCT
DCT
 
DCT
DCTDCT
DCT
 
DCT
DCTDCT
DCT
 
Problem Solving by Computer Finite Element Method
Problem Solving by Computer Finite Element MethodProblem Solving by Computer Finite Element Method
Problem Solving by Computer Finite Element Method
 
Emfbook
EmfbookEmfbook
Emfbook
 
“Electric Flux Density & Applications3.1.-converted.pptx
“Electric Flux Density & Applications3.1.-converted.pptx“Electric Flux Density & Applications3.1.-converted.pptx
“Electric Flux Density & Applications3.1.-converted.pptx
 
numerical.ppt
numerical.pptnumerical.ppt
numerical.ppt
 
project final
project finalproject final
project final
 
Capitulo 3, 7ma edición
Capitulo 3, 7ma ediciónCapitulo 3, 7ma edición
Capitulo 3, 7ma edición
 
Numerical Analysis Assignment Help
Numerical Analysis Assignment HelpNumerical Analysis Assignment Help
Numerical Analysis Assignment Help
 
Presentation.pdf
Presentation.pdfPresentation.pdf
Presentation.pdf
 
Numerical Analysis Assignment Help
Numerical Analysis Assignment HelpNumerical Analysis Assignment Help
Numerical Analysis Assignment Help
 
Solving the Poisson Equation
Solving the Poisson EquationSolving the Poisson Equation
Solving the Poisson Equation
 
Robotics_Final_Paper_Folza
Robotics_Final_Paper_FolzaRobotics_Final_Paper_Folza
Robotics_Final_Paper_Folza
 
Sparse data formats and efficient numerical methods for uncertainties in nume...
Sparse data formats and efficient numerical methods for uncertainties in nume...Sparse data formats and efficient numerical methods for uncertainties in nume...
Sparse data formats and efficient numerical methods for uncertainties in nume...
 
A Rapid Location Independent Full Tensor Gravity Algorithm
A Rapid Location Independent Full Tensor Gravity AlgorithmA Rapid Location Independent Full Tensor Gravity Algorithm
A Rapid Location Independent Full Tensor Gravity Algorithm
 
Calculate_distance_and_bearing_between Latitude_Longitude_Points.docx
Calculate_distance_and_bearing_between Latitude_Longitude_Points.docxCalculate_distance_and_bearing_between Latitude_Longitude_Points.docx
Calculate_distance_and_bearing_between Latitude_Longitude_Points.docx
 
Calculate_distance_and_bearing_between Latitude_Longitude_Points.docx
Calculate_distance_and_bearing_between Latitude_Longitude_Points.docxCalculate_distance_and_bearing_between Latitude_Longitude_Points.docx
Calculate_distance_and_bearing_between Latitude_Longitude_Points.docx
 
Double_Integral.pdf
Double_Integral.pdfDouble_Integral.pdf
Double_Integral.pdf
 
matlab program for Smith chart
matlab program for Smith chartmatlab program for Smith chart
matlab program for Smith chart
 

More from Springer

The chemistry of the actinide and transactinide elements (set vol.1 6)
The chemistry of the actinide and transactinide elements (set vol.1 6)The chemistry of the actinide and transactinide elements (set vol.1 6)
The chemistry of the actinide and transactinide elements (set vol.1 6)Springer
 
Transition metal catalyzed enantioselective allylic substitution in organic s...
Transition metal catalyzed enantioselective allylic substitution in organic s...Transition metal catalyzed enantioselective allylic substitution in organic s...
Transition metal catalyzed enantioselective allylic substitution in organic s...Springer
 
Total synthesis of natural products
Total synthesis of natural productsTotal synthesis of natural products
Total synthesis of natural productsSpringer
 
Solid state nmr
Solid state nmrSolid state nmr
Solid state nmrSpringer
 
Mass spectrometry
Mass spectrometryMass spectrometry
Mass spectrometrySpringer
 
Higher oxidation state organopalladium and platinum
Higher oxidation state organopalladium and platinumHigher oxidation state organopalladium and platinum
Higher oxidation state organopalladium and platinumSpringer
 
Principles and applications of esr spectroscopy
Principles and applications of esr spectroscopyPrinciples and applications of esr spectroscopy
Principles and applications of esr spectroscopySpringer
 
Inorganic 3 d structures
Inorganic 3 d structuresInorganic 3 d structures
Inorganic 3 d structuresSpringer
 
Field flow fractionation in biopolymer analysis
Field flow fractionation in biopolymer analysisField flow fractionation in biopolymer analysis
Field flow fractionation in biopolymer analysisSpringer
 
Thermodynamics of crystalline states
Thermodynamics of crystalline statesThermodynamics of crystalline states
Thermodynamics of crystalline statesSpringer
 
Theory of electroelasticity
Theory of electroelasticityTheory of electroelasticity
Theory of electroelasticitySpringer
 
Tensor algebra and tensor analysis for engineers
Tensor algebra and tensor analysis for engineersTensor algebra and tensor analysis for engineers
Tensor algebra and tensor analysis for engineersSpringer
 
Springer handbook of nanomaterials
Springer handbook of nanomaterialsSpringer handbook of nanomaterials
Springer handbook of nanomaterialsSpringer
 
Shock wave compression of condensed matter
Shock wave compression of condensed matterShock wave compression of condensed matter
Shock wave compression of condensed matterSpringer
 
Polarization bremsstrahlung on atoms, plasmas, nanostructures and solids
Polarization bremsstrahlung on atoms, plasmas, nanostructures and solidsPolarization bremsstrahlung on atoms, plasmas, nanostructures and solids
Polarization bremsstrahlung on atoms, plasmas, nanostructures and solidsSpringer
 
Nanostructured materials for magnetoelectronics
Nanostructured materials for magnetoelectronicsNanostructured materials for magnetoelectronics
Nanostructured materials for magnetoelectronicsSpringer
 
Nanobioelectrochemistry
NanobioelectrochemistryNanobioelectrochemistry
NanobioelectrochemistrySpringer
 
Modern theory of magnetism in metals and alloys
Modern theory of magnetism in metals and alloysModern theory of magnetism in metals and alloys
Modern theory of magnetism in metals and alloysSpringer
 
Mechanical behaviour of materials
Mechanical behaviour of materialsMechanical behaviour of materials
Mechanical behaviour of materialsSpringer
 

More from Springer (20)

The chemistry of the actinide and transactinide elements (set vol.1 6)
The chemistry of the actinide and transactinide elements (set vol.1 6)The chemistry of the actinide and transactinide elements (set vol.1 6)
The chemistry of the actinide and transactinide elements (set vol.1 6)
 
Transition metal catalyzed enantioselective allylic substitution in organic s...
Transition metal catalyzed enantioselective allylic substitution in organic s...Transition metal catalyzed enantioselective allylic substitution in organic s...
Transition metal catalyzed enantioselective allylic substitution in organic s...
 
Total synthesis of natural products
Total synthesis of natural productsTotal synthesis of natural products
Total synthesis of natural products
 
Solid state nmr
Solid state nmrSolid state nmr
Solid state nmr
 
Mass spectrometry
Mass spectrometryMass spectrometry
Mass spectrometry
 
Higher oxidation state organopalladium and platinum
Higher oxidation state organopalladium and platinumHigher oxidation state organopalladium and platinum
Higher oxidation state organopalladium and platinum
 
Principles and applications of esr spectroscopy
Principles and applications of esr spectroscopyPrinciples and applications of esr spectroscopy
Principles and applications of esr spectroscopy
 
Inorganic 3 d structures
Inorganic 3 d structuresInorganic 3 d structures
Inorganic 3 d structures
 
Field flow fractionation in biopolymer analysis
Field flow fractionation in biopolymer analysisField flow fractionation in biopolymer analysis
Field flow fractionation in biopolymer analysis
 
Thermodynamics of crystalline states
Thermodynamics of crystalline statesThermodynamics of crystalline states
Thermodynamics of crystalline states
 
Theory of electroelasticity
Theory of electroelasticityTheory of electroelasticity
Theory of electroelasticity
 
Tensor algebra and tensor analysis for engineers
Tensor algebra and tensor analysis for engineersTensor algebra and tensor analysis for engineers
Tensor algebra and tensor analysis for engineers
 
Springer handbook of nanomaterials
Springer handbook of nanomaterialsSpringer handbook of nanomaterials
Springer handbook of nanomaterials
 
Shock wave compression of condensed matter
Shock wave compression of condensed matterShock wave compression of condensed matter
Shock wave compression of condensed matter
 
Polarization bremsstrahlung on atoms, plasmas, nanostructures and solids
Polarization bremsstrahlung on atoms, plasmas, nanostructures and solidsPolarization bremsstrahlung on atoms, plasmas, nanostructures and solids
Polarization bremsstrahlung on atoms, plasmas, nanostructures and solids
 
Nanostructured materials for magnetoelectronics
Nanostructured materials for magnetoelectronicsNanostructured materials for magnetoelectronics
Nanostructured materials for magnetoelectronics
 
Nanobioelectrochemistry
NanobioelectrochemistryNanobioelectrochemistry
Nanobioelectrochemistry
 
Modern theory of magnetism in metals and alloys
Modern theory of magnetism in metals and alloysModern theory of magnetism in metals and alloys
Modern theory of magnetism in metals and alloys
 
Mechanical behaviour of materials
Mechanical behaviour of materialsMechanical behaviour of materials
Mechanical behaviour of materials
 
Magnonics
MagnonicsMagnonics
Magnonics
 

Computational electromagnetics

  • 1. Chapter 2 Convergence The usage of computational electromagnetics in engineering and science more or less always originates from a physical situation that features a particular problem. Here, some examples of such situations could be to determine the radiation pattern of an antenna, the transfer function of a frequency selective surface, the scattering from small particles or the influence of a cell phone on its user. The physical problem is then described as a mathematical problem that involves Maxwell’s equations. In a very limited number of cases, the mathematical problem can be solved analytically such that we have an exact solution in closed form. If there exists a solution to the problem that can not be calculated analytically, we can approximate the mathematical problem and pursue an approximate solution. In the context of CEM, such an approximate solution is often referred to as a numerical solution, since it typically involves extensive numerical computations in combination with relatively simple analytical expressions. These simple analytical expressions are normally applied to small subdomains of the original problem-domain, where the subdomain solutions are related to each other such that they collectively correspond to the solution to the original problem. The difference between an approximate solution and the exact solution is referred to as the error. It is desirable that the error can be reduced to an arbitrary low level such that the approximate solution converge to the exact solution, i.e. the accuracy of the numerical solution improves. Thus, one must keep in mind that numerical tools never give the exact answer. The accuracy of the numerical result depends on the so-called resolution. Resolution may mean the number of grid points per wavelength in microwave problems, or how well the geometry of an electrical motor is represented by a finite element mesh. If the method works correctly, the computed answer will converge to the exact result as the resolution increases. However, with finite resolution, the error is nonzero, and one must estimate it to ensure that its magnitude is acceptable. This is particularly true for large systems, where it may be hard to resolve details of the geometry or to afford a sufficient number of points per wavelength. Examples of this state of affairs are found in 3D-modeling of electrical motors and generators, large array antennas, and computation of the radar cross sections of aircrafts. T. Rylander et al., Computational Electromagnetics, Texts in Applied 11 Mathematics 51, DOI 10.1007/978-1-4614-5351-2 2, © Springer Science+Business Media New York 2013
  • 2. 12 2 Convergence Applied mathematicians have derived a posteriori error estimates, which can be evaluated after an approximate numerical solution has been computed. However, such error estimates are only beginning to be established for Maxwell’s equations, and discussion of these would take us far beyond an introductory course. For further information on this topic, see, e.g., [48, 69]. Nevertheless, error estimates are useful because they can be exploited for adaptive mesh refinement in regions that give large contributions to the error. A simpler method to estimate the error of a given computation is to do a convergence test by increasing the resolution uniformly, finding out the order of convergence, and then extrapolating the computed results to infinite resolution. That is the approach we will follow. In general, one does not know the order of convergence of a computational method for a given problem a priori. Even though standard centered finite differ- ences or linear finite elements converge with an error of order h2 (where h is the grid spacing or the cell size) for regular problems, singular behavior of the solution decreases the order of convergence in most application problems. Singularities are introduced by sharp edges and tips of objects such as metallic conductors, dielectrics, and magnetic materials. 2.1 Extrapolation to Zero Cell Size We will use a very simple problem, namely to calculate the electrostatic potential on the symmetry axis of a uniformly charged square, to illustrate how computed results can be extrapolated to zero cell size. The square is the region a < x < a; a < y < a; z D 0, the surface charge density s .x; y/ D s0 is constant, and we seek the potential at two points on the symmetry axis: .0; 0; a/ and .0; 0; 0/. Using the symmetry, we can write the potential from this charge distribution as Z Z a a dy 0 dx 0 s0 s0 .0; 0; z/ D D I.z; a/; 4 0 x0D a y0 D a .x 0 2 C y 0 2 C z2 /1=2 0 with Z Z a 0 a dy 0 I.z; a/ Á dx : (2.1) x 0 D0 y 0 D0 .x 0 2 C y 0 2 C z2 /1=2 To do the integral I.z; a/ numerically, we split the square into n2 smaller squares of side h D a=n, and on each square, apply a simple integration rule such as midpoint integration Z xCh  à h f .x/dx hf x C (2.2) x 2
  • 3. 2.1 Extrapolation to Zero Cell Size 13 or Simpson’s rule Z xCh Ä Â Ã h h f .x/dx f .x/ C 4f x C C f .x C h/ (2.3) x 6 2 in two dimensions. The integration can be written as a MATLAB function. % -------------------------------------------------------------- % Compute potential on symmetry axis of square plate % -------------------------------------------------------------- function pot = integr(z, a, n, rule) % Arguments: % z = the height over the plate % a = the side of the square % n = the number of elements along each side of the plate % rule = a string ’midpoint’ or ’simpson’ that specifies % the integration rule % Returns: % pot = the potential at the point (0,0,z) x = linspace(0, a, n+1); y = linspace(0, a, n+1); h = a/n; zs = zˆ2; if (strcmp(rule, ’midpoint’)) % Midpoint integration xs(1:n) = (x(1:n) + h/2).ˆ2; ys(1:n) = (y(1:n) + h/2).ˆ2; [xxs, yys] = meshgrid(xs,ys); int = sum(sum(1./sqrt(xxs + yys + zs))); elseif (strcmp(rule, ’simpson’)) % Simpson’s rule int = 0; for i = 1:n x1 = x(i)ˆ2; x2 = (x(i) + h/2)ˆ2; x3 = (x(i) + h)ˆ2; y1(1:n) = y(1:n).ˆ2; y2(1:n) = (y(1:n) + h/2).ˆ2; y3(1:n) = (y(1:n) + h).ˆ2; int = int + sum( 1./sqrt(x1+y1+zs) + 1./sqrt(x1+y3+zs) ... + 1./sqrt(x3+y1+zs) + 1./sqrt(x3+y3+zs)... + 4./sqrt(x2+y1+zs) + 4./sqrt(x2+y3+zs)... + 4./sqrt(x1+y2+zs) + 4./sqrt(x3+y2+zs)... + 16./sqrt(x2+y2+zs))/36; end
  • 4. 14 2 Convergence Table 2.1 Integral I.1; 1/ from numerical integration n [-] h [m] Imidp .1; 1/ [m] ISimpson .1; 1/ [m] with different cell sizes 5 0.20000 0.79432 30171 0.79335 94378 7 0.14286 0.79385 04952 0.79335 92042 10 0.10000 0.79359 97873 0.79335 91413 15 0.06667 0.79346 60584 0.79335 91252 20 0.05000 0.79341 92684 0.79335 91225 else error([’Only midpoint integration and Simpson’’s rule are ’ ... ’implemented’]) end pot = int*hˆ2; We call this function with z D a D 1 [integr(1,1,n,rule)] and different numbers of grid points n for rule = ’simpson’ and ’midpoint’, and then extrapolate the results to zero cell size to get as accurate an answer as possible. The first step is to establish the order of convergence. Table 2.1 shows some results of calling the function for different cell sizes h D 1=n. We can carry out the extrapolation using MATLAB routines, by collecting the values of h, Imidp , and ISimpson in vectors. Plotting Imidp versus h to some power p, we find an almost straight line for p D 2, as shown in Fig. 2.1. This indicates that the midpoint rule gives quadratic convergence, i.e., Imidp .h/ D I0 C I2 h2 C where I0 is the extrapolated result. The term I2 h2 in the Taylor expansion of Imidp is the dominant contribution to the error when h is sufficiently small, and for such resolutions the higher-order terms in the Taylor expansion can be neglected. We extrapolate the computed results as a polynomial fit in h2 using the MATLAB command pfit = polyfit(h.ˆ2,I,m) Here, m is the order of the polynomial, and the extrapolated value of the integral is the coefficient for h0 . [With the MATLAB convention for storing polynomials, this is the (m C 1)th component of pfit]. A first-order fit (m D 1) gives the extrapolation I.1; 1/ 0.79335 88818, second-order (m D 2) gives 0.79335 91208, and a third-order fit gives 0.79335 91213. The results from the Simpson integration fall on an almost straight line when plotted against h4 , and we conclude that the dominant error scales as h4 . A fit of ISimpson .1; 1/ to a linear polynomial in h4 gives the extrapolation 0.79335 91207, and quadratic and cubic fits give 0.79335 91202. The correct answer to eight digits is 0.79335 912. Extrapolation allows us to establish this degree of accuracy with a rather moderate effort: a second-order fit of the low-order midpoint rule versus h2 , using data computed for rather coarse grids h 0:05. This gives eight-digit accuracy of the extrapolation even though the
  • 5. 2.1 Extrapolation to Zero Cell Size 15 0.7945 0.794 Imidp [m] 0.7935 0.793 0 0.01 0.02 0.03 0.04 h2 [m2] Fig. 2.1 Values of the integral I.1; 1/ computed by the midpoint rule, plotted versus h2 computed data has only three to four correct digits. Thus, extrapolation can bring very significant improvements of accuracy. Another advantage of extrapolation is that it makes us aware of how good the accuracy is. The example shows that good accuracy can also be obtained by using the higher-order Simpson integration, even without extrapolation, on a grid of moderate size. A simple way to estimate the order of convergence is to carry out computations for a geometric sequence of cell sizes such that hi = hi C1 D hi C1 = hi C2 . Assuming that the lowest-order term in the expansion of the error is sufficient, i.e. I.h/ D I0 C Ip hp , and that the cell sizes form a geometric series, one can then estimate the order of convergence as Ä , Ä I.hi / I.hi C1 / hi p D ln ln : (2.4) I.hi C1 / I.hi C2 / hi C1 When applied to the computed results for h D 0:2; 0:1 and 0.05, this formula gives p D 2:002 for the midpoint rule and p D 3:985 for Simpson, indicating that the convergence is quadratic and quartic, respectively, for the two methods. 2.1.1 A Singular Problem It is instructive to consider a more singular problem, such as the potential on the midpoint of the plate, z D 0. Now, the integrand is singular, but the integral is nevertheless convergent. For this problem, Simpson integration gives a divergent result and cannot be used. (This illustrates the fact that high-order methods often
  • 6. 16 2 Convergence experience difficulties in the presence of singularities.) However, the midpoint integration still works, and for the cell sizes above we find the following val- ues for Imidp .0; 1/: 1.684320, 1.706250, 1.722947, 1.736083, 1.742700. Plots of Imidp versus hp reveal that the order of convergence is now lower, p D 1. Nevertheless, we can still extrapolate using fits to polynomials in h. The results are linear, 1.762015; quadratic, 1.762745; cubic, 1.762748. This integral can be p done analytically: I.0; 1/ D 2 ln.1 C 2/ 1:762747. Thus, despite the singularity, the midpoint rule gives six-figure accuracy with h 0:05 and quadratic extrapolation. Review Questions 2.1-1 What is meant by resolution in the context of numerical computations? Give some examples. 2.1-2 How can the error in a computation be estimated? 2.1-3 What influences the error and the order of convergence? 2.1-4 Give a couple of examples of numerical integration rules and provide a simple comparison. Especially consider the differences for smooth and singular integrands. 2.2 Practical Procedures The example we have just studied is very simple. Real application problems have more complex geometry than a square, but on the other hand, six-digit accuracy is very rarely needed, or even possible to achieve. Furthermore, numerical results converge in the very regular way we found here only if the grid can be refined uniformly over the whole computational region. When this is not possible, the con- vergence may be oscillatory, and the extrapolation to zero cell size becomes more difficult. In practice, it is often possible to extract a main power of convergence with the number of grid cells, but the remainder is too oscillatory to be convincingly fit by higher-order polynomials. A more robust and practical procedure for such cases is to use a linear fit of the computed results to hp , where p is the estimated order of convergence. When the converged answer is not known, but the convergence is sufficiently regular, the order of convergence can be estimated from results for three different resolutions. To ascertain that the estimated order of convergence is not accidental, at least four different resolutions should be used. Once the order of convergence is established, extrapolation to zero cell size can be made by fitting a lowest-order expansion I.h/ D I0 C Ip hp (2.5) to the computed results.
  • 7. 2.2 Practical Procedures 17 Review Question 2.2-1 Why can extrapolation to zero cell size be difficult for nonuniformly refined grids? Summary • The accuracy of a numerical result depends on resolution. For example, a domain of integration can be divided into segments of size h, and a numerical evaluation of the integral I is then expressed as I.h/ D I0 CIp hp C , where I0 is the exact result, Ip hp is the dominant error term (provided that h is sufficiently small), and p is the order of convergence. • The order of convergence p can be estimated from Ä , Ä I.hi / I.hi C1 / hi p D ln ln ; I.hi C1 / I.hi C2 / hi C1 which requires at least three computations and where hi = hi C1 D hi C1 = hi C2 . The result should preferably be verified for at least four resolutions to ascertain that the estimated p is not accidental. • A simple method to estimate the error of a given computation is to (i) do a convergence test by uniform grid refinement, (ii) find the order of convergence, and (iii) extrapolate the computed results to zero cell size. • The order of convergence depend on the method and the regularity of the solution. Singular behavior of the solution decreases the order of convergence p in many real-world problems. Problems P.2-1 Derive the order of convergence for midpoint integration (2.2) and Simp- son’s rule (2.3) under the assumption that the integrand is regular. How does a singular integrand influence your derivation? P.2-2 Show that (2.4) gives an estimate for p. Under what conditions is this estimate accurate?
  • 8. 18 2 Convergence Computer Projects C.2-1 Repeat the calculations of I.1; 1/ and I.0; 1/, where I.z; a/ is defined in (2.1), using two-point Gaussian integration Z xCh Ä Â Â ÃÃ Â Â ÃÃ h h 1 h 1 f .x/dx D f xC 1 p Cf xC 1C p x 2 2 3 2 3 and find the order of convergence. R1 C.2-2 Calculate the integral 0 x ˛ dx, with a singular integrand, numerically by dividing the interval into equal elements and applying midpoint integration on each. Investigate the cases ˛ D 0:5 and 0.8, find the order of convergence, and extrapolate to zero cell size. The exact integral is 1=.1 ˛/.