SlideShare a Scribd company logo
1 of 14
Download to read offline
Σ YSTEMS
Introduction to Computer Aided Geometric Design
(CAGD) for Inverse Problems
Dimitrios Papadopoulos
Delta Pi Systems
Thessaloniki, Greece, 3 August 2014
Σ YSTEMS
Overview
◮ Problem formulation
◮ A minimization problem with PDEs as constraints
◮ Computational Grids
◮ Approximation and Interpolation
◮ B´ezier and B-spline curves
◮ Least squares approximation
◮ Smoothing and regularization
◮ Parametrization - finding a knot sequence
◮ Tensor product patches
Σ YSTEMS
Problem Formulation [Schlegel(2004)]
◮ Dynamic optimization problem
min
u(t),p,tf
Φ = ΦM (y(tf )) +
tf
t0
ΦL(y(t), u(t), p, t)dt (1)
subject to the Differential-Algebraic Equations (DAE)
B(y(t), u(t), p, t) ˙y = f(y(t), u(t), p, t), t ∈ I (2)
0 = l( ˙y(t0), y(y0)), (3)
0 ≥ h(y(t), u(t), p, t), t ∈ I (4)
0 ≥ e(y(tf ) (5)
where
◮ y(t) ∈ Rny
state variables
u(t) ∈ Rnu
control variables
p ∈ Rnp
time-invariant parameters
Σ YSTEMS
Problem Formulation [Tr¨oltzsch(2005)]
◮ inverse problem
min
y(x)
J = J(u(x), y(x), p, x) = [S(ω) − ˜S(ω)]2
dω (6)
subject to
F(
∂u
∂x1
, . . . ,
∂u
∂xnx
, u(x), y(x), p, x) = 0 (7)
where
◮ x ∈ Rnx
independent variables
u(x) ∈ Rnu
state variables
y(x) ∈ Rny
control variables
p ∈ Rnp
invariant parameters
Σ YSTEMS
Computational Grids
◮ State variables are discretized on the finite element grid
◮ Control variables are on both finite element and optimization grid
◮ Interpolation of the control variables from finite element grid to
optimization grid
◮ Finite element grid is much finer than optimization grid so
less variables enter the optimization procedure
Σ YSTEMS
Interpolation
◮ Bernstein polynomials (form a partition of unity)
Bn
i (t) =
n
i
ti
(1 − t)n−i
(8)
or recursively:
Bn
i (t) = (1 − t)Bn−1
i (t) + tBn−1
i−1 (t) (9)
with
B0
0(t) ≡ 1
Bn
j (t) ≡ 0 forj /∈ {0, . . . , n}
◮ B´ezier curve (affine invariant) formed by control points bi
b(t) =
n
i=0
biBn
i (t) (10)
Σ YSTEMS
Interpolation (cntd)
◮ B-spline basis functions
N0
i (t) =
1 if τi−1 ≤ t < τi
0 else
, (11)
Nn
j (t) =
t − τj−1
τj+n−1 − τj−1
Nn−1
j (t) +
τj+n − t
τj+n − τj
Nn−1
j+1 (t), n > 1 (12)
◮ B-spline curve formed by control points ci
b(t) =
L
j=0
cjNn
j (t) (13)
Σ YSTEMS
Least Squares Approximation
◮ Given m + 1 data points d0, . . . , dm, each di being associated with a
parameter value ti, find a polynomial curve b(t) of a given degree n such
that
minimize f(c1, . . . , cL) =
m
i=0
di −
L
j=0
cjNn
j (ti)
2
(14)
which leads to the following system (in case of L2 norm)
NT
NC = NT
D (15)
◮ The data points are the control variables (concentration) discretized on the
finite element grid and the control points cj are on the optimization grid.
Σ YSTEMS
Smoothing - Regularization
◮ minimize f(c1, . . . , cL) =
P
i=0 di −
L
j=0 cjNn
j (ti)
2
+ αS[b(ti)]
◮ second differences
c0 − 2c1 + c2 = 0
... (16)
cL−2 − 2cL−1 + cL = 0
◮ smoothing equations
(1 − α)N
αS
C =
(1 − α)D
0
(17)
◮ α allows a weighting between initial data fitting and smoothing
Σ YSTEMS
Parametrization - Finding a knot sequence
◮ uniform or equidistant
(ti − ti−1)/(ti+1 − ti) = 1 (18)
◮ chord length
∆ti
∆ti+1
=
||∆di||
||∆di+1||
(19)
◮ cetripetal
∆ti
∆ti+1
=
||∆di||
||∆di+1||
1/2
(20)
◮ Natural end conditions
¨b(t0) = 0, ¨b(tm) = 0 (21)
Σ YSTEMS
Tensor Product Patches [Farin(2002)]
◮ B´ezier surface
bm,n
(u, v) =
m
i=0
n
j=0
bi,jBm
i (u)Bn
j (v) (22)
◮ B-spline surface
bm,n
(u, v) =
m
i=0
n
j=0
ci,jNm
i (u)Nn
j (v) (23)
◮ A surface with the topology of a sphere is not representable as a tensor
product surface, without degeneracies
Σ YSTEMS
Parametrization of surfaces
◮ Project the data points into a plane, i.e. drop the z-coordinate and fit into
the unit square.
◮ For each point find a good initial guess, and
perform Newton iteration until convergence is reached.
◮ Can be generalized to 4-dimensional hypersurface for the case of a
3-dimensional problem.
◮ Triangulation of data points based on graph theory.
◮ End conditions involve partial derivatives of the surface.
Σ YSTEMS
Synopsis - Outlook
Synopsis
◮ Inverse problem as a minimization problem with PDEs as constaints
◮ Optimization grid much smaller than the finite element grid
◮ Interpolation with B´ezier and B-spline curves
◮ Smoothing
◮ Different parametrization methods
◮ Natural end conditions
Outlook
◮ For a 3D space-time, a 5-dimensional hypersurface would be needed,
◮ tensor product approach is easily generalized,
◮ a projection and Newton iteration can also be generalized.
◮ NURBS curves & patches [Piegl and Tiller(1997)]
Σ YSTEMS
Bibliography
Farin, G., 2002. Curves and Surfaces for CAGD: A Practical Guide.
Academic Press.
Piegl, L. A., Tiller, W., 1997. The NURBS Book. Springer Science and
Business Media.
Schlegel, M., 2004. Adaptive discretization methods for the efficient
solution of dynamic optimization problems. Ph.D. thesis, RWTH Aachen.
Tr¨oltzsch, F., 2005. Optimale Steuerung partieller Differentialgleichungen:
Theorie, Verfahren und Anwendungen. Vieweg.

More Related Content

What's hot

Application of definite integrals
Application of definite integralsApplication of definite integrals
Application of definite integralsVaibhav Tandel
 
Lesson 16 length of an arc
Lesson 16 length of an arcLesson 16 length of an arc
Lesson 16 length of an arcLawrence De Vera
 
Lines and curves algorithms
Lines and curves algorithmsLines and curves algorithms
Lines and curves algorithmsMohammad Sadiq
 
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
 
Numerical integration
Numerical integrationNumerical integration
Numerical integrationTarun Gehlot
 
An elementary introduction to information geometry
An elementary introduction to information geometryAn elementary introduction to information geometry
An elementary introduction to information geometryFrank Nielsen
 
Information geometry: Dualistic manifold structures and their uses
Information geometry: Dualistic manifold structures and their usesInformation geometry: Dualistic manifold structures and their uses
Information geometry: Dualistic manifold structures and their usesFrank Nielsen
 
Vector mechanics for engineers statics 7th chapter 5
Vector mechanics for engineers statics 7th chapter 5 Vector mechanics for engineers statics 7th chapter 5
Vector mechanics for engineers statics 7th chapter 5 Nahla Hazem
 
Math 2 Application of integration
Math 2 Application of integrationMath 2 Application of integration
Math 2 Application of integrationlightspeed2
 
Computer Graphic - Transformations in 3d
Computer Graphic - Transformations in 3dComputer Graphic - Transformations in 3d
Computer Graphic - Transformations in 3d2013901097
 
3 d scaling and translation in homogeneous coordinates
3 d scaling and translation in homogeneous coordinates3 d scaling and translation in homogeneous coordinates
3 d scaling and translation in homogeneous coordinatesKRIPA SHNAKAR TIWARI
 
Snakes in Images (Active contour tutorial)
Snakes in Images (Active contour tutorial)Snakes in Images (Active contour tutorial)
Snakes in Images (Active contour tutorial)Yan Xu
 
Num Integration
Num IntegrationNum Integration
Num Integrationmuhdisys
 
IRJET- On Greatest Common Divisor and its Application for a Geometrical S...
IRJET-  	  On Greatest Common Divisor and its Application for a Geometrical S...IRJET-  	  On Greatest Common Divisor and its Application for a Geometrical S...
IRJET- On Greatest Common Divisor and its Application for a Geometrical S...IRJET Journal
 

What's hot (20)

SinogramReconstruction
SinogramReconstructionSinogramReconstruction
SinogramReconstruction
 
Application of definite integrals
Application of definite integralsApplication of definite integrals
Application of definite integrals
 
Lesson 16 length of an arc
Lesson 16 length of an arcLesson 16 length of an arc
Lesson 16 length of an arc
 
Lines and curves algorithms
Lines and curves algorithmsLines and curves algorithms
Lines and curves algorithms
 
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
 
Numerical integration
Numerical integrationNumerical integration
Numerical integration
 
An elementary introduction to information geometry
An elementary introduction to information geometryAn elementary introduction to information geometry
An elementary introduction to information geometry
 
Conformal mapping
Conformal mappingConformal mapping
Conformal mapping
 
Information geometry: Dualistic manifold structures and their uses
Information geometry: Dualistic manifold structures and their usesInformation geometry: Dualistic manifold structures and their uses
Information geometry: Dualistic manifold structures and their uses
 
Climate Extremes Workshop - Semiparametric Estimation of Heavy Tailed Density...
Climate Extremes Workshop - Semiparametric Estimation of Heavy Tailed Density...Climate Extremes Workshop - Semiparametric Estimation of Heavy Tailed Density...
Climate Extremes Workshop - Semiparametric Estimation of Heavy Tailed Density...
 
Vector mechanics for engineers statics 7th chapter 5
Vector mechanics for engineers statics 7th chapter 5 Vector mechanics for engineers statics 7th chapter 5
Vector mechanics for engineers statics 7th chapter 5
 
Math 2 Application of integration
Math 2 Application of integrationMath 2 Application of integration
Math 2 Application of integration
 
Computer Graphic - Transformations in 3d
Computer Graphic - Transformations in 3dComputer Graphic - Transformations in 3d
Computer Graphic - Transformations in 3d
 
Gradient
GradientGradient
Gradient
 
3 d scaling and translation in homogeneous coordinates
3 d scaling and translation in homogeneous coordinates3 d scaling and translation in homogeneous coordinates
3 d scaling and translation in homogeneous coordinates
 
Snakes in Images (Active contour tutorial)
Snakes in Images (Active contour tutorial)Snakes in Images (Active contour tutorial)
Snakes in Images (Active contour tutorial)
 
Num Integration
Num IntegrationNum Integration
Num Integration
 
Chapter 4 Integration
Chapter 4  IntegrationChapter 4  Integration
Chapter 4 Integration
 
Finite fields
Finite fields Finite fields
Finite fields
 
IRJET- On Greatest Common Divisor and its Application for a Geometrical S...
IRJET-  	  On Greatest Common Divisor and its Application for a Geometrical S...IRJET-  	  On Greatest Common Divisor and its Application for a Geometrical S...
IRJET- On Greatest Common Divisor and its Application for a Geometrical S...
 

Similar to Introduction to CAGD for Inverse Problems

On problem-of-parameters-identification-of-dynamic-object
On problem-of-parameters-identification-of-dynamic-objectOn problem-of-parameters-identification-of-dynamic-object
On problem-of-parameters-identification-of-dynamic-objectCemal Ardil
 
International journal of engineering and mathematical modelling vol2 no1_2015_1
International journal of engineering and mathematical modelling vol2 no1_2015_1International journal of engineering and mathematical modelling vol2 no1_2015_1
International journal of engineering and mathematical modelling vol2 no1_2015_1IJEMM
 
Affine Yield Curves: Flexibility versus Incompleteness
Affine Yield Curves: Flexibility versus IncompletenessAffine Yield Curves: Flexibility versus Incompleteness
Affine Yield Curves: Flexibility versus IncompletenessDhia Eddine Barbouche
 
Automatic Bayesian method for Numerical Integration
Automatic Bayesian method for Numerical Integration Automatic Bayesian method for Numerical Integration
Automatic Bayesian method for Numerical Integration Jagadeeswaran Rathinavel
 
2014 spring crunch seminar (SDE/levy/fractional/spectral method)
2014 spring crunch seminar (SDE/levy/fractional/spectral method)2014 spring crunch seminar (SDE/levy/fractional/spectral method)
2014 spring crunch seminar (SDE/levy/fractional/spectral method)Zheng Mengdi
 
Modeling Transformations
Modeling TransformationsModeling Transformations
Modeling TransformationsTarun Gehlot
 
Verification of a brick wang tiling algorithm
Verification of a brick wang tiling algorithmVerification of a brick wang tiling algorithm
Verification of a brick wang tiling algorithmYoshihiro Mizoguchi
 
2015 - Nonlinear Eigenvalue Problems And Contour Integrals
2015 - Nonlinear Eigenvalue Problems And Contour Integrals2015 - Nonlinear Eigenvalue Problems And Contour Integrals
2015 - Nonlinear Eigenvalue Problems And Contour IntegralsWendy Berg
 
SPDE presentation 2012
SPDE presentation 2012SPDE presentation 2012
SPDE presentation 2012Zheng Mengdi
 
Approximating offset curves using B ´ ezier curves with high accuracy
Approximating offset curves using B ´ ezier curves with high accuracyApproximating offset curves using B ´ ezier curves with high accuracy
Approximating offset curves using B ´ ezier curves with high accuracyIJECEIAES
 
Tucker tensor analysis of Matern functions in spatial statistics
Tucker tensor analysis of Matern functions in spatial statistics Tucker tensor analysis of Matern functions in spatial statistics
Tucker tensor analysis of Matern functions in spatial statistics Alexander Litvinenko
 

Similar to Introduction to CAGD for Inverse Problems (20)

On problem-of-parameters-identification-of-dynamic-object
On problem-of-parameters-identification-of-dynamic-objectOn problem-of-parameters-identification-of-dynamic-object
On problem-of-parameters-identification-of-dynamic-object
 
International journal of engineering and mathematical modelling vol2 no1_2015_1
International journal of engineering and mathematical modelling vol2 no1_2015_1International journal of engineering and mathematical modelling vol2 no1_2015_1
International journal of engineering and mathematical modelling vol2 no1_2015_1
 
Affine Yield Curves: Flexibility versus Incompleteness
Affine Yield Curves: Flexibility versus IncompletenessAffine Yield Curves: Flexibility versus Incompleteness
Affine Yield Curves: Flexibility versus Incompleteness
 
Presentation.pdf
Presentation.pdfPresentation.pdf
Presentation.pdf
 
Automatic Bayesian method for Numerical Integration
Automatic Bayesian method for Numerical Integration Automatic Bayesian method for Numerical Integration
Automatic Bayesian method for Numerical Integration
 
2014 spring crunch seminar (SDE/levy/fractional/spectral method)
2014 spring crunch seminar (SDE/levy/fractional/spectral method)2014 spring crunch seminar (SDE/levy/fractional/spectral method)
2014 spring crunch seminar (SDE/levy/fractional/spectral method)
 
Modeling Transformations
Modeling TransformationsModeling Transformations
Modeling Transformations
 
Verification of a brick wang tiling algorithm
Verification of a brick wang tiling algorithmVerification of a brick wang tiling algorithm
Verification of a brick wang tiling algorithm
 
CDT 22 slides.pdf
CDT 22 slides.pdfCDT 22 slides.pdf
CDT 22 slides.pdf
 
CMU_13
CMU_13CMU_13
CMU_13
 
2015 - Nonlinear Eigenvalue Problems And Contour Integrals
2015 - Nonlinear Eigenvalue Problems And Contour Integrals2015 - Nonlinear Eigenvalue Problems And Contour Integrals
2015 - Nonlinear Eigenvalue Problems And Contour Integrals
 
Automatic bayesian cubature
Automatic bayesian cubatureAutomatic bayesian cubature
Automatic bayesian cubature
 
talk_NASPDE.pdf
talk_NASPDE.pdftalk_NASPDE.pdf
talk_NASPDE.pdf
 
SPDE presentation 2012
SPDE presentation 2012SPDE presentation 2012
SPDE presentation 2012
 
MUMS Opening Workshop - Quantifying Nonparametric Modeling Uncertainty with B...
MUMS Opening Workshop - Quantifying Nonparametric Modeling Uncertainty with B...MUMS Opening Workshop - Quantifying Nonparametric Modeling Uncertainty with B...
MUMS Opening Workshop - Quantifying Nonparametric Modeling Uncertainty with B...
 
KAUST_talk_short.pdf
KAUST_talk_short.pdfKAUST_talk_short.pdf
KAUST_talk_short.pdf
 
Approximating offset curves using B ´ ezier curves with high accuracy
Approximating offset curves using B ´ ezier curves with high accuracyApproximating offset curves using B ´ ezier curves with high accuracy
Approximating offset curves using B ´ ezier curves with high accuracy
 
2018 MUMS Fall Course - Statistical Representation of Model Input (EDITED) - ...
2018 MUMS Fall Course - Statistical Representation of Model Input (EDITED) - ...2018 MUMS Fall Course - Statistical Representation of Model Input (EDITED) - ...
2018 MUMS Fall Course - Statistical Representation of Model Input (EDITED) - ...
 
Tucker tensor analysis of Matern functions in spatial statistics
Tucker tensor analysis of Matern functions in spatial statistics Tucker tensor analysis of Matern functions in spatial statistics
Tucker tensor analysis of Matern functions in spatial statistics
 
ICCF_2022_talk.pdf
ICCF_2022_talk.pdfICCF_2022_talk.pdf
ICCF_2022_talk.pdf
 

More from Delta Pi Systems

Introduction to the theory of optimization
Introduction to the theory of optimizationIntroduction to the theory of optimization
Introduction to the theory of optimizationDelta Pi Systems
 
Introduction to inverse problems
Introduction to inverse problemsIntroduction to inverse problems
Introduction to inverse problemsDelta Pi Systems
 
Introduction to Calculus of Variations
Introduction to Calculus of VariationsIntroduction to Calculus of Variations
Introduction to Calculus of VariationsDelta Pi Systems
 
Optimal control of coupled PDE networks with automated code generation
Optimal control of coupled PDE networks with automated code generationOptimal control of coupled PDE networks with automated code generation
Optimal control of coupled PDE networks with automated code generationDelta Pi Systems
 
Introduction to Grid Generation
Introduction to Grid GenerationIntroduction to Grid Generation
Introduction to Grid GenerationDelta Pi Systems
 
Οικονομικά οφέλη από προγράμματα διαχείρισης
Οικονομικά οφέλη από προγράμματα διαχείρισηςΟικονομικά οφέλη από προγράμματα διαχείρισης
Οικονομικά οφέλη από προγράμματα διαχείρισηςDelta Pi Systems
 
Agile development of processes and systems
Agile development of processes and systemsAgile development of processes and systems
Agile development of processes and systemsDelta Pi Systems
 
Optimization and control of processes and systems
Optimization and control of processes and systemsOptimization and control of processes and systems
Optimization and control of processes and systemsDelta Pi Systems
 

More from Delta Pi Systems (9)

Introduction to the theory of optimization
Introduction to the theory of optimizationIntroduction to the theory of optimization
Introduction to the theory of optimization
 
Introduction to inverse problems
Introduction to inverse problemsIntroduction to inverse problems
Introduction to inverse problems
 
Introduction to Calculus of Variations
Introduction to Calculus of VariationsIntroduction to Calculus of Variations
Introduction to Calculus of Variations
 
Optimal control of coupled PDE networks with automated code generation
Optimal control of coupled PDE networks with automated code generationOptimal control of coupled PDE networks with automated code generation
Optimal control of coupled PDE networks with automated code generation
 
Introduction to Grid Generation
Introduction to Grid GenerationIntroduction to Grid Generation
Introduction to Grid Generation
 
Οικονομικά οφέλη από προγράμματα διαχείρισης
Οικονομικά οφέλη από προγράμματα διαχείρισηςΟικονομικά οφέλη από προγράμματα διαχείρισης
Οικονομικά οφέλη από προγράμματα διαχείρισης
 
Agile development of processes and systems
Agile development of processes and systemsAgile development of processes and systems
Agile development of processes and systems
 
Optimization and control of processes and systems
Optimization and control of processes and systemsOptimization and control of processes and systems
Optimization and control of processes and systems
 
Outsourcing in Greece
Outsourcing in GreeceOutsourcing in Greece
Outsourcing in Greece
 

Recently uploaded

Orientation, design and principles of polyhouse
Orientation, design and principles of polyhouseOrientation, design and principles of polyhouse
Orientation, design and principles of polyhousejana861314
 
DIFFERENCE IN BACK CROSS AND TEST CROSS
DIFFERENCE IN  BACK CROSS AND TEST CROSSDIFFERENCE IN  BACK CROSS AND TEST CROSS
DIFFERENCE IN BACK CROSS AND TEST CROSSLeenakshiTyagi
 
Unlocking the Potential: Deep dive into ocean of Ceramic Magnets.pptx
Unlocking  the Potential: Deep dive into ocean of Ceramic Magnets.pptxUnlocking  the Potential: Deep dive into ocean of Ceramic Magnets.pptx
Unlocking the Potential: Deep dive into ocean of Ceramic Magnets.pptxanandsmhk
 
Animal Communication- Auditory and Visual.pptx
Animal Communication- Auditory and Visual.pptxAnimal Communication- Auditory and Visual.pptx
Animal Communication- Auditory and Visual.pptxUmerFayaz5
 
Chromatin Structure | EUCHROMATIN | HETEROCHROMATIN
Chromatin Structure | EUCHROMATIN | HETEROCHROMATINChromatin Structure | EUCHROMATIN | HETEROCHROMATIN
Chromatin Structure | EUCHROMATIN | HETEROCHROMATINsankalpkumarsahoo174
 
Spermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatidSpermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatidSarthak Sekhar Mondal
 
Botany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questionsBotany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questionsSumit Kumar yadav
 
TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...
TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...
TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...ssifa0344
 
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCRStunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCRDelhi Call girls
 
Broad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptxBroad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptxjana861314
 
Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)PraveenaKalaiselvan1
 
Disentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOSTDisentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOSTSérgio Sacani
 
Presentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptxPresentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptxgindu3009
 
Botany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdfBotany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdfSumit Kumar yadav
 
Natural Polymer Based Nanomaterials
Natural Polymer Based NanomaterialsNatural Polymer Based Nanomaterials
Natural Polymer Based NanomaterialsAArockiyaNisha
 
GBSN - Microbiology (Unit 1)
GBSN - Microbiology (Unit 1)GBSN - Microbiology (Unit 1)
GBSN - Microbiology (Unit 1)Areesha Ahmad
 
STERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCE
STERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCESTERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCE
STERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCEPRINCE C P
 
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptxSOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptxkessiyaTpeter
 
Cultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptxCultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptxpradhanghanshyam7136
 
Green chemistry and Sustainable development.pptx
Green chemistry  and Sustainable development.pptxGreen chemistry  and Sustainable development.pptx
Green chemistry and Sustainable development.pptxRajatChauhan518211
 

Recently uploaded (20)

Orientation, design and principles of polyhouse
Orientation, design and principles of polyhouseOrientation, design and principles of polyhouse
Orientation, design and principles of polyhouse
 
DIFFERENCE IN BACK CROSS AND TEST CROSS
DIFFERENCE IN  BACK CROSS AND TEST CROSSDIFFERENCE IN  BACK CROSS AND TEST CROSS
DIFFERENCE IN BACK CROSS AND TEST CROSS
 
Unlocking the Potential: Deep dive into ocean of Ceramic Magnets.pptx
Unlocking  the Potential: Deep dive into ocean of Ceramic Magnets.pptxUnlocking  the Potential: Deep dive into ocean of Ceramic Magnets.pptx
Unlocking the Potential: Deep dive into ocean of Ceramic Magnets.pptx
 
Animal Communication- Auditory and Visual.pptx
Animal Communication- Auditory and Visual.pptxAnimal Communication- Auditory and Visual.pptx
Animal Communication- Auditory and Visual.pptx
 
Chromatin Structure | EUCHROMATIN | HETEROCHROMATIN
Chromatin Structure | EUCHROMATIN | HETEROCHROMATINChromatin Structure | EUCHROMATIN | HETEROCHROMATIN
Chromatin Structure | EUCHROMATIN | HETEROCHROMATIN
 
Spermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatidSpermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatid
 
Botany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questionsBotany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questions
 
TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...
TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...
TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...
 
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCRStunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
 
Broad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptxBroad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptx
 
Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)
 
Disentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOSTDisentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOST
 
Presentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptxPresentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptx
 
Botany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdfBotany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdf
 
Natural Polymer Based Nanomaterials
Natural Polymer Based NanomaterialsNatural Polymer Based Nanomaterials
Natural Polymer Based Nanomaterials
 
GBSN - Microbiology (Unit 1)
GBSN - Microbiology (Unit 1)GBSN - Microbiology (Unit 1)
GBSN - Microbiology (Unit 1)
 
STERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCE
STERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCESTERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCE
STERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCE
 
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptxSOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
 
Cultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptxCultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptx
 
Green chemistry and Sustainable development.pptx
Green chemistry  and Sustainable development.pptxGreen chemistry  and Sustainable development.pptx
Green chemistry and Sustainable development.pptx
 

Introduction to CAGD for Inverse Problems

  • 1. Σ YSTEMS Introduction to Computer Aided Geometric Design (CAGD) for Inverse Problems Dimitrios Papadopoulos Delta Pi Systems Thessaloniki, Greece, 3 August 2014
  • 2. Σ YSTEMS Overview ◮ Problem formulation ◮ A minimization problem with PDEs as constraints ◮ Computational Grids ◮ Approximation and Interpolation ◮ B´ezier and B-spline curves ◮ Least squares approximation ◮ Smoothing and regularization ◮ Parametrization - finding a knot sequence ◮ Tensor product patches
  • 3. Σ YSTEMS Problem Formulation [Schlegel(2004)] ◮ Dynamic optimization problem min u(t),p,tf Φ = ΦM (y(tf )) + tf t0 ΦL(y(t), u(t), p, t)dt (1) subject to the Differential-Algebraic Equations (DAE) B(y(t), u(t), p, t) ˙y = f(y(t), u(t), p, t), t ∈ I (2) 0 = l( ˙y(t0), y(y0)), (3) 0 ≥ h(y(t), u(t), p, t), t ∈ I (4) 0 ≥ e(y(tf ) (5) where ◮ y(t) ∈ Rny state variables u(t) ∈ Rnu control variables p ∈ Rnp time-invariant parameters
  • 4. Σ YSTEMS Problem Formulation [Tr¨oltzsch(2005)] ◮ inverse problem min y(x) J = J(u(x), y(x), p, x) = [S(ω) − ˜S(ω)]2 dω (6) subject to F( ∂u ∂x1 , . . . , ∂u ∂xnx , u(x), y(x), p, x) = 0 (7) where ◮ x ∈ Rnx independent variables u(x) ∈ Rnu state variables y(x) ∈ Rny control variables p ∈ Rnp invariant parameters
  • 5. Σ YSTEMS Computational Grids ◮ State variables are discretized on the finite element grid ◮ Control variables are on both finite element and optimization grid ◮ Interpolation of the control variables from finite element grid to optimization grid ◮ Finite element grid is much finer than optimization grid so less variables enter the optimization procedure
  • 6. Σ YSTEMS Interpolation ◮ Bernstein polynomials (form a partition of unity) Bn i (t) = n i ti (1 − t)n−i (8) or recursively: Bn i (t) = (1 − t)Bn−1 i (t) + tBn−1 i−1 (t) (9) with B0 0(t) ≡ 1 Bn j (t) ≡ 0 forj /∈ {0, . . . , n} ◮ B´ezier curve (affine invariant) formed by control points bi b(t) = n i=0 biBn i (t) (10)
  • 7. Σ YSTEMS Interpolation (cntd) ◮ B-spline basis functions N0 i (t) = 1 if τi−1 ≤ t < τi 0 else , (11) Nn j (t) = t − τj−1 τj+n−1 − τj−1 Nn−1 j (t) + τj+n − t τj+n − τj Nn−1 j+1 (t), n > 1 (12) ◮ B-spline curve formed by control points ci b(t) = L j=0 cjNn j (t) (13)
  • 8. Σ YSTEMS Least Squares Approximation ◮ Given m + 1 data points d0, . . . , dm, each di being associated with a parameter value ti, find a polynomial curve b(t) of a given degree n such that minimize f(c1, . . . , cL) = m i=0 di − L j=0 cjNn j (ti) 2 (14) which leads to the following system (in case of L2 norm) NT NC = NT D (15) ◮ The data points are the control variables (concentration) discretized on the finite element grid and the control points cj are on the optimization grid.
  • 9. Σ YSTEMS Smoothing - Regularization ◮ minimize f(c1, . . . , cL) = P i=0 di − L j=0 cjNn j (ti) 2 + αS[b(ti)] ◮ second differences c0 − 2c1 + c2 = 0 ... (16) cL−2 − 2cL−1 + cL = 0 ◮ smoothing equations (1 − α)N αS C = (1 − α)D 0 (17) ◮ α allows a weighting between initial data fitting and smoothing
  • 10. Σ YSTEMS Parametrization - Finding a knot sequence ◮ uniform or equidistant (ti − ti−1)/(ti+1 − ti) = 1 (18) ◮ chord length ∆ti ∆ti+1 = ||∆di|| ||∆di+1|| (19) ◮ cetripetal ∆ti ∆ti+1 = ||∆di|| ||∆di+1|| 1/2 (20) ◮ Natural end conditions ¨b(t0) = 0, ¨b(tm) = 0 (21)
  • 11. Σ YSTEMS Tensor Product Patches [Farin(2002)] ◮ B´ezier surface bm,n (u, v) = m i=0 n j=0 bi,jBm i (u)Bn j (v) (22) ◮ B-spline surface bm,n (u, v) = m i=0 n j=0 ci,jNm i (u)Nn j (v) (23) ◮ A surface with the topology of a sphere is not representable as a tensor product surface, without degeneracies
  • 12. Σ YSTEMS Parametrization of surfaces ◮ Project the data points into a plane, i.e. drop the z-coordinate and fit into the unit square. ◮ For each point find a good initial guess, and perform Newton iteration until convergence is reached. ◮ Can be generalized to 4-dimensional hypersurface for the case of a 3-dimensional problem. ◮ Triangulation of data points based on graph theory. ◮ End conditions involve partial derivatives of the surface.
  • 13. Σ YSTEMS Synopsis - Outlook Synopsis ◮ Inverse problem as a minimization problem with PDEs as constaints ◮ Optimization grid much smaller than the finite element grid ◮ Interpolation with B´ezier and B-spline curves ◮ Smoothing ◮ Different parametrization methods ◮ Natural end conditions Outlook ◮ For a 3D space-time, a 5-dimensional hypersurface would be needed, ◮ tensor product approach is easily generalized, ◮ a projection and Newton iteration can also be generalized. ◮ NURBS curves & patches [Piegl and Tiller(1997)]
  • 14. Σ YSTEMS Bibliography Farin, G., 2002. Curves and Surfaces for CAGD: A Practical Guide. Academic Press. Piegl, L. A., Tiller, W., 1997. The NURBS Book. Springer Science and Business Media. Schlegel, M., 2004. Adaptive discretization methods for the efficient solution of dynamic optimization problems. Ph.D. thesis, RWTH Aachen. Tr¨oltzsch, F., 2005. Optimale Steuerung partieller Differentialgleichungen: Theorie, Verfahren und Anwendungen. Vieweg.