Introduction into Implementation of Optimization problems with PDEs: Sheet 3

Size: px
Start display at page:

Download "Introduction into Implementation of Optimization problems with PDEs: Sheet 3"

Transcription

1 Technische Universität München Center for Mathematical Sciences, M17 Lucas Bonifacius, Korbinian Singhammer www-m17.ma.tum.de/lehrstuhl/lehresose16labcourseoptpde Summer 216 Introduction into Implementation of Optimization problems with PDEs: Sheet 3 Exercise 3.1 (State constraints): to point-wise state constraints We consider the linear quadratic elliptic problem subject min J(q, u) = 1 q L 2 (Ω), u H 1 (Ω) 2 u u d 2 L 2 (Ω) + α 2 q 2 L 2 (Ω) u + u = q in Ω, subject to n u = on Ω u u a in Ω. (1a) (1b) The domain is the square Ω = ( 1, 1) ( 1, 1), we take u d (x) = cos (πx 1 ) x 2, α = 1 3 and the state constraint is given by u a.4. We eliminate the state constraint by adding a Moreau-Yosida type regularization term with parameter γ to the objective functional min J(q γ, u γ ) + γ (max{, u a u γ }) 3 dx q γ L 2 (Ω), u γ H 1 (Ω) 3 Ω { uγ + u γ = q γ in Ω, subject to n u γ = on Ω. The corresponding optimality condition reads as ū γ + ū γ = q γ in Ω, n ū γ = on Ω, z γ + z γ = ū γ u d γ max{, u a ū γ } 2 in Ω, n z γ = on Ω, α q γ + z γ = in Ω. (2) Since (2) is a non-linear system we want to solve it by the Newton method. For that we follow the same steps as in Exercise.3 but now with the two variables u and z. a) First, substitute q γ in the state equation by the gradient condition α q γ + z γ =. Then, write down the weak forms of the corresponding equations of (2) such that the weak solutions to (2) are the roots of the residual r : H 1 (Ω) H 1 (Ω) H 1 (Ω) H 1 (Ω) with r(x γ )(ϕ) = where x γ = (u γ, z γ ) and ϕ = (ϕ u, ϕ z ). [ ] ru (u γ, z γ )(ϕ u ), (3) r z (u γ, z γ )(ϕ z ) 1/8

2 b) We use Newton s method on the residual. Formulate a Newton step by calculating the partial derivatives of the residuals in (3), i.e., r (x γ )(ϕ)(δx) = ( ) uγ r u (x γ )(ϕ u )(δx u ) zγ r u (x γ )(ϕ u )(δx z ) = r(x uγ r z (x γ )(ϕ z )(δx u ) zγ r z (x γ )(ϕ z )(δx z ) γ )(ϕ). (4) c) Discretize the state and adjoint state with piecewise linear finite elements (as before) and use the variational control discretization. Accordingly, we discretize (4). Write the discrete Newton step as system of linear equations of the form ( ) ( ) ( ) Auu A uz dxu ru =. (5) dx z r z A zu A zz Here, for example, A uu and A zu stand for uγ r u (u γ, z γ )(ϕ)(δu γ ) and zγ r u (u γ, z γ )(ϕ)(δu γ ), respectively. Implement all required forms and assemble the matrices and vectors. d) As a first plausibility check, set γ = and solve the optimization problem. This corresponds to the optimal control problem without state constraints. How many Newton steps should your implementation need to converge? e) To test your implementation, you can successively increase the regularization parameter γ, say γ = 1, 1, 1, 1. Determine for each choice the minimal value of ū γ. For γ = 1 3, your solution should look like Figure 1. 1 Control 1 State Figure 1: Optimal control q γh and state ū γh for γ = 1 6, u a.4 and 8 mesh refines We would like to investigate the dependence of the regularization parameter γ and the mesh parameter h on the approximation error q q γh L 2 (Ω) and ū ū γh L 2 (Ω). f) Since we do not know the analytical solution, we have to compute first a reference solution on a sufficiently fine grid. As we expect the solution on the coarser grid to be an approximation to the solution on the finer grid, we can use the solution of the preceding iteration as an initial value for the next to improve the performance of the algorithm. You can use [meshref, u_1,..., u_n] = uniforminterpolate(meshref, u_1,..., u_n); to uniformly refine the mesh and interpolate the functions u_1 to u_n on the resulting mesh. 2/8

3 Then calculate a solution of the regularized problem as above. It is useful to wrap the solution of the optimality system in a separate function function [u, z, q] = solveoptimalitysystem(mesh, u, z, gamma, ua, alpha) with u in the function arguments being the initial value. Use γ = N with N the number of nodes. g) Solve the regularized problem for a the regularization parameters γ = 1, 5, 25, 125,..., 5 1 and on a sequence of uniformly refined meshes with prerefine 2, 3,..., 8. As before, use the function uniforminterpolate to use the solution of the preceding iteration as the initial value for the problem on the finer grid. h) In each iteration, compute the L 2 -errors q q γh L 2 (Ω) and ū ū γh L 2 (Ω) using the function ComputeError and store the values in a matrix. Plot the error with respect to the regularization parameter as in Figure 2. Describe qualitatively the coupling of γ and h. i) Can we replace the regularization term by γ 2 Ω (max{, u a u γ }) 2 without further modifications? For a possible solution see also Exercise 3.3 (Bonus) q qγh h =.5 h =.25 h =.125 h =.62 h =.31 h = γ h =.5 h =.25 h =.125 h =.62 h =.31 h = γ ū ūγh Figure 2: L 2 -error for the control (left) and the state (right) for different spatial discretizations and regularization parameter γ Exercise 3.2 (Finite dimensional control and inverse problem): The intention of this exercise is to show that optimal control problems have a wide of range of applications and we should not be too strict with the term control. Assume we are given some conducting material where the electrical conduction depends on the direction (orthotropic), e.g. graphite. We suppose that the exact conduction coefficients are unknown. For simplicity the material sample is of infinite length with cross-section Ω R 2. On two boundary parts Γ 1, Γ 2 Ω we apply a potential that in turn induces a current encoded in the functions f 1, f 2 H 1 (Ω). Let u denote the electrical potential. The lower part Γ Ω is 3/8

