SlideShare a Scribd company logo
1 of 17
APPLICATION OF TAYLOR’S SERIES
AND PARTIAL DIFFRENTIAL
EQUATION
PRESENTED BY—
DHEERENDRA RAJPUT
ABSTRACT-----
• Polynomial functions are easy to understand but complicated
functions, infinite polynomials, are not obvious. Infinite
polynomials are made easier when represented using series:
complicated functions are easily represented using Taylor’s series.
This representation make some functions properties easy to study
such as the asymptotic behavior. Differential equations are made
easy with Taylor series. Taylor’s series is an essential theoretical
tool in computational science and approximation. This paper
points out and attempts to illustrate some of the many
applications of Taylor’s series expansion. Concrete examples in the
physical science division and various engineering fields are used to
paint the applications pointed out.
Introduction of Taylor Series
. Taylors series is an expansion of a function into an
infinite series of a variable x or into a finite series plus
a remainder term[1]. The coefficients of the
expansion or of the subsequent terms of the series
involve the successive derivatives of the function. The
function to be expanded should have a nth derivative
in the interval of expansion. The series resulting from
Taylors expansion is referred to as the Taylor series.
The series is finite and the only concern is the
magnitude of the remainder. :
EVALUATING DEFINITE
INTEGRALS
Some functions have no anti-derivative which can be
expressed in terms of familiar functions. This makes
evaluating definite integrals of these functions difficult
because the fundamental theorem of calculus cannot
be
used.
Example=
Taylor series
sin(x^2) = x^2 – x^6/3! + x^10/5! ………
(MATLAB)
The Taylor series can then be integrated:
0
1
sin 𝑥2
𝑑𝑥 =
𝑥3
3
+
𝑥7
7𝑋3!
+
𝑥11
11𝑋5!
+ ⋯ … .
(MATLAB)
syms x
S(x) = sin(x.^2)
T = taylor(S,x,'Order',18)
I = int(T,x)
MATLAB syms x
S(x) = sin(x.^2)
T = taylor(S,x,'Order',18)
• This is an alternating series and by adding all the terms the series
converges to 0.31026
MATLAB CODE—
syms x
S(x) = sin(x.^2)
T = taylor(S,x,'Order',18)
I = int(T,x,[0 ])
UNDERSTANDING ASYMPTOTIC
BEHAVIOR
The electric field
obeys the inverse square law.
E =Kq/r^2
Where E is the electric field, q is the charge, r is the
distance away from the charge and k is some constant
of proportionality. Two opposite charges placed side by
side, setup an electric dipole moment
Taylor’s series is used to study this behavior.
• E = Kq/(x-r)^2 + Kq/(x+r)^2
• An electric field further away from the dipole is obtained after expanding
the terms in the denominator—
• E = Kq/x^2(1-r/x)^2 – Kq/x^2(1+r/x)^2
• Taylor’s series can be used to expand the denominators if(x>>>r)
Kq/(1-r/x)^2 = (MATLAB)—
syms x r
E(x) = 1/(1-r/x)^2
T = taylor(E,r,'Order',5)
Kq/(1+r/x)^2 = (MATLAB)
syms x r
E(x) = 1/(1+r/x)^2
T = taylor(E,r,'Order',5--)
EXAMPLES OF APPLICATIONS OF TAYLOR
SERIES--
1----
• The Gassmann relations of poroelasticity provide a connection between
the dry and the saturated elastic moduli of porous rock and are useful in a
variety of petroleum geoscience applications . Because some uncertainty is
usually associated with the input parameters, the propagation of error in
the inputs into the final moduli estimates is immediately of interest. Two
common approaches to error propagation include: a first-order Taylor’s
series expansion and Monte-Carlo methods. The Taylor’s series approach
requires derivatives, which are obtained either analytically or numerically
and is usually limited to a first-order analysis. The formulae for analytical
derivatives were often prohibitively complicated before modern symbolic
computation packages became prevalent but they are now more
accessible.
2----
A numerical method for simulations of nonlinear surface water waves over variable
bathymetry (study of underwater depth of third dimension of lake or ocean floor) and which
is applicable to either two- or three dimensional flows, as well as to either static or moving
bottom topography, is based on the reduction of the problem to a lower-dimensional
Hamiltonian system involving boundary quantities alone. A key component of this
formulation is the Dirichlet-Neumann operator (used in analysing boundary conditions e.g
fluid dynamics and crystal growth) which, in light of its joint analyticity properties with
respect to surface and bottom deformations, is computed using its Taylor’s series
representation. The new stabilized forms for the Taylor terms, are efficiently computed by a
pseudo spectral method using the fast Fourier transform
Solving Partial Differential Equations--
In a partial differential equation (PDE), the function
being solved for depends on several variables, and
the differential equation can include partial
derivatives taken with respect to each of the
variables. Partial differential equations are useful for
modelling waves, heat flow, fluid dispersion, and
other phenomena with spatial behavior that changes
over time.
Example: The Heat Equation
• An example of a parabolic PDE is the heat equation in one dimension:
• ∂u/∂t=∂^2u/∂x^2
• Solve heat equation in MATLAB
•solutionProcess
To solve PDEs with pdepe, you must define the equation coefficients for c, f, and s, the
initial conditions, the behavior of the solution at the boundaries, and a mesh of points to
evaluate the solution on
Local Functions
function [c,f,s] = heatpde(x,t,u,dudx)
c = 1; f = dudx; s = 0;
End
function u0 = heatic(x)
u0 = 0.5; end
function
[pl,ql,pr,qr] = heatbc(xl,ul,xr,ur,t)
pl = ul;
ql = 0;
pr = ur - 1;
qr = 0;
end
Select Solution Mesh
Use a spatial mesh of 20 points and a time mesh of 30 points. Since the solution
rapidly
reaches a steady state, the time points near t=0 are more closely spaced together to
capture
this behavior in the output.
L = 1; x = linspace(0,L,20); t = [linspace(0,0.05,20), linspace(0.5,5,10)];
Solve Equation
Finally, solve the equation using the symmetry m, the PDE equation, the initial condition, the boundary
conditions, and the meshes for x and t.
m = 0;
sol = pdepe(m,@heatpde,@heatic,@heatbc,x,t);
Plot Solution
Use imagesc to visualize the solution matrix.
colormap hot
imagesc(x,t,sol)
colorbar
xlabel('Distance x','interpreter','latex')
ylabel('Time t','interpreter','latex')
title('Heat Equation for $0 le x le 1$ and $0 le t le 5$','interpreter','latex')
CONCLUSION.
Probably the most important application of Taylor series
is to use their partial sums to approximate functions.
These partial sums are (finite) polynomials and are easy
to compute.
As far as I know, the concept of Taylor series was
discovered by the Scottish mathematician James
Gregory and formally introduced by the English
mathematician Brook Taylor in 1715. However, my main
curiosity is about the problems and situations that
resulted in a need to approximate a function using Taylor
series.
•THANKU YOU

More Related Content

What's hot

What's hot (20)

Laplace transform
Laplace transformLaplace transform
Laplace transform
 
Geometrical control theory
Geometrical control theoryGeometrical control theory
Geometrical control theory
 
Laplace Transformation & Its Application
Laplace Transformation & Its ApplicationLaplace Transformation & Its Application
Laplace Transformation & Its Application
 
Laplace transforms
Laplace transformsLaplace transforms
Laplace transforms
 
Production Engineering - Laplace Transformation
Production Engineering - Laplace TransformationProduction Engineering - Laplace Transformation
Production Engineering - Laplace Transformation
 
Laplace transform
Laplace transformLaplace transform
Laplace transform
 
Laplace transforms
Laplace transforms Laplace transforms
Laplace transforms
 
Laplace transformations
Laplace transformationsLaplace transformations
Laplace transformations
 
Ch05 1
Ch05 1Ch05 1
Ch05 1
 
Dynamical systems
Dynamical systemsDynamical systems
Dynamical systems
 
Maths 3 ppt
Maths 3 pptMaths 3 ppt
Maths 3 ppt
 
Multiple scales
Multiple scalesMultiple scales
Multiple scales
 
Control chap5
Control chap5Control chap5
Control chap5
 
Chapter 2 laplace transform
Chapter 2 laplace transformChapter 2 laplace transform
Chapter 2 laplace transform
 
Meeting w3 chapter 2 part 1
Meeting w3   chapter 2 part 1Meeting w3   chapter 2 part 1
Meeting w3 chapter 2 part 1
 
Meeting w6 chapter 2 part 3
Meeting w6   chapter 2 part 3Meeting w6   chapter 2 part 3
Meeting w6 chapter 2 part 3
 
Laplace
LaplaceLaplace
Laplace
 
Z transform
Z transformZ transform
Z transform
 
Integral Transform
Integral  TransformIntegral  Transform
Integral Transform
 
Laplace transformation
Laplace transformationLaplace transformation
Laplace transformation
 

Similar to Maths ppt partial diffrentian eqn

transformada de lapalace universidaqd ppt para find eaño
transformada de lapalace universidaqd ppt para find eañotransformada de lapalace universidaqd ppt para find eaño
transformada de lapalace universidaqd ppt para find eañoluis506251
 
An alternative scheme for approximating a periodic function
An alternative scheme for approximating a periodic functionAn alternative scheme for approximating a periodic function
An alternative scheme for approximating a periodic functionijscmcj
 
from_data_to_differential_equations.ppt
from_data_to_differential_equations.pptfrom_data_to_differential_equations.ppt
from_data_to_differential_equations.pptashutoshvb1
 
Applications of differential equation
Applications of differential equationApplications of differential equation
Applications of differential equationDeekshaSrivas
 
Oscillatory motion control of hinged body using controller
Oscillatory motion control of hinged body using controllerOscillatory motion control of hinged body using controller
Oscillatory motion control of hinged body using controllereSAT Publishing House
 
Oscillatory motion control of hinged body using controller
Oscillatory motion control of hinged body using controllerOscillatory motion control of hinged body using controller
Oscillatory motion control of hinged body using controllereSAT Journals
 
Meeting w3 chapter 2 part 1
Meeting w3   chapter 2 part 1Meeting w3   chapter 2 part 1
Meeting w3 chapter 2 part 1Hattori Sidek
 
NAS-Ch4-Application of Laplace Transform
NAS-Ch4-Application of Laplace TransformNAS-Ch4-Application of Laplace Transform
NAS-Ch4-Application of Laplace TransformHussain K
 
Math major 14 differential calculus pw
Math major 14 differential calculus pwMath major 14 differential calculus pw
Math major 14 differential calculus pwReymart Bargamento
 
20070823
2007082320070823
20070823neostar
 

Similar to Maths ppt partial diffrentian eqn (20)

transformada de lapalace universidaqd ppt para find eaño
transformada de lapalace universidaqd ppt para find eañotransformada de lapalace universidaqd ppt para find eaño
transformada de lapalace universidaqd ppt para find eaño
 
Laplace transform
Laplace transformLaplace transform
Laplace transform
 
APPLICATION MATHS FOR EEE
APPLICATION MATHS FOR EEEAPPLICATION MATHS FOR EEE
APPLICATION MATHS FOR EEE
 
Two
TwoTwo
Two
 
Laplace transform
Laplace transformLaplace transform
Laplace transform
 
An alternative scheme for approximating a periodic function
An alternative scheme for approximating a periodic functionAn alternative scheme for approximating a periodic function
An alternative scheme for approximating a periodic function
 
04_AJMS_453_22_compressed.pdf
04_AJMS_453_22_compressed.pdf04_AJMS_453_22_compressed.pdf
04_AJMS_453_22_compressed.pdf
 
from_data_to_differential_equations.ppt
from_data_to_differential_equations.pptfrom_data_to_differential_equations.ppt
from_data_to_differential_equations.ppt
 
Applications of differential equation
Applications of differential equationApplications of differential equation
Applications of differential equation
 
Oscillatory motion control of hinged body using controller
Oscillatory motion control of hinged body using controllerOscillatory motion control of hinged body using controller
Oscillatory motion control of hinged body using controller
 
Oscillatory motion control of hinged body using controller
Oscillatory motion control of hinged body using controllerOscillatory motion control of hinged body using controller
Oscillatory motion control of hinged body using controller
 
02_AJMS_297_21.pdf
02_AJMS_297_21.pdf02_AJMS_297_21.pdf
02_AJMS_297_21.pdf
 
Chapter26
Chapter26Chapter26
Chapter26
 
Meeting w3 chapter 2 part 1
Meeting w3   chapter 2 part 1Meeting w3   chapter 2 part 1
Meeting w3 chapter 2 part 1
 
NAS-Ch4-Application of Laplace Transform
NAS-Ch4-Application of Laplace TransformNAS-Ch4-Application of Laplace Transform
NAS-Ch4-Application of Laplace Transform
 
Mamt2 u1 a1_yaco
Mamt2 u1 a1_yacoMamt2 u1 a1_yaco
Mamt2 u1 a1_yaco
 
Math major 14 differential calculus pw
Math major 14 differential calculus pwMath major 14 differential calculus pw
Math major 14 differential calculus pw
 
Lec1 01
Lec1 01Lec1 01
Lec1 01
 
20070823
2007082320070823
20070823
 
PART I.4 - Physical Mathematics
PART I.4 - Physical MathematicsPART I.4 - Physical Mathematics
PART I.4 - Physical Mathematics
 

More from DheerendraKumar43

More from DheerendraKumar43 (9)

Temperature measurement using nodemcu esp8266
Temperature measurement  using nodemcu esp8266Temperature measurement  using nodemcu esp8266
Temperature measurement using nodemcu esp8266
 
Buck converter in MATLAB using PID controller
Buck converter in MATLAB using PID controllerBuck converter in MATLAB using PID controller
Buck converter in MATLAB using PID controller
 
Control system done by dheerendra
Control system done by dheerendraControl system done by dheerendra
Control system done by dheerendra
 
Addiction
AddictionAddiction
Addiction
 
Diodes // LED // OLED
Diodes // LED // OLEDDiodes // LED // OLED
Diodes // LED // OLED
 
momentum conservation
momentum conservationmomentum conservation
momentum conservation
 
energy conservation
energy conservation energy conservation
energy conservation
 
Queue
QueueQueue
Queue
 
Photodiode / diode
Photodiode / diodePhotodiode / diode
Photodiode / diode
 

Recently uploaded

Introduction to AI in Higher Education_draft.pptx
Introduction to AI in Higher Education_draft.pptxIntroduction to AI in Higher Education_draft.pptx
Introduction to AI in Higher Education_draft.pptxpboyjonauth
 
Solving Puzzles Benefits Everyone (English).pptx
Solving Puzzles Benefits Everyone (English).pptxSolving Puzzles Benefits Everyone (English).pptx
Solving Puzzles Benefits Everyone (English).pptxOH TEIK BIN
 
mini mental status format.docx
mini    mental       status     format.docxmini    mental       status     format.docx
mini mental status format.docxPoojaSen20
 
BASLIQ CURRENT LOOKBOOK LOOKBOOK(1) (1).pdf
BASLIQ CURRENT LOOKBOOK  LOOKBOOK(1) (1).pdfBASLIQ CURRENT LOOKBOOK  LOOKBOOK(1) (1).pdf
BASLIQ CURRENT LOOKBOOK LOOKBOOK(1) (1).pdfSoniaTolstoy
 
Employee wellbeing at the workplace.pptx
Employee wellbeing at the workplace.pptxEmployee wellbeing at the workplace.pptx
Employee wellbeing at the workplace.pptxNirmalaLoungPoorunde1
 
Incoming and Outgoing Shipments in 1 STEP Using Odoo 17
Incoming and Outgoing Shipments in 1 STEP Using Odoo 17Incoming and Outgoing Shipments in 1 STEP Using Odoo 17
Incoming and Outgoing Shipments in 1 STEP Using Odoo 17Celine George
 
Separation of Lanthanides/ Lanthanides and Actinides
Separation of Lanthanides/ Lanthanides and ActinidesSeparation of Lanthanides/ Lanthanides and Actinides
Separation of Lanthanides/ Lanthanides and ActinidesFatimaKhan178732
 
Mastering the Unannounced Regulatory Inspection
Mastering the Unannounced Regulatory InspectionMastering the Unannounced Regulatory Inspection
Mastering the Unannounced Regulatory InspectionSafetyChain Software
 
Hybridoma Technology ( Production , Purification , and Application )
Hybridoma Technology  ( Production , Purification , and Application  ) Hybridoma Technology  ( Production , Purification , and Application  )
Hybridoma Technology ( Production , Purification , and Application ) Sakshi Ghasle
 
Micromeritics - Fundamental and Derived Properties of Powders
Micromeritics - Fundamental and Derived Properties of PowdersMicromeritics - Fundamental and Derived Properties of Powders
Micromeritics - Fundamental and Derived Properties of PowdersChitralekhaTherkar
 
POINT- BIOCHEMISTRY SEM 2 ENZYMES UNIT 5.pptx
POINT- BIOCHEMISTRY SEM 2 ENZYMES UNIT 5.pptxPOINT- BIOCHEMISTRY SEM 2 ENZYMES UNIT 5.pptx
POINT- BIOCHEMISTRY SEM 2 ENZYMES UNIT 5.pptxSayali Powar
 
URLs and Routing in the Odoo 17 Website App
URLs and Routing in the Odoo 17 Website AppURLs and Routing in the Odoo 17 Website App
URLs and Routing in the Odoo 17 Website AppCeline George
 
The basics of sentences session 2pptx copy.pptx
The basics of sentences session 2pptx copy.pptxThe basics of sentences session 2pptx copy.pptx
The basics of sentences session 2pptx copy.pptxheathfieldcps1
 
_Math 4-Q4 Week 5.pptx Steps in Collecting Data
_Math 4-Q4 Week 5.pptx Steps in Collecting Data_Math 4-Q4 Week 5.pptx Steps in Collecting Data
_Math 4-Q4 Week 5.pptx Steps in Collecting DataJhengPantaleon
 
18-04-UA_REPORT_MEDIALITERAСY_INDEX-DM_23-1-final-eng.pdf
18-04-UA_REPORT_MEDIALITERAСY_INDEX-DM_23-1-final-eng.pdf18-04-UA_REPORT_MEDIALITERAСY_INDEX-DM_23-1-final-eng.pdf
18-04-UA_REPORT_MEDIALITERAСY_INDEX-DM_23-1-final-eng.pdfssuser54595a
 
Crayon Activity Handout For the Crayon A
Crayon Activity Handout For the Crayon ACrayon Activity Handout For the Crayon A
Crayon Activity Handout For the Crayon AUnboundStockton
 
Software Engineering Methodologies (overview)
Software Engineering Methodologies (overview)Software Engineering Methodologies (overview)
Software Engineering Methodologies (overview)eniolaolutunde
 

Recently uploaded (20)

Introduction to AI in Higher Education_draft.pptx
Introduction to AI in Higher Education_draft.pptxIntroduction to AI in Higher Education_draft.pptx
Introduction to AI in Higher Education_draft.pptx
 
Solving Puzzles Benefits Everyone (English).pptx
Solving Puzzles Benefits Everyone (English).pptxSolving Puzzles Benefits Everyone (English).pptx
Solving Puzzles Benefits Everyone (English).pptx
 
mini mental status format.docx
mini    mental       status     format.docxmini    mental       status     format.docx
mini mental status format.docx
 
BASLIQ CURRENT LOOKBOOK LOOKBOOK(1) (1).pdf
BASLIQ CURRENT LOOKBOOK  LOOKBOOK(1) (1).pdfBASLIQ CURRENT LOOKBOOK  LOOKBOOK(1) (1).pdf
BASLIQ CURRENT LOOKBOOK LOOKBOOK(1) (1).pdf
 
Employee wellbeing at the workplace.pptx
Employee wellbeing at the workplace.pptxEmployee wellbeing at the workplace.pptx
Employee wellbeing at the workplace.pptx
 
Incoming and Outgoing Shipments in 1 STEP Using Odoo 17
Incoming and Outgoing Shipments in 1 STEP Using Odoo 17Incoming and Outgoing Shipments in 1 STEP Using Odoo 17
Incoming and Outgoing Shipments in 1 STEP Using Odoo 17
 
Separation of Lanthanides/ Lanthanides and Actinides
Separation of Lanthanides/ Lanthanides and ActinidesSeparation of Lanthanides/ Lanthanides and Actinides
Separation of Lanthanides/ Lanthanides and Actinides
 
Mastering the Unannounced Regulatory Inspection
Mastering the Unannounced Regulatory InspectionMastering the Unannounced Regulatory Inspection
Mastering the Unannounced Regulatory Inspection
 
Código Creativo y Arte de Software | Unidad 1
Código Creativo y Arte de Software | Unidad 1Código Creativo y Arte de Software | Unidad 1
Código Creativo y Arte de Software | Unidad 1
 
Hybridoma Technology ( Production , Purification , and Application )
Hybridoma Technology  ( Production , Purification , and Application  ) Hybridoma Technology  ( Production , Purification , and Application  )
Hybridoma Technology ( Production , Purification , and Application )
 
Micromeritics - Fundamental and Derived Properties of Powders
Micromeritics - Fundamental and Derived Properties of PowdersMicromeritics - Fundamental and Derived Properties of Powders
Micromeritics - Fundamental and Derived Properties of Powders
 
POINT- BIOCHEMISTRY SEM 2 ENZYMES UNIT 5.pptx
POINT- BIOCHEMISTRY SEM 2 ENZYMES UNIT 5.pptxPOINT- BIOCHEMISTRY SEM 2 ENZYMES UNIT 5.pptx
POINT- BIOCHEMISTRY SEM 2 ENZYMES UNIT 5.pptx
 
URLs and Routing in the Odoo 17 Website App
URLs and Routing in the Odoo 17 Website AppURLs and Routing in the Odoo 17 Website App
URLs and Routing in the Odoo 17 Website App
 
The basics of sentences session 2pptx copy.pptx
The basics of sentences session 2pptx copy.pptxThe basics of sentences session 2pptx copy.pptx
The basics of sentences session 2pptx copy.pptx
 
Model Call Girl in Tilak Nagar Delhi reach out to us at 🔝9953056974🔝
Model Call Girl in Tilak Nagar Delhi reach out to us at 🔝9953056974🔝Model Call Girl in Tilak Nagar Delhi reach out to us at 🔝9953056974🔝
Model Call Girl in Tilak Nagar Delhi reach out to us at 🔝9953056974🔝
 
_Math 4-Q4 Week 5.pptx Steps in Collecting Data
_Math 4-Q4 Week 5.pptx Steps in Collecting Data_Math 4-Q4 Week 5.pptx Steps in Collecting Data
_Math 4-Q4 Week 5.pptx Steps in Collecting Data
 
TataKelola dan KamSiber Kecerdasan Buatan v022.pdf
TataKelola dan KamSiber Kecerdasan Buatan v022.pdfTataKelola dan KamSiber Kecerdasan Buatan v022.pdf
TataKelola dan KamSiber Kecerdasan Buatan v022.pdf
 
18-04-UA_REPORT_MEDIALITERAСY_INDEX-DM_23-1-final-eng.pdf
18-04-UA_REPORT_MEDIALITERAСY_INDEX-DM_23-1-final-eng.pdf18-04-UA_REPORT_MEDIALITERAСY_INDEX-DM_23-1-final-eng.pdf
18-04-UA_REPORT_MEDIALITERAСY_INDEX-DM_23-1-final-eng.pdf
 
Crayon Activity Handout For the Crayon A
Crayon Activity Handout For the Crayon ACrayon Activity Handout For the Crayon A
Crayon Activity Handout For the Crayon A
 
Software Engineering Methodologies (overview)
Software Engineering Methodologies (overview)Software Engineering Methodologies (overview)
Software Engineering Methodologies (overview)
 

Maths ppt partial diffrentian eqn

  • 1. APPLICATION OF TAYLOR’S SERIES AND PARTIAL DIFFRENTIAL EQUATION PRESENTED BY— DHEERENDRA RAJPUT
  • 2. ABSTRACT----- • Polynomial functions are easy to understand but complicated functions, infinite polynomials, are not obvious. Infinite polynomials are made easier when represented using series: complicated functions are easily represented using Taylor’s series. This representation make some functions properties easy to study such as the asymptotic behavior. Differential equations are made easy with Taylor series. Taylor’s series is an essential theoretical tool in computational science and approximation. This paper points out and attempts to illustrate some of the many applications of Taylor’s series expansion. Concrete examples in the physical science division and various engineering fields are used to paint the applications pointed out.
  • 3. Introduction of Taylor Series . Taylors series is an expansion of a function into an infinite series of a variable x or into a finite series plus a remainder term[1]. The coefficients of the expansion or of the subsequent terms of the series involve the successive derivatives of the function. The function to be expanded should have a nth derivative in the interval of expansion. The series resulting from Taylors expansion is referred to as the Taylor series. The series is finite and the only concern is the magnitude of the remainder. :
  • 4. EVALUATING DEFINITE INTEGRALS Some functions have no anti-derivative which can be expressed in terms of familiar functions. This makes evaluating definite integrals of these functions difficult because the fundamental theorem of calculus cannot be used.
  • 5. Example= Taylor series sin(x^2) = x^2 – x^6/3! + x^10/5! ……… (MATLAB) The Taylor series can then be integrated: 0 1 sin 𝑥2 𝑑𝑥 = 𝑥3 3 + 𝑥7 7𝑋3! + 𝑥11 11𝑋5! + ⋯ … . (MATLAB) syms x S(x) = sin(x.^2) T = taylor(S,x,'Order',18) I = int(T,x) MATLAB syms x S(x) = sin(x.^2) T = taylor(S,x,'Order',18)
  • 6. • This is an alternating series and by adding all the terms the series converges to 0.31026 MATLAB CODE— syms x S(x) = sin(x.^2) T = taylor(S,x,'Order',18) I = int(T,x,[0 ])
  • 7. UNDERSTANDING ASYMPTOTIC BEHAVIOR The electric field obeys the inverse square law. E =Kq/r^2 Where E is the electric field, q is the charge, r is the distance away from the charge and k is some constant of proportionality. Two opposite charges placed side by side, setup an electric dipole moment
  • 8. Taylor’s series is used to study this behavior. • E = Kq/(x-r)^2 + Kq/(x+r)^2 • An electric field further away from the dipole is obtained after expanding the terms in the denominator— • E = Kq/x^2(1-r/x)^2 – Kq/x^2(1+r/x)^2 • Taylor’s series can be used to expand the denominators if(x>>>r) Kq/(1-r/x)^2 = (MATLAB)— syms x r E(x) = 1/(1-r/x)^2 T = taylor(E,r,'Order',5) Kq/(1+r/x)^2 = (MATLAB) syms x r E(x) = 1/(1+r/x)^2 T = taylor(E,r,'Order',5--)
  • 9. EXAMPLES OF APPLICATIONS OF TAYLOR SERIES-- 1---- • The Gassmann relations of poroelasticity provide a connection between the dry and the saturated elastic moduli of porous rock and are useful in a variety of petroleum geoscience applications . Because some uncertainty is usually associated with the input parameters, the propagation of error in the inputs into the final moduli estimates is immediately of interest. Two common approaches to error propagation include: a first-order Taylor’s series expansion and Monte-Carlo methods. The Taylor’s series approach requires derivatives, which are obtained either analytically or numerically and is usually limited to a first-order analysis. The formulae for analytical derivatives were often prohibitively complicated before modern symbolic computation packages became prevalent but they are now more accessible.
  • 10. 2---- A numerical method for simulations of nonlinear surface water waves over variable bathymetry (study of underwater depth of third dimension of lake or ocean floor) and which is applicable to either two- or three dimensional flows, as well as to either static or moving bottom topography, is based on the reduction of the problem to a lower-dimensional Hamiltonian system involving boundary quantities alone. A key component of this formulation is the Dirichlet-Neumann operator (used in analysing boundary conditions e.g fluid dynamics and crystal growth) which, in light of its joint analyticity properties with respect to surface and bottom deformations, is computed using its Taylor’s series representation. The new stabilized forms for the Taylor terms, are efficiently computed by a pseudo spectral method using the fast Fourier transform
  • 11. Solving Partial Differential Equations-- In a partial differential equation (PDE), the function being solved for depends on several variables, and the differential equation can include partial derivatives taken with respect to each of the variables. Partial differential equations are useful for modelling waves, heat flow, fluid dispersion, and other phenomena with spatial behavior that changes over time.
  • 12. Example: The Heat Equation • An example of a parabolic PDE is the heat equation in one dimension: • ∂u/∂t=∂^2u/∂x^2 • Solve heat equation in MATLAB •solutionProcess To solve PDEs with pdepe, you must define the equation coefficients for c, f, and s, the initial conditions, the behavior of the solution at the boundaries, and a mesh of points to evaluate the solution on
  • 13. Local Functions function [c,f,s] = heatpde(x,t,u,dudx) c = 1; f = dudx; s = 0; End function u0 = heatic(x) u0 = 0.5; end function [pl,ql,pr,qr] = heatbc(xl,ul,xr,ur,t) pl = ul; ql = 0; pr = ur - 1; qr = 0; end
  • 14. Select Solution Mesh Use a spatial mesh of 20 points and a time mesh of 30 points. Since the solution rapidly reaches a steady state, the time points near t=0 are more closely spaced together to capture this behavior in the output. L = 1; x = linspace(0,L,20); t = [linspace(0,0.05,20), linspace(0.5,5,10)]; Solve Equation Finally, solve the equation using the symmetry m, the PDE equation, the initial condition, the boundary conditions, and the meshes for x and t. m = 0; sol = pdepe(m,@heatpde,@heatic,@heatbc,x,t); Plot Solution Use imagesc to visualize the solution matrix. colormap hot imagesc(x,t,sol) colorbar xlabel('Distance x','interpreter','latex') ylabel('Time t','interpreter','latex') title('Heat Equation for $0 le x le 1$ and $0 le t le 5$','interpreter','latex')
  • 15.
  • 16. CONCLUSION. Probably the most important application of Taylor series is to use their partial sums to approximate functions. These partial sums are (finite) polynomials and are easy to compute. As far as I know, the concept of Taylor series was discovered by the Scottish mathematician James Gregory and formally introduced by the English mathematician Brook Taylor in 1715. However, my main curiosity is about the problems and situations that resulted in a need to approximate a function using Taylor series.