4 connected to ground, i.e. u Γ =. The remaining boundary parts are isolated, i.e. n u =. The shape is visualized in Figure 3. Furthermore, we are given measurements c d R 2 and an observation operator that maps the electrical potential to the observation. From this we can formulate the following optimization problem min J(q, u) = 1 q R 2, u H 1 (Ω) 2 Cu c d 2 R 2 A(q)u = in Ω, (6a) subject to u = on Γ n u = f 1 on Γ 1 (6b) n u = f 2 on Γ 2 n u = on Ω \ (Γ Γ 1 Γ 2 ), where A(q) with q R 2 is the differential operator A(q)u, ϕ = q 1 x1 u x1 ϕ + q 2 x2 u x2 ϕ, where Ω H 1 Γ (Ω) = { } ϕ H 1 (Ω): ϕ Γ =. u, ϕ H 1 Γ (Ω), In the examples considered so far the materials where isotropic, i.e. the diffusion was independent of the spatial direction. Here, A(q) models orthotropic materials. For well-posedness of the state equation we have to require that q >, otherwise the operator A(q) would not be elliptic. For simplicity we ignore this control constraint. Moreover, the observation operator C = (C 1, C 2 ) is given by C 1 u = u, Ω 1 C 2 u = u, Ω 2 with the observation domains We take f 1 = 5 and f 2 = 5. Ω 1 = {x Ω : x 1 <.5} Ω 2 = {x Ω : x 1 > 7.5}. The diffusion parameters q 1 and q 2 are unknown and should be estimated from the measurements c d R 2. Whence, in this setting the searched control is the pair of parameters q 1 and q 2. a) In order to optimize, we would like to have an expression for the gradient. We will use the Lagrange formalism and define the bilinear form a(q, u)(ϕ) = A(q)u, ϕ for all ϕ H 1 Γ (Ω). For all z H 1 Γ (Ω) it holds j(q) = J(q, u) = 1 2 Cu c d 2 R Γ 2 a(q, u)(z) + f 1 z + f 2 z. 1 Γ 2 Differentiate the equation above with respect to q. Verify that j (q)(δq) = (Cu c d, Cδu) a q(q, u)(δq, z) a u(q, u)(δu, z), 4/8

5 Figure 3: Mesh of cross section of the material with boundary parts. where δu = S (q)δq. Define z H 1 Γ (Ω) such that a u(q, u)(ϕ, z) = (C (Cu c d ), ϕ), ϕ H 1 Γ (Ω), to find an expression for j(q). Determine C, a q(q, u) and a u(q, u). Alternatively, you can use the operator approach. Convince yourself that A is continuously Fréchet differentiable and verify that δu = S (q)δq is the solution to Show that A(q)δu = A (q)(u, δq) in Ω, u = on Γ n u = on Γ 1 n u = on Γ 2 n u = on Ω \ (Γ Γ 1 Γ 2 ). j (q)(δq) = (S (q) C (CS(q) c d ), δq) R 2 = ( [A (q)(u)] [A(q) 1 ] C (CS(q) c d ), δq) R 2. We define z = [A(q) 1 ] C (CS(q) c d ) to be the adjoint state. Determine A (q)(u). b) On the computer, we first have to specify the mesh. The strength of the finite element method is that it can handle complex domains easily. Use the command [node, elem] = loadmesh( material.msh ); to load all the nodes and cells from a file. To specify the boundary, you can either enter the indices of the nodes (as we did before for the unit square) or you can give a logical expression, which is more convenient in this case. To select the boundary on the left-hand side, enter boundary = Boundary( near(x,)); The function near returns true, if x is close to the value specified in the second argument. Due to numerical errors we cannot just use x ==. You can define multiple boundary pieces as follows boundary = Boundary( gamma1, [..], gamma2, [..],..); The command visusimple(mesh) will plot the mesh as well as the boundary parts in different colors. Compare with Figure (3). 5/8

6 State 4 State Figure 4: Electrical potential for conduction parameters q = (5,.2) (left) and q = (1, 1) (right). c) Write a function u = solvestate(q, args) that solves the state equation. The operator A(q) can be incorporated by modifying the function handle. Pass the parameter q via data.param to the handle. Since the values of the solution on the Dirichlet boundary part are fixed, solve the problem on the nodes that belong to the interior and to the Neumann boundary parts only. Because the set of the non Dirichlet nodes will be used frequently, we stored them in args.inner. Solve the (reduced) linear system as follows u = zeros(n,1); u(args.inner) = A(args.inner,args.inner)\args.Mf(args.inner); Solve the state equation for different q and compare with Figure 4. Now, we solve the parameter estimation problem numerically. e) Implement C and C. You can use the function data) to integrate over the domain Ω, where func has the signature function g = func(data). f) To estimate the parameters q 1 and q 2, we require measurements c d. For testing purposes, solve the state equation for q ref = (5,.2) and store the observation value in args.cd. g) Implement a function z = solveadjoint(q, u, args) that solves the discrete adjoint equation for a given state u h. h) Implement a function g = computejp(q, u, z, args) that calculates the discrete gradient of j. You have to write the function handles a_q1 and a_q2 to calculate a q(q, u)(ϕ, z) resp. A (q)(u). i) Verify the correctness of your implementation so far using args); j) Use the gradient descent @computejp, args); with initial value q = (5.5, 1.6) to solve the optimization problem. Remember that you have to pass the initial value via args.q_. Calculate the error between q ref and q h obtained from the optimization. What went wrong? 6/8

7 k) Suggest new observation domains Ω 1 and Ω 2 to improve the error q ref q h. l) Can we omit the earthing, i.e. can we replace the homogeneous Dirichlet boundary condition on Γ by say homogeneous Neumann boundary conditions? Exercise 3.3 (State constraints with primal-dual active set method (Bonus)): Instead of adding a cubic term to the objective functional, we now add a quadratic regularization term to eliminate the state constraint min J(q γ, u γ ) + γ (max{, u a u γ }) 2 dx q γ L 2 (Ω), u γ H 1 (Ω) 2 Ω { uγ + u γ = q γ in Ω, subject to n u γ = on Ω. The corresponding optimality condition reads as ū γ + ū γ = q γ in Ω, n ū γ = on Ω, z γ + z γ = ū γ u d γ max{, u a ū γ } in Ω, n z γ = on Ω, α q γ + z γ = in Ω. (7) a) We discretize again the state and adjoint state with piecewise linear finite elements (as before) and use the variational control discretization. Find the discrete optimality condition to (7) with matrices A and M and a vector u d such that Az = Mu u d γm max{, u a u}, Au = 1 α Mz. (8) b) The system (8) is nonlinear and nonsmooth. Therefore, we use the primal-dual active set strategy. Select arbitrary initial values u and z. In each iteration, we calculate the active set as { } A n = i {1,..., M}: ui n 1 u a <. Write as a system of linear equations ( ) ( ) ( ) M + MAn A z MAn u A 1 α M = a + u d, (9) u with an appropriate matrix M An. Solve the linear system using the backslash operator in Matlab. Terminate the iteration, if the active set does not change, i.e. A n = A n 1. c) Solve the regularized problem for a the regularization parameters γ = 5, 25,...,..., 5 1 and on a sequence of uniformly refined meshes with prerefine 2, 3,..., 8. As before, use the function uniforminterpolate to use the solution of the preceding iteration as the initial value for the problem on the finer grid. d) In each iteration, compute the L 2 -errors q q γh L 2 (Ω) and ū ū γh L 2 (Ω) using the function ComputeError and store the values in a matrix. Plot the error with respect to the regularization parameter as in Figure 5. 7/8

8 e) Recommend a choice for γ (depending on h) based your numerical observation. Use for h the length of the shortest side of the triangle. Since we have a uniform triangulation, all measures for h are equivalent. f) It can be shown that there is a constant C > such that q q γh 2 L 2 (Ω) C(h + γ 1 h 1 ), see [1, Corollary 3.8]. Determine the optimal choice of γ from the estimate above. Compare the rate of convergence (with respect to γ) with your numerical observation. Is the estimate sharp (for this example)? q qγh h =.25 h =.125 h =.62 h =.31 h =.16 h =.8 O(γ 1/2 ) γ h =.25 h =.125 h =.62 h =.31 h =.16 h =.8 O(γ 1 ) γ ū ūγh Figure 5: L 2 -error for the control (left) and the state (right) for different spatial discretizations and regularization parameter γ Further Reading [1] M. Hintermüller and M. Hinze. Moreau-Yosida regularization in state constrained elliptic control problems: error estimates and parameter adjustment. In: SIAM J. Numer. Anal (29), pp issn: /8

Hamburger Beiträge zur Angewandten Mathematik

Hamburger Beiträge zur Angewandten Mathematik Hamburger Beiträge zur Angewandten Mathematik Numerical analysis of a control and state constrained elliptic control problem with piecewise constant control approximations Klaus Deckelnick and Michael

More information

Solving PDEs with freefem++

Solving PDEs with freefem++ Solving PDEs with freefem++ Tutorials at Basque Center BCA Olivier Pironneau 1 with Frederic Hecht, LJLL-University of Paris VI 1 March 13, 2011 Do not forget That everything about freefem++ is at www.freefem.org

More information

Affine covariant Semi-smooth Newton in function space

Affine covariant Semi-smooth Newton in function space Affine covariant Semi-smooth Newton in function space Anton Schiela March 14, 2018 These are lecture notes of my talks given for the Winter School Modern Methods in Nonsmooth Optimization that was held

More information

Convergence Order Studies for Elliptic Test Problems with COMSOL Multiphysics

Convergence Order Studies for Elliptic Test Problems with COMSOL Multiphysics Convergence Order Studies for Elliptic Test Problems with COMSOL Multiphysics Shiming Yang and Matthias K. Gobbert Abstract. The convergence order of finite elements is related to the polynomial order

More information

Adaptive methods for control problems with finite-dimensional control space

Adaptive methods for control problems with finite-dimensional control space Adaptive methods for control problems with finite-dimensional control space Saheed Akindeinde and Daniel Wachsmuth Johann Radon Institute for Computational and Applied Mathematics (RICAM) Austrian Academy

More information

SUPERCONVERGENCE PROPERTIES FOR OPTIMAL CONTROL PROBLEMS DISCRETIZED BY PIECEWISE LINEAR AND DISCONTINUOUS FUNCTIONS

SUPERCONVERGENCE PROPERTIES FOR OPTIMAL CONTROL PROBLEMS DISCRETIZED BY PIECEWISE LINEAR AND DISCONTINUOUS FUNCTIONS SUPERCONVERGENCE PROPERTIES FOR OPTIMAL CONTROL PROBLEMS DISCRETIZED BY PIECEWISE LINEAR AND DISCONTINUOUS FUNCTIONS A. RÖSCH AND R. SIMON Abstract. An optimal control problem for an elliptic equation

More information

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs Chapter Two: Numerical Methods for Elliptic PDEs Finite Difference Methods for Elliptic PDEs.. Finite difference scheme. We consider a simple example u := subject to Dirichlet boundary conditions ( ) u

More information

Basic Principles of Weak Galerkin Finite Element Methods for PDEs

Basic Principles of Weak Galerkin Finite Element Methods for PDEs Basic Principles of Weak Galerkin Finite Element Methods for PDEs Junping Wang Computational Mathematics Division of Mathematical Sciences National Science Foundation Arlington, VA 22230 Polytopal Element

More information

Key words. preconditioned conjugate gradient method, saddle point problems, optimal control of PDEs, control and state constraints, multigrid method

Key words. preconditioned conjugate gradient method, saddle point problems, optimal control of PDEs, control and state constraints, multigrid method PRECONDITIONED CONJUGATE GRADIENT METHOD FOR OPTIMAL CONTROL PROBLEMS WITH CONTROL AND STATE CONSTRAINTS ROLAND HERZOG AND EKKEHARD SACHS Abstract. Optimality systems and their linearizations arising in

More information

LECTURE 1: SOURCES OF ERRORS MATHEMATICAL TOOLS A PRIORI ERROR ESTIMATES. Sergey Korotov,

LECTURE 1: SOURCES OF ERRORS MATHEMATICAL TOOLS A PRIORI ERROR ESTIMATES. Sergey Korotov, LECTURE 1: SOURCES OF ERRORS MATHEMATICAL TOOLS A PRIORI ERROR ESTIMATES Sergey Korotov, Institute of Mathematics Helsinki University of Technology, Finland Academy of Finland 1 Main Problem in Mathematical

More information

FEM Convergence for PDEs with Point Sources in 2-D and 3-D

FEM Convergence for PDEs with Point Sources in 2-D and 3-D FEM Convergence for PDEs with Point Sources in -D and 3-D Kourosh M. Kalayeh 1, Jonathan S. Graf, and Matthias K. Gobbert 1 Department of Mechanical Engineering, University of Maryland, Baltimore County

More information

A framework for the adaptive finite element solution of large inverse problems. I. Basic techniques

A framework for the adaptive finite element solution of large inverse problems. I. Basic techniques ICES Report 04-39 A framework for the adaptive finite element solution of large inverse problems. I. Basic techniques Wolfgang Bangerth Center for Subsurface Modeling, Institute for Computational Engineering

More information

Goal-oriented error control of the iterative solution of finite element equations

Goal-oriented error control of the iterative solution of finite element equations J. Numer. Math., Vol. 0, No. 0, pp. 1 31 (2009) DOI 10.1515/ JNUM.2009.000 c de Gruyter 2009 Prepared using jnm.sty [Version: 20.02.2007 v1.3] Goal-oriented error control of the iterative solution of finite

More information

Hamburger Beiträge zur Angewandten Mathematik

Hamburger Beiträge zur Angewandten Mathematik Hamburger Beiträge zur Angewandten Mathematik A finite element approximation to elliptic control problems in the presence of control and state constraints Klaus Deckelnick and Michael Hinze Nr. 2007-0

More information

A Posteriori Estimates for Cost Functionals of Optimal Control Problems

A Posteriori Estimates for Cost Functionals of Optimal Control Problems A Posteriori Estimates for Cost Functionals of Optimal Control Problems Alexandra Gaevskaya, Ronald H.W. Hoppe,2 and Sergey Repin 3 Institute of Mathematics, Universität Augsburg, D-8659 Augsburg, Germany

More information

A Priori Error Analysis for Space-Time Finite Element Discretization of Parabolic Optimal Control Problems

A Priori Error Analysis for Space-Time Finite Element Discretization of Parabolic Optimal Control Problems A Priori Error Analysis for Space-Time Finite Element Discretization of Parabolic Optimal Control Problems D. Meidner and B. Vexler Abstract In this article we discuss a priori error estimates for Galerkin

More information

Priority Program 1253

Priority Program 1253 Deutsche Forschungsgemeinschaft Priority Program 1253 Optimization with Partial Differential Equations Klaus Deckelnick and Michael Hinze A note on the approximation of elliptic control problems with bang-bang

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Discretization of Boundary Conditions Discretization of Boundary Conditions On

More information

Simple Examples on Rectangular Domains

Simple Examples on Rectangular Domains 84 Chapter 5 Simple Examples on Rectangular Domains In this chapter we consider simple elliptic boundary value problems in rectangular domains in R 2 or R 3 ; our prototype example is the Poisson equation

More information

A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems

A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems Etereldes Gonçalves 1, Tarek P. Mathew 1, Markus Sarkis 1,2, and Christian E. Schaerer 1 1 Instituto de Matemática Pura

More information

Finite Elements for Nonlinear Problems

Finite Elements for Nonlinear Problems Finite Elements for Nonlinear Problems Computer Lab 2 In this computer lab we apply finite element method to nonlinear model problems and study two of the most common techniques for solving the resulting

More information

FINITE DIFFERENCE METHODS (II): 1D EXAMPLES IN MATLAB

FINITE DIFFERENCE METHODS (II): 1D EXAMPLES IN MATLAB 1.723 - COMPUTATIONAL METHODS FOR FLOW IN POROUS MEDIA Spring 2009 FINITE DIFFERENCE METHODS (II): 1D EXAMPLES IN MATLAB Luis Cueto-Felgueroso 1. COMPUTING FINITE DIFFERENCE WEIGHTS The function fdcoefs

More information

TMA4220: Programming project - part 1

TMA4220: Programming project - part 1 TMA4220: Programming project - part 1 TMA4220 - Numerical solution of partial differential equations using the finite element method The programming project will be split into two parts. This is the first

More information

Scientific Computing I

Scientific Computing I Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Neckel Winter 2013/2014 Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 1 Part I: Introduction to

More information

Constrained Minimization and Multigrid

Constrained Minimization and Multigrid Constrained Minimization and Multigrid C. Gräser (FU Berlin), R. Kornhuber (FU Berlin), and O. Sander (FU Berlin) Workshop on PDE Constrained Optimization Hamburg, March 27-29, 2008 Matheon Outline Successive

More information

Iterative Methods for Linear Systems

Iterative Methods for Linear Systems Iterative Methods for Linear Systems 1. Introduction: Direct solvers versus iterative solvers In many applications we have to solve a linear system Ax = b with A R n n and b R n given. If n is large the

More information

Kasetsart University Workshop. Multigrid methods: An introduction

Kasetsart University Workshop. Multigrid methods: An introduction Kasetsart University Workshop Multigrid methods: An introduction Dr. Anand Pardhanani Mathematics Department Earlham College Richmond, Indiana USA pardhan@earlham.edu A copy of these slides is available

More information

Semismooth Newton Methods for an Optimal Boundary Control Problem of Wave Equations

Semismooth Newton Methods for an Optimal Boundary Control Problem of Wave Equations Semismooth Newton Methods for an Optimal Boundary Control Problem of Wave Equations Axel Kröner 1 Karl Kunisch 2 and Boris Vexler 3 1 Lehrstuhl für Mathematische Optimierung Technische Universität München

More information

K. Krumbiegel I. Neitzel A. Rösch

K. Krumbiegel I. Neitzel A. Rösch SUFFICIENT OPTIMALITY CONDITIONS FOR THE MOREAU-YOSIDA-TYPE REGULARIZATION CONCEPT APPLIED TO SEMILINEAR ELLIPTIC OPTIMAL CONTROL PROBLEMS WITH POINTWISE STATE CONSTRAINTS K. Krumbiegel I. Neitzel A. Rösch

More information

Numerical algorithms for one and two target optimal controls

Numerical algorithms for one and two target optimal controls Numerical algorithms for one and two target optimal controls Sung-Sik Kwon Department of Mathematics and Computer Science, North Carolina Central University 80 Fayetteville St. Durham, NC 27707 Email:

More information

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C.

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C. Lecture 9 Approximations of Laplace s Equation, Finite Element Method Mathématiques appliquées (MATH54-1) B. Dewals, C. Geuzaine V1.2 23/11/218 1 Learning objectives of this lecture Apply the finite difference

More information

Preconditioned space-time boundary element methods for the heat equation

Preconditioned space-time boundary element methods for the heat equation W I S S E N T E C H N I K L E I D E N S C H A F T Preconditioned space-time boundary element methods for the heat equation S. Dohr and O. Steinbach Institut für Numerische Mathematik Space-Time Methods

More information

University of Illinois at Urbana-Champaign College of Engineering

University of Illinois at Urbana-Champaign College of Engineering University of Illinois at Urbana-Champaign College of Engineering CEE 570 Finite Element Methods (in Solid and Structural Mechanics) Spring Semester 2014 Quiz #2 April 14, 2014 Name: SOLUTION ID#: PS1.:

More information

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES)

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) RAYTCHO LAZAROV 1 Notations and Basic Functional Spaces Scalar function in R d, d 1 will be denoted by u,

More information

13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs)

13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs) 13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs) A prototypical problem we will discuss in detail is the 1D diffusion equation u t = Du xx < x < l, t > finite-length rod u(x,

More information

Maximum norm estimates for energy-corrected finite element method

Maximum norm estimates for energy-corrected finite element method Maximum norm estimates for energy-corrected finite element method Piotr Swierczynski 1 and Barbara Wohlmuth 1 Technical University of Munich, Institute for Numerical Mathematics, piotr.swierczynski@ma.tum.de,

More information

Algorithms for Scientific Computing

Algorithms for Scientific Computing Algorithms for Scientific Computing Finite Element Methods Michael Bader Technical University of Munich Summer 2016 Part I Looking Back: Discrete Models for Heat Transfer and the Poisson Equation Modelling

More information

1.The anisotropic plate model

1.The anisotropic plate model Pré-Publicações do Departamento de Matemática Universidade de Coimbra Preprint Number 6 OPTIMAL CONTROL OF PIEZOELECTRIC ANISOTROPIC PLATES ISABEL NARRA FIGUEIREDO AND GEORG STADLER ABSTRACT: This paper

More information

An optimal control problem for a parabolic PDE with control constraints

An optimal control problem for a parabolic PDE with control constraints An optimal control problem for a parabolic PDE with control constraints PhD Summer School on Reduced Basis Methods, Ulm Martin Gubisch University of Konstanz October 7 Martin Gubisch (University of Konstanz)

More information

DISCRETE MAXIMUM PRINCIPLES in THE FINITE ELEMENT SIMULATIONS

DISCRETE MAXIMUM PRINCIPLES in THE FINITE ELEMENT SIMULATIONS DISCRETE MAXIMUM PRINCIPLES in THE FINITE ELEMENT SIMULATIONS Sergey Korotov BCAM Basque Center for Applied Mathematics http://www.bcamath.org 1 The presentation is based on my collaboration with several

More information

Weak form of Boundary Value Problems. Simulation Methods in Acoustics

Weak form of Boundary Value Problems. Simulation Methods in Acoustics Weak form of Boundary Value Problems Simulation Methods in Acoustics Note on finite dimensional description of functions Approximation: N f (x) ˆf (x) = q j φ j (x) j=1 Residual function: r(x) = f (x)

More information

Goal-oriented error control of the iterative solution of finite element equations

Goal-oriented error control of the iterative solution of finite element equations J. Numer. Math., Vol. 17, No. 2, pp. 143 172 (2009) DOI 10.1515/ JNUM.2009.009 c de Gruyter 2009 Goal-oriented error control of the iterative solution of finite element equations D. MEIDNER, R. RANNACHER,

More information

Numerical Solution of a Coefficient Identification Problem in the Poisson equation

Numerical Solution of a Coefficient Identification Problem in the Poisson equation Swiss Federal Institute of Technology Zurich Seminar for Applied Mathematics Department of Mathematics Bachelor Thesis Spring semester 2014 Thomas Haener Numerical Solution of a Coefficient Identification

More information

A Finite Element Method Using Singular Functions for Poisson Equations: Mixed Boundary Conditions

A Finite Element Method Using Singular Functions for Poisson Equations: Mixed Boundary Conditions A Finite Element Method Using Singular Functions for Poisson Equations: Mixed Boundary Conditions Zhiqiang Cai Seokchan Kim Sangdong Kim Sooryun Kong Abstract In [7], we proposed a new finite element method

More information

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V Part I: Introduction to Finite Element Methods Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Necel Winter 4/5 The Model Problem FEM Main Ingredients Wea Forms and Wea

More information

Supraconvergence of a Non-Uniform Discretisation for an Elliptic Third-Kind Boundary-Value Problem with Mixed Derivatives

Supraconvergence of a Non-Uniform Discretisation for an Elliptic Third-Kind Boundary-Value Problem with Mixed Derivatives Supraconvergence of a Non-Uniform Discretisation for an Elliptic Third-Kind Boundary-Value Problem with Mixed Derivatives Etienne Emmrich Technische Universität Berlin, Institut für Mathematik, Straße

More information

Convergence of a finite element approximation to a state constrained elliptic control problem

Convergence of a finite element approximation to a state constrained elliptic control problem Als Manuskript gedruckt Technische Universität Dresden Herausgeber: Der Rektor Convergence of a finite element approximation to a state constrained elliptic control problem Klaus Deckelnick & Michael Hinze

More information

Technische Universität Graz

Technische Universität Graz Technische Universität Graz Error Estimates for Neumann Boundary Control Problems with Energy Regularization T. Apel, O. Steinbach, M. Winkler Berichte aus dem Institut für Numerische Mathematik Bericht

More information

A posteriori error estimation for elliptic problems

A posteriori error estimation for elliptic problems A posteriori error estimation for elliptic problems Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in

More information

An Iterative Substructuring Method for Mortar Nonconforming Discretization of a Fourth-Order Elliptic Problem in two dimensions

An Iterative Substructuring Method for Mortar Nonconforming Discretization of a Fourth-Order Elliptic Problem in two dimensions An Iterative Substructuring Method for Mortar Nonconforming Discretization of a Fourth-Order Elliptic Problem in two dimensions Leszek Marcinkowski Department of Mathematics, Warsaw University, Banacha

More information

Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses

Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses P. Boyanova 1, I. Georgiev 34, S. Margenov, L. Zikatanov 5 1 Uppsala University, Box 337, 751 05 Uppsala,

More information

Boundary Value Problems and Iterative Methods for Linear Systems

Boundary Value Problems and Iterative Methods for Linear Systems Boundary Value Problems and Iterative Methods for Linear Systems 1. Equilibrium Problems 1.1. Abstract setting We want to find a displacement u V. Here V is a complete vector space with a norm v V. In

More information

Finite Difference Methods for Boundary Value Problems

Finite Difference Methods for Boundary Value Problems Finite Difference Methods for Boundary Value Problems October 2, 2013 () Finite Differences October 2, 2013 1 / 52 Goals Learn steps to approximate BVPs using the Finite Difference Method Start with two-point

More information

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1 Scientific Computing WS 2017/2018 Lecture 18 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 18 Slide 1 Lecture 18 Slide 2 Weak formulation of homogeneous Dirichlet problem Search u H0 1 (Ω) (here,

More information

Finite Difference Methods (FDMs) 1

Finite Difference Methods (FDMs) 1 Finite Difference Methods (FDMs) 1 1 st - order Approxima9on Recall Taylor series expansion: Forward difference: Backward difference: Central difference: 2 nd - order Approxima9on Forward difference: Backward

More information

A stabilized finite element method for the convection dominated diffusion optimal control problem

A stabilized finite element method for the convection dominated diffusion optimal control problem Applicable Analysis An International Journal ISSN: 0003-6811 (Print) 1563-504X (Online) Journal homepage: http://www.tandfonline.com/loi/gapa20 A stabilized finite element method for the convection dominated

More information

Numerische Mathematik

Numerische Mathematik Numer. Math. (997) 76: 479 488 Numerische Mathematik c Springer-Verlag 997 Electronic Edition Exponential decay of C cubic splines vanishing at two symmetric points in each knot interval Sang Dong Kim,,

More information

A Multigrid Method for Two Dimensional Maxwell Interface Problems

A Multigrid Method for Two Dimensional Maxwell Interface Problems A Multigrid Method for Two Dimensional Maxwell Interface Problems Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University USA JSA 2013 Outline A

More information

Numerical Programming I (for CSE)

Numerical Programming I (for CSE) Technische Universität München WT 1/13 Fakultät für Mathematik Prof. Dr. M. Mehl B. Gatzhammer January 1, 13 Numerical Programming I (for CSE) Tutorial 1: Iterative Methods 1) Relaxation Methods a) Let

More information

High order, finite volume method, flux conservation, finite element method

High order, finite volume method, flux conservation, finite element method FLUX-CONSERVING FINITE ELEMENT METHODS SHANGYOU ZHANG, ZHIMIN ZHANG, AND QINGSONG ZOU Abstract. We analyze the flux conservation property of the finite element method. It is shown that the finite element

More information

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA Introduction to Finite and Spectral Element Methods Using MATLAB Second Edition C. Pozrikidis University of Massachusetts Amherst, USA (g) CRC Press Taylor & Francis Group Boca Raton London New York CRC

More information

Numerical Analysis and Methods for PDE I

Numerical Analysis and Methods for PDE I Numerical Analysis and Methods for PDE I A. J. Meir Department of Mathematics and Statistics Auburn University US-Africa Advanced Study Institute on Analysis, Dynamical Systems, and Mathematical Modeling

More information

Continuous adjoint based error estimation and r-refinement for the active-flux method

Continuous adjoint based error estimation and r-refinement for the active-flux method Continuous adjoint based error estimation and r-refinement for the active-flux method Kaihua Ding, Krzysztof J. Fidkowski and Philip L. Roe Department of Aerospace Engineering, University of Michigan,

More information

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS JASON ALBRIGHT, YEKATERINA EPSHTEYN, AND QING XIA Abstract. Highly-accurate numerical methods that can efficiently

More information

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends Lecture 3: Finite Elements in 2-D Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Finite Element Methods 1 / 18 Outline 1 Boundary

More information

Ultraconvergence of ZZ Patch Recovery at Mesh Symmetry Points

Ultraconvergence of ZZ Patch Recovery at Mesh Symmetry Points Ultraconvergence of ZZ Patch Recovery at Mesh Symmetry Points Zhimin Zhang and Runchang Lin Department of Mathematics, Wayne State University Abstract. The ultraconvergence property of the Zienkiewicz-Zhu

More information

PDE Constrained Optimization selected Proofs

PDE Constrained Optimization selected Proofs PDE Constrained Optimization selected Proofs Jeff Snider jeff@snider.com George Mason University Department of Mathematical Sciences April, 214 Outline 1 Prelim 2 Thms 3.9 3.11 3 Thm 3.12 4 Thm 3.13 5

More information

FINITE ELEMENT APPROXIMATION OF ELLIPTIC DIRICHLET OPTIMAL CONTROL PROBLEMS

FINITE ELEMENT APPROXIMATION OF ELLIPTIC DIRICHLET OPTIMAL CONTROL PROBLEMS Numerical Functional Analysis and Optimization, 28(7 8):957 973, 2007 Copyright Taylor & Francis Group, LLC ISSN: 0163-0563 print/1532-2467 online DOI: 10.1080/01630560701493305 FINITE ELEMENT APPROXIMATION

More information

Analysis of an Adaptive Finite Element Method for Recovering the Robin Coefficient

Analysis of an Adaptive Finite Element Method for Recovering the Robin Coefficient Analysis of an Adaptive Finite Element Method for Recovering the Robin Coefficient Yifeng Xu 1 Jun Zou 2 Abstract Based on a new a posteriori error estimator, an adaptive finite element method is proposed

More information

Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms

Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms Marcus Sarkis Worcester Polytechnic Inst., Mass. and IMPA, Rio de Janeiro and Daniel

More information

Suboptimal Open-loop Control Using POD. Stefan Volkwein

Suboptimal Open-loop Control Using POD. Stefan Volkwein Institute for Mathematics and Scientific Computing University of Graz, Austria PhD program in Mathematics for Technology Catania, May 22, 2007 Motivation Optimal control of evolution problems: min J(y,

More information

On some numerical convergence studies of mixed finite element methods for flow in porous media

On some numerical convergence studies of mixed finite element methods for flow in porous media On some numerical convergence studies of mixed finite element methods for flow in porous media Gergina Pencheva Abstract We consider an expanded mixed finite element method for solving second-order elliptic

More information

Geometric Multigrid Methods

Geometric Multigrid Methods Geometric Multigrid Methods Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University IMA Tutorial: Fast Solution Techniques November 28, 2010 Ideas

More information

Numerical Analysis of Electromagnetic Fields

Numerical Analysis of Electromagnetic Fields Pei-bai Zhou Numerical Analysis of Electromagnetic Fields With 157 Figures Springer-Verlag Berlin Heidelberg New York London Paris Tokyo Hong Kong Barcelona Budapest Contents Part 1 Universal Concepts

More information

A Two-grid Method for Coupled Free Flow with Porous Media Flow

A Two-grid Method for Coupled Free Flow with Porous Media Flow A Two-grid Method for Coupled Free Flow with Porous Media Flow Prince Chidyagwai a and Béatrice Rivière a, a Department of Computational and Applied Mathematics, Rice University, 600 Main Street, Houston,

More information

In this chapter we study elliptical PDEs. That is, PDEs of the form. 2 u = lots,

In this chapter we study elliptical PDEs. That is, PDEs of the form. 2 u = lots, Chapter 8 Elliptic PDEs In this chapter we study elliptical PDEs. That is, PDEs of the form 2 u = lots, where lots means lower-order terms (u x, u y,..., u, f). Here are some ways to think about the physical

More information

Simulation based optimization

Simulation based optimization SimBOpt p.1/52 Simulation based optimization Feb 2005 Eldad Haber haber@mathcs.emory.edu Emory University SimBOpt p.2/52 Outline Introduction A few words about discretization The unconstrained framework

More information

Design of optimal RF pulses for NMR as a discrete-valued control problem

Design of optimal RF pulses for NMR as a discrete-valued control problem Design of optimal RF pulses for NMR as a discrete-valued control problem Christian Clason Faculty of Mathematics, Universität Duisburg-Essen joint work with Carla Tameling (Göttingen) and Benedikt Wirth

More information

The Relativistic Heat Equation

The Relativistic Heat Equation Maximum Principles and Behavior near Absolute Zero Washington University in St. Louis ARTU meeting March 28, 2014 The Heat Equation The heat equation is the standard model for diffusion and heat flow,

More information

A posteriori error estimation of approximate boundary fluxes

A posteriori error estimation of approximate boundary fluxes COMMUNICATIONS IN NUMERICAL METHODS IN ENGINEERING Commun. Numer. Meth. Engng 2008; 24:421 434 Published online 24 May 2007 in Wiley InterScience (www.interscience.wiley.com)..1014 A posteriori error estimation

More information

REGULAR LAGRANGE MULTIPLIERS FOR CONTROL PROBLEMS WITH MIXED POINTWISE CONTROL-STATE CONSTRAINTS

REGULAR LAGRANGE MULTIPLIERS FOR CONTROL PROBLEMS WITH MIXED POINTWISE CONTROL-STATE CONSTRAINTS REGULAR LAGRANGE MULTIPLIERS FOR CONTROL PROBLEMS WITH MIXED POINTWISE CONTROL-STATE CONSTRAINTS fredi tröltzsch 1 Abstract. A class of quadratic optimization problems in Hilbert spaces is considered,

More information

Novel tomography techniques and parameter identification problems

Novel tomography techniques and parameter identification problems Novel tomography techniques and parameter identification problems Bastian von Harrach harrach@ma.tum.de Department of Mathematics - M1, Technische Universität München Colloquium of the Institute of Biomathematics

More information

Gradient Descent and Implementation Solving the Euler-Lagrange Equations in Practice

Gradient Descent and Implementation Solving the Euler-Lagrange Equations in Practice 1 Lecture Notes, HCI, 4.1.211 Chapter 2 Gradient Descent and Implementation Solving the Euler-Lagrange Equations in Practice Bastian Goldlücke Computer Vision Group Technical University of Munich 2 Bastian

More information

11.3 MATLAB for Partial Differential Equations

11.3 MATLAB for Partial Differential Equations 276 3. Generate the shape functions N (i) j = a (i) j where i =1, 2, 3,..., m and j =1, 2, 3,..., m. + b (i) j x + c(i) j y (11.2.17) 4. Compute the integrals for matrix elements α ij and vector elements

More information

PARTITION OF UNITY FOR THE STOKES PROBLEM ON NONMATCHING GRIDS

PARTITION OF UNITY FOR THE STOKES PROBLEM ON NONMATCHING GRIDS PARTITION OF UNITY FOR THE STOES PROBLEM ON NONMATCHING GRIDS CONSTANTIN BACUTA AND JINCHAO XU Abstract. We consider the Stokes Problem on a plane polygonal domain Ω R 2. We propose a finite element method

More information

Remarks on the analysis of finite element methods on a Shishkin mesh: are Scott-Zhang interpolants applicable?

Remarks on the analysis of finite element methods on a Shishkin mesh: are Scott-Zhang interpolants applicable? Remarks on the analysis of finite element methods on a Shishkin mesh: are Scott-Zhang interpolants applicable? Thomas Apel, Hans-G. Roos 22.7.2008 Abstract In the first part of the paper we discuss minimal

More information

A multigrid method for large scale inverse problems

A multigrid method for large scale inverse problems A multigrid method for large scale inverse problems Eldad Haber Dept. of Computer Science, Dept. of Earth and Ocean Science University of British Columbia haber@cs.ubc.ca July 4, 2003 E.Haber: Multigrid

More information

A-posteriori error estimates for optimal control problems with state and control constraints

A-posteriori error estimates for optimal control problems with state and control constraints www.oeaw.ac.at A-posteriori error estimates for optimal control problems with state and control constraints A. Rösch, D. Wachsmuth RICAM-Report 2010-08 www.ricam.oeaw.ac.at A-POSTERIORI ERROR ESTIMATES

More information

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications)

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications) Chapter 6 Finite Element Method Literature: (tiny selection from an enormous number of publications) K.J. Bathe, Finite Element procedures, 2nd edition, Pearson 2014 (1043 pages, comprehensive). Available

More information

A Domain Decomposition Method for Quasilinear Elliptic PDEs Using Mortar Finite Elements

A Domain Decomposition Method for Quasilinear Elliptic PDEs Using Mortar Finite Elements W I S S E N T E C H N I K L E I D E N S C H A F T A Domain Decomposition Method for Quasilinear Elliptic PDEs Using Mortar Finite Elements Matthias Gsell and Olaf Steinbach Institute of Computational Mathematics

More information

INTRODUCTION TO FINITE ELEMENT METHODS

INTRODUCTION TO FINITE ELEMENT METHODS INTRODUCTION TO FINITE ELEMENT METHODS LONG CHEN Finite element methods are based on the variational formulation of partial differential equations which only need to compute the gradient of a function.

More information

INTRODUCTION TO PDEs

INTRODUCTION TO PDEs INTRODUCTION TO PDEs In this course we are interested in the numerical approximation of PDEs using finite difference methods (FDM). We will use some simple prototype boundary value problems (BVP) and initial

More information

Local Mesh Refinement with the PCD Method

Local Mesh Refinement with the PCD Method Advances in Dynamical Systems and Applications ISSN 0973-5321, Volume 8, Number 1, pp. 125 136 (2013) http://campus.mst.edu/adsa Local Mesh Refinement with the PCD Method Ahmed Tahiri Université Med Premier

More information

Efficient Numerical Solution of Parabolic Optimization Problems by Finite Element Methods

Efficient Numerical Solution of Parabolic Optimization Problems by Finite Element Methods Optimization Methods and Software Vol. 00, No. 00, October 2006, 1 28 Efficient Numerical Solution of Parabolic Optimization Problems by Finite Element Methods Roland Becker, Dominik Meidner, and Boris

More information

ASYMPTOTICALLY EXACT A POSTERIORI ESTIMATORS FOR THE POINTWISE GRADIENT ERROR ON EACH ELEMENT IN IRREGULAR MESHES. PART II: THE PIECEWISE LINEAR CASE

ASYMPTOTICALLY EXACT A POSTERIORI ESTIMATORS FOR THE POINTWISE GRADIENT ERROR ON EACH ELEMENT IN IRREGULAR MESHES. PART II: THE PIECEWISE LINEAR CASE MATEMATICS OF COMPUTATION Volume 73, Number 246, Pages 517 523 S 0025-5718(0301570-9 Article electronically published on June 17, 2003 ASYMPTOTICALLY EXACT A POSTERIORI ESTIMATORS FOR TE POINTWISE GRADIENT

More information

A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations

A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations S. Hussain, F. Schieweck, S. Turek Abstract In this note, we extend our recent work for

More information

Chapter 4. Adjoint-state methods

Chapter 4. Adjoint-state methods Chapter 4 Adjoint-state methods As explained in section (3.4), the adjoint F of the linearized forward (modeling) operator F plays an important role in the formula of the functional gradient δj of the

More information

Nonlinear examples. June 21, Solution by fixed-point iteration 3. 5 Exercises 9

Nonlinear examples. June 21, Solution by fixed-point iteration 3. 5 Exercises 9 Nonlinear examples June 21, 2012 Contents 1 Bratu s equation 1 1.1 Manufacturing a problem to match a solution.................. 2 1.1.1 A manufactured Bratu s problem in 1D.................. 2 1.2 Weak

More information

Experiment 1: Linear Regression

Experiment 1: Linear Regression Experiment 1: Linear Regression August 27, 2018 1 Description This first exercise will give you practice with linear regression. These exercises have been extensively tested with Matlab, but they should

More information

Applied/Numerical Analysis Qualifying Exam

Applied/Numerical Analysis Qualifying Exam Applied/Numerical Analysis Qualifying Exam August 9, 212 Cover Sheet Applied Analysis Part Policy on misprints: The qualifying exam committee tries to proofread exams as carefully as possible. Nevertheless,

More information