Predictive Engineering and Computational Sciences. A Brief Survey of Error Estimation and Adaptivity. Paul T. Bauman

Size: px
Start display at page:

Download "Predictive Engineering and Computational Sciences. A Brief Survey of Error Estimation and Adaptivity. Paul T. Bauman"

Transcription

1 PECOS Predictive Engineering and Computational Sciences A Brief Survey of Error Estimation and Adaptivity Paul T. Bauman Institute for Computational Engineering and Sciences The University of Texas at Austin Mechanical and Aerospace Engineering State University of New York at Buffalo ICES August 14, 2013 P. T. Bauman Error Estimation and Adaptivity August 14, / 112

2 Objectives Course Objectives Scope Broad overview of error estimation techniques for estimating error in mathematical models adaptation strategies for controlling error Brief survey of some contemporary research areas Target Audience PhD students/postdocs with some exposure to numerical methods Limited functional analysis training Slides Slides are publicly available at: usc_uq2013_workshop_error_adaptivity_talk P. T. Bauman Error Estimation and Adaptivity August 14, / 112

3 Objectives Course Notes This is for you! Please stop me to ask questions Please stop me to have a discussion Please download the slides at your convenience Check the References I have chosen to pursue a breadth of topics instead of more depth in fewer topics I ve tried to provide a list of references for you to pursue your own study P. T. Bauman Error Estimation and Adaptivity August 14, / 112

4 Objectives Primary References Oden/Ainsworth Book on a posteriori error estimation [18] Bangerth/Rannacher lecture notes on adaptive finite elements [2] Carey Computational Grids book [10] Becker/Rannacher paper on optimal control approach to a posteriori error estimation [6] Oden/Prudhomme paper on modeling error [17] Excellent short courses by Don Estep available on his webpage: P. T. Bauman Error Estimation and Adaptivity August 14, / 112

5 Outline Outline Overview Preliminaries Error control through mesh adaptation Error estimation for discretized PDE s Global error estimators Adjoint-based error estimators Modeling error estimation and model adaptivity Coupled Stokes/Navier-Stokes example Coupled particle/continuum multiscale model example Some available software Contemporary issues QoI challenges Unsteady problems Extending to UQ setting P. T. Bauman Error Estimation and Adaptivity August 14, / 112

6 Overview Uncertainty Quantification (UQ) Ideas UQ Means Many Different Things In the present context, we will have in the back of our minds Assessing the uncertainty of experimental data, typically through a data reduction model (data uncertainty) Determining the uncertainty of parameters of a mathematical model used in some engineering analysis (inverse analysis) Using uncertain parameters to ascertain the uncertainty in some quantity of interest (QoI) that determined by mathematical model (forward propagation) P. T. Bauman Error Estimation and Adaptivity August 14, / 112

7 Overview Uncertainty Quantification (UQ) Ideas UQ Means Many Different Things In the present context, we will have in the back of our minds Assessing the uncertainty of experimental data, typically through a data reduction model (data uncertainty) Determining the uncertainty of parameters of a mathematical model used in some engineering analysis (inverse analysis) Using uncertain parameters to ascertain the uncertainty in some quantity of interest (QoI) that determined by mathematical model (forward propagation) We are working in the context of mathematical models P. T. Bauman Error Estimation and Adaptivity August 14, / 112

8 Overview Mathematical Models What is a Mathematical Model? In scientific/engineering analyses, a mathematical model is typically a system of algebraic, ordinary-differential, or partial-differential equations, in space and/or time. Including boundary and initial conditions (often sources of uncertainty) P. T. Bauman Error Estimation and Adaptivity August 14, / 112

9 Overview Mathematical Models What is a Mathematical Model? In scientific/engineering analyses, a mathematical model is typically a system of algebraic, ordinary-differential, or partial-differential equations, in space and/or time. Including boundary and initial conditions (often sources of uncertainty) Examples Chemical kinetics (Algebraic) N-body dynamics (ODE s) Navier-Stokes equations (PDE s) Boltzmann Equation (Integro-differential equations) P. T. Bauman Error Estimation and Adaptivity August 14, / 112

10 Overview Errors We Always Incur Error Algebraic systems - error in linear/nonlinear solver ODE s/pde s - error in space/time discretization, error in linear/nonlinear solver P. T. Bauman Error Estimation and Adaptivity August 14, / 112

11 Overview Errors We Always Incur Error Algebraic systems - error in linear/nonlinear solver ODE s/pde s - error in space/time discretization, error in linear/nonlinear solver Control Your Error! We must always control our error Even more crucial to quantify the error in the context of UQ analyses If the error in solution of the mathematical model similar to the uncertainty, UQ analysis isn t very meaningful We will focus only on spatial discretization error (not time error or solver error) P. T. Bauman Error Estimation and Adaptivity August 14, / 112

12 Overview Error Estimation...in the Context of UQ Could try to treat discretization as an uncertain parameter and adopt other UQ strategies to estimate error uncertainty I ve heard of this idea, but have not seen it used so much This is not the point-of-view I take Error is deterministic and we must simply set tolerances which are acceptable for the analysis at hand and use estimation and control strategies to meet that tolerance Many of the ideas discussed here are being adapted to estimate and control error in parameter space Hence, examining and understanding these ideas can bear fruit in new contexts P. T. Bauman Error Estimation and Adaptivity August 14, / 112

13 Overview Focus of this Shortcourse Error estimation of spatial discretizations in the context of PDE s: Briefly examine some classical error estimates Overview QoI-based error estimates and the adjoint problem Look at mesh adaptive strategies to control error Extensions to modeling error and modeling error estimation Extend ideas of QoI-based error estimation Adapting the model Some examples of current work in the field in adapting these ideas to parameter space P. T. Bauman Error Estimation and Adaptivity August 14, / 112

14 Preliminaries Notation Domain Ω D Model Problem u = f u = u0 u n = g in Ω on Ω D on Ω N Ω Ω N Image courtesy Benjamin S. Kirk, Roy H. Stogner, John W. Peterson P. T. Bauman Error Estimation and Adaptivity August 14, / 112

15 Preliminaries Notation We use the method of weighted residuals - multiply by a test function v V and integrate by parts to arrive at weak form of the equations Domain Weak Form Find u U such that u v dx + Ω gv ds Ω N = fv dx v V Ω Ω N Ω Ω D Image courtesy Benjamin S. Kirk, Roy H. Stogner, John W. Peterson P. T. Bauman Error Estimation and Adaptivity August 14, / 112

16 Preliminaries Notation Now we discretize the weak form by creating a mesh over the domain and testing against functions v h V h Discretized Weak Form Find u h U h such that u h v h dx Ω h + gv h ds = Ω h N Ω fv h dx v h V h Meshed Domain Ω h Image courtesy Benjamin S. Kirk, Roy H. Stogner, John W. Peterson P. T. Bauman Error Estimation and Adaptivity August 14, / 112

17 Preliminaries Notation The interior integral is broken up over elements: N e u h v h dx = u h v h dx Ω h Ω e e=1 and each function is written in terms of its basis function: N s u h = u i φ i (x) i=1 N s v h = c i φ i (x) i=1 where u i are the degrees of freedom and c i is arbitrary Shape functions φ i (x) are typically polynomials P. T. Bauman Error Estimation and Adaptivity August 14, / 112

18 Preliminaries Notation We will need the notation for the L 2 inner product: L 2 inner product ( u, v) = Ω u v dx The theory of error estimation is developed using the language of bilinear and semilinear forms: Bilinear Form for Laplace B(u, v) = ( u, v) F (v) = (f, v) Ω h N gv h ds so that the weak form of the model Laplace problem is B(u, v) = F (v) P. T. Bauman Error Estimation and Adaptivity August 14, / 112

19 Error Control through Mesh Adaptation Mesh Adaptation What is a mesh? A collection of points (called nodes) connected together to form shapes (called elements) Over each element, we define a finite element that contains information of the function representation (degrees of freedom, shape functions, etc) The more elements and nodes we have, the better we can resolve the function we are studying (solution of a differential equation) What do we mean by mesh adaptation/refinement? We refine a mesh by adding more degrees of freedom This helps give better resolution to the function we wish to compute Carefully choosing where to refine the mesh can greatly accelerate convergence to the desired solution P. T. Bauman Error Estimation and Adaptivity August 14, / 112

20 Error Control through Mesh Adaptation Types of Mesh Refinement h-adaptivity Break existing elements into smaller subelements h, the size of the element, shrinks p-adaptivity Raise the order of approximation of the basis functions For example, make the element use quadratic basis functions instead of linear hp-adaptivity Strategies combining both h-adaptivity and p-adaptivity Use optimization algorithms to decide which (both?) types of adaptation to perform on the element P. T. Bauman Error Estimation and Adaptivity August 14, / 112

21 Error Control through Mesh Adaptation Element h-refinement Triangle Quadrilateral Tetrahedron Prism Images courtesy of Benjamin S. Kirk, Roy H. Stogner, and John W. Peterson P. T. Bauman Error Estimation and Adaptivity August 14, / 112

22 Error Control through Mesh Adaptation Hanging Nodes Locally h-refining elements naturally leads to the presence of hanging nodes Dealing with Hanging Nodes Can add buffer elements and/or force neighboring refinements to avoid hanging nodes Can cause unnecessary proliferation of element refinement Creating buffer zones, especially in 3D, can be challenging to implement More commonly, enforce continuity of the solution (for discontinuous methods, there s nothing to do) For Lagrange basis functions, simply interpolating is adequate For more exotic elements/formulations, need to be careful to preserve the approximation Resort to projection-based interpolation strategies: interpolate at the nodes, project onto the edge degrees of freedom, project onto faces, project into the interior P. T. Bauman Error Estimation and Adaptivity August 14, / 112

23 Error Control through Mesh Adaptation Nonconforming Meshes When hanging nodes are present, we say the mesh is nonconforming If there are, at most, n hanging nodes on any element side, we say the mesh is an n-irregular mesh Although some software packages support more than 1-irregular meshes, it is very uncommon for such meshes to be used Practical difficulty of implementation Enforcing 1-irregularity forces some transition between the size of the elements Can lose conformity of the approximation with greater than 1-irregularity [12] P. T. Bauman Error Estimation and Adaptivity August 14, / 112

24 Error Control through Mesh Adaptation Mesh Redistribution Can adjust the mesh without changing its topology (how the elements/nodes are connected) One common operation is mesh smoothing Generated meshes can have sharp interfaces, skewed elements, etc. Solve a PDE (typically a form of the Laplace equation) to adjust the position of the nodes without changing the connectivity to improve the quality of the mesh A related idea is mesh redistribution where the nodes are redistributed to capture some desired feature One common example is shocks [7] P. T. Bauman Error Estimation and Adaptivity August 14, / 112

25 Error Control through Mesh Adaptation Example: Compressible Flow Over a Wedge The problem studied is that of an oblique shock generated by a 10 o wedge angle. Slide courtesy of Benjamin S. Kirk, Roy H. Stogner, and John W. Peterson P. T. Bauman Error Estimation and Adaptivity August 14, / 112

26 Error Control through Mesh Adaptation Example: Compressible Flow Over a Wedge The problem studied is that of an oblique shock generated by a 10 o wedge angle. This problem has an exact solution for density which is a step function. Slide courtesy of Benjamin S. Kirk, Roy H. Stogner, and John W. Peterson P. T. Bauman Error Estimation and Adaptivity August 14, / 112

27 Error Control through Mesh Adaptation Example: Compressible Flow Over a Wedge The problem studied is that of an oblique shock generated by a 10 o wedge angle. This problem has an exact solution for density which is a step function. The exact solution is shown below: Slide courtesy of Benjamin S. Kirk, Roy H. Stogner, and John W. Peterson P. T. Bauman Error Estimation and Adaptivity August 14, / 112

28 Error Control through Mesh Adaptation Uniformly Refined Solutions For comparison purposes, here is a mesh and a solution after 1 uniform refinement with DOFs. 1 1 y y r x x (a) Mesh after 1 uniform refinement. (b) Solution after 1 uniform refinement. Slide courtesy of Benjamin S. Kirk, Roy H. Stogner, and John W. Peterson P. T. Bauman Error Estimation and Adaptivity August 14, / 112

29 Error Control through Mesh Adaptation h-adapted Solutions A flux jump indicator was employed as the error indicator Slide courtesy of Benjamin S. Kirk, Roy H. Stogner, and John W. Peterson P. T. Bauman Error Estimation and Adaptivity August 14, / 112

30 Error Control through Mesh Adaptation h-adapted Solutions A flux jump indicator was employed as the error indicator Here is a mesh and solution after 2 adaptive refinements containing DOFs: 1 1 y y r x (e) Mesh, 2 refinements x (f) Solution Slide courtesy of Benjamin S. Kirk, Roy H. Stogner, and John W. Peterson P. T. Bauman Error Estimation and Adaptivity August 14, / 112

31 Error Control through Mesh Adaptation Redistributed Solutions Redistribution utilizing the same flux jump indicator. 1 1 y y r x (g) Mesh, 8 redistribution steps x (h) Solution Slide courtesy of Benjamin S. Kirk, Roy H. Stogner, and John W. Peterson P. T. Bauman Error Estimation and Adaptivity August 14, / 112

32 Error Control through Mesh Adaptation Redistributed and Adapted Now combining the two, here are the mesh and solution after 2 adaptations beyond the previous redistribution containing DOFs. 1 1 y y r x (i) Mesh, 2 refinements x (j) Solution Slide courtesy of Benjamin S. Kirk, Roy H. Stogner, and John W. Peterson P. T. Bauman Error Estimation and Adaptivity August 14, / 112

33 Error Control through Mesh Adaptation Solution Comparison For a better comparison here are 3 of the solutions, each with around DOFs: r r r y y y x (k) Uniform x (l) Adaptive x (m) R + H. Slide courtesy of Benjamin S. Kirk, Roy H. Stogner, and John W. Peterson P. T. Bauman Error Estimation and Adaptivity August 14, / 112

34 Error Control through Mesh Adaptation 2 0 Error Plot The exact solution is not in H 1 therefore we only look at the L 2 convergence plot: -1.2 Uniform Adaptivity Redist + Adapt (L Error ) log log 10 D ofs (n) LogLog plot of L2 vs DOFs. Slide courtesy of Benjamin S. Kirk, Roy H. Stogner, and John W. Peterson P. T. Bauman Error Estimation and Adaptivity August 14, / 112

35 Error Control through Mesh Adaptation Mesh Adaptation How to Choose Where to Refine the Mesh? This is the job of local error indicators We construct an estimate of the error η That error estimate is partitioned over the elements η = K η K Then we can use various flagging strategies to label which elements to refine Error value Error fraction Target number of elements (optimization) P. T. Bauman Error Estimation and Adaptivity August 14, / 112

36 Error Control through Mesh Adaptation Mesh Adaptation How to Choose Where to Refine the Mesh? This is the job of local error indicators We construct an estimate of the error η That error estimate is partitioned over the elements η = K η K Then we can use various flagging strategies to label which elements to refine Error value Error fraction Target number of elements (optimization) The job of error estimation is to come up with η and η K P. T. Bauman Error Estimation and Adaptivity August 14, / 112

37 Error Estimation for Discretized PDE s Error Estimation in General Two general flavors of error analysis: a priori Error Analysis From the earlier Analysis carried out before computations to assess convergence characteristics, etc. E.g. u u h Ch 2 Classical numerical analysis a posteriori Error Analysis From the later Analysis carried out following computation Used to guide adaptive refinement, etc. P. T. Bauman Error Estimation and Adaptivity August 14, / 112

38 Error Estimation for Discretized PDE s Flux Jump Error Indicator The flux-jump error indicator is derived starting from the element integrals N e ( u h v h fv h ) dx = 0 Ω e e=1 Applying the divergence theorem in reverse obtains N e e=1 Ω e Ω e Ω ( ) u h f v h dx + Ω e u h n v h dx = 0 P. T. Bauman Error Estimation and Adaptivity August 14, / 112

39 Error Estimation for Discretized PDE s Flux Jump Error Indicator Defining the cell residual we have N e e=1 Ω e r(u h )v h dx + r(u h ) = u h f Ω e Ω Ω e u h n Clearly, the exact solution u satisfies (1) identically. v h dx = 0 Computing r(u h ) requires knowledge of the differential operator (i.e. knowledge of the physics ). The second sum leads to a physics-independent method for estimating the error in the approximate solution u h. P. T. Bauman Error Estimation and Adaptivity August 14, / 112

40 Error Estimation for Discretized PDE s Flux Jump Error Indicator Pros Cons Ideal for low-order (piecewise linear) elements Easily extensible to adaptivity with hanging nodes Works well in practice for nonlinear, time-dependent problems, and problems with shocks, layers, discontinuities, etc. For higher-order elements, the interior residual term may dominate Relatively expensive to compute Makes no sense for discontinuous and C 1 FE bases P. T. Bauman Error Estimation and Adaptivity August 14, / 112

41 Error Estimation for Discretized PDE s Patch Recovery Error Indicator Main Idea Reconstruct gradient of solution at nodes using some average of values in adjoining elements Various different procedures Most popular may be that due to Zienkiewicz and Zhu ( superconvergent patch recovery ) Compare the reconstructed gradient against the gradient of the discrete solution Remarkably effective error indicator in many scenarios Can also be easily fooled P. T. Bauman Error Estimation and Adaptivity August 14, / 112

42 Error Estimation for Discretized PDE s Implicit a posteriori Error Estimators Based on element-local subproblems to be solved to approximate error Equilibrated residual method Residual free bubbles Depend on physics operator Can be much more accurate than the previous explicit type error indicators P. T. Bauman Error Estimation and Adaptivity August 14, / 112

43 Error Estimation for Discretized PDE s QoI-based Error Estimation What do you really want to compute? Thus far, have focused on error estimates for u u h Very often, we re not interested in u itself, but rather some functional of u, Q(u) We call Q(u) the quantity of interest Examples: Stress in a local region Maximum heat flux on a surface Local vorticity Thus, we would instead prefer to estimate the error Q(u) Q(u h ) One theory for developing such error estimates follows an optimal control approach P. T. Bauman Error Estimation and Adaptivity August 14, / 112

44 Error Estimation for Discretized PDE s QoI-based Error Estimation Abstract Nonlinear Problem Find u V such that B(u; v) = F (v), v V Optimal Control Approach Find u V such that where Q(u) = inf v M Q(v) M = {v V ; B(v; q) = F (q) q V } Q (u; v) = lim θ 1 [Q(u + θv) Q(u)] θ 0 B (u; v, w) = lim θ 1 [B(u + θv; w) B(u; w)] θ 0 P. T. Bauman Error Estimation and Adaptivity August 14, / 112

45 Error Estimation for Discretized PDE s QoI-based Error Estimation Comments on Optimal Control Approach Trivial optimal control problem: Compute u from B(u; v) = F (v) and evaluate Q(u) What this buys us is the machinery of optimal control for deriving equations needed for error computation. Lagrangian Must find saddle point (u, p) V V of Lagrangian Critical Points L(u, p) = Q(u) + F (p) B(u; p) L ((u, p); (v, q)) = 0, (v, q) V V P. T. Bauman Error Estimation and Adaptivity August 14, / 112

46 Error Estimation for Discretized PDE s QoI-based Error Estimation Critical Points L ((u, p); (v, q)) = Q (u; v) B (u; v, p)+f (q) B(u; q), (v, q) V V Primal Problem (potentially nonlinear) Find u V such that B(u; q) = F (q), q V Adjoint or Dual Problem (always linear) Find p V such that B (u; v, p) = Q (u; v), v V P. T. Bauman Error Estimation and Adaptivity August 14, / 112

47 Error Estimation for Discretized PDE s QoI-based Error Estimation Residual R(u; v) = F (v) B(u; v), v V Error Representation Q(u) Q(u h ) = R(u h ; p) + where u h V h V is our discrete approximation to u, p is the adjoint solution, and is higher order in u u h Comments This error representation requires the exact adjoint solution p p also requires a discrete approximation But, the second argument of the residual operator is linear, so... P. T. Bauman Error Estimation and Adaptivity August 14, / 112

48 Error Estimation for Discretized PDE s QoI-based Error Estimation Computable Error Representation Q(u) Q(u h ) = R(u h ; p h ) + R(u h ; p p h ) + Q(u) Q(u h ) R(u h ; p h ) where p h is our discrete approximation to p Comments When we neglect, we are assuming that u h is sufficiently close to u that it is small u h must be a good enough approximation of u to get good error estimators What happens if we use the same mesh for the solution of p h as u h? p h V h But u h V h such that R(u h ; v h ) = 0, v h V h R(u h ; p h ) = 0! No information in the error estimate! P. T. Bauman Error Estimation and Adaptivity August 14, / 112

49 Error Estimation for Discretized PDE s QoI-based Error Estimation What do we do, then? Need to enrich the adjoint solution beyond the space V h P. T. Bauman Error Estimation and Adaptivity August 14, / 112

50 Error Estimation for Discretized PDE s QoI-based Error Estimation What do we do, then? Need to enrich the adjoint solution beyond the space V h One strategy is to do one or more uniform refinements of the mesh and compute the adjoint solution, p h/2, on that mesh This is, probably, the most common strategy P. T. Bauman Error Estimation and Adaptivity August 14, / 112

51 Error Estimation for Discretized PDE s QoI-based Error Estimation What do we do, then? Need to enrich the adjoint solution beyond the space V h One strategy is to do one or more uniform refinements of the mesh and compute the adjoint solution, p h/2, on that mesh This is, probably, the most common strategy Then, Q(u) Q(u h ) R(I h/2 u h ; p h/2 ), where I h/2 u h is the interpolant of u h onto the uniformly refined grid Another common strategy involves using higher order basis functions, i.e. raising the order p of the approximation Other strategies abound such a using residual bubbles P. T. Bauman Error Estimation and Adaptivity August 14, / 112

52 Error Estimation for Discretized PDE s Summary Error Estimation Algorithm 1. Compute the primal solution u h : B(u h ; v h ) = F (v h ), v h V h P. T. Bauman Error Estimation and Adaptivity August 14, / 112

53 Error Estimation for Discretized PDE s Summary Error Estimation Algorithm 1. Compute the primal solution u h : B(u h ; v h ) = F (v h ), v h V h 2. Enrich the solution space, e.g. h h/2 P. T. Bauman Error Estimation and Adaptivity August 14, / 112

54 Error Estimation for Discretized PDE s Summary Error Estimation Algorithm 1. Compute the primal solution u h : B(u h ; v h ) = F (v h ), v h V h 2. Enrich the solution space, e.g. h h/2 3. Compute the adjoint solution p h/2 : B (I h/2 u h ; v h/2, p h/2 ) = Q (I h/2 u h ; v h/2 ), v h/2 V h/2 P. T. Bauman Error Estimation and Adaptivity August 14, / 112

55 Error Estimation for Discretized PDE s Summary Error Estimation Algorithm 1. Compute the primal solution u h : B(u h ; v h ) = F (v h ), v h V h 2. Enrich the solution space, e.g. h h/2 3. Compute the adjoint solution p h/2 : B (I h/2 u h ; v h/2, p h/2 ) = Q (I h/2 u h ; v h/2 ), v h/2 V h/2 4. Evaluate the residual to computer error estimate: Q(u) Q(u h ) R(I h/2 u h ; p h/2 ) P. T. Bauman Error Estimation and Adaptivity August 14, / 112

56 Error Estimation for Discretized PDE s Example Convection-Diffusion Problem with Adjoints Equation: Manufactured solution : α u + β e x u + f = 0 u 4(1 e αx (1 e α )x)y(1 y) α controls flux strength, layer Aside: MASA Manufactured and Analytical Solution Abstraction - library to facilitate the use of the Method of Manufactured Solutions (MMS) N. Malaya, K. C. Estacio-Hiroms, R. H. Stogner, K. W. Schulz, P. T. Bauman, G. F. Carey, MASA: A Library for Verification Using Manufactured and Analytical Solutions, Engineering with Computers, in press, Available: P. T. Bauman Error Estimation and Adaptivity August 14, / 112

57 Error Estimation for Discretized PDE s Example Convergence Primal Solution T: Convergence of the interior QoI, ε = 10 8 Uniform Refinements Flux Jump Error Estimator Adjoint Error Estimator 3.5 Log 10 (Absolute Error) Log 10 (Dofs), Degrees of Freedom Images courtesy Roy H. Stogner, The University of Texas at Austin P. T. Bauman Error Estimation and Adaptivity August 14, / 112

58 Error Estimation for Discretized PDE s Example Convergence Adjoint Solution T: Convergence of the interior QoI, ε = 10 8 Uniform Refinements Flux Jump Error Estimator Adjoint Error Estimator 3.5 Log 10 (Absolute Error) Log 10 (Dofs), Degrees of Freedom Images courtesy Roy H. Stogner, The University of Texas at Austin P. T. Bauman Error Estimation and Adaptivity August 14, / 112

59 Error Estimation for Discretized PDE s Example Comments Flux jump error indicator picks up the sharp layer near the boundary Convergence of QoI stalls Adjoint-based error estimator still picks up layer, but also picks up influence of QoI, as expected Convergence of adjoint-based error estimator double the rate of the uniformly refined solution P. T. Bauman Error Estimation and Adaptivity August 14, / 112

60 Error Estimation for Discretized PDE s Adjoint Problem Definition of Adjoint Operator Definition of adjoint operator: (Lu, v) = (u, L v) Example: linear system Ax = b, adjoint of A is A T Example: differential equation Lu = u + u, L v = v v P. T. Bauman Error Estimation and Adaptivity August 14, / 112

61 Error Estimation for Discretized PDE s Adjoint Problem Definition of Adjoint Operator Definition of adjoint operator: (Lu, v) = (u, L v) Example: linear system Ax = b, adjoint of A is A T Example: differential equation Lu = u + u, L v = v v Why is the Adjoint Problem Called the Adjoint Problem? We use a linear system as a simple example Exact: Ax = b Approximate: Ax 0 = b Error: e = x x 0 Equation for error: Ae = r, r = b Ax 0 Adjoint problem: A T p = q, for some q (QoI) a posteriori error estimate: (e, q) = (e, A T p) = (Ae, p) = (R, p) P. T. Bauman Error Estimation and Adaptivity August 14, / 112

62 Error Estimation for Discretized PDE s Adjoint Solution The adjoint solution may look somewhat familiar P. T. Bauman Error Estimation and Adaptivity August 14, / 112

63 Error Estimation for Discretized PDE s Adjoint Solution The adjoint solution may look somewhat familiar Green s Functions If we are computing Lu = f x Ω plus boundary and/or initial conditions, then the Green s function G is defined as L G(y, x) = δ y (x), x Ω plus boundary and/or initial conditions P. T. Bauman Error Estimation and Adaptivity August 14, / 112

64 Error Estimation for Discretized PDE s Adjoint Solution The adjoint solution may look somewhat familiar Green s Functions If we are computing Lu = f x Ω plus boundary and/or initial conditions, then the Green s function G is defined as L G(y, x) = δ y (x), x Ω plus boundary and/or initial conditions Comments If our quantity of interest is a point value, then the adjoint solution is actually a Green s function of our operator! Point value QoI s were studied for elliptic problems in [21] P. T. Bauman Error Estimation and Adaptivity August 14, / 112

65 Error Estimation for Discretized PDE s Adjoint Solution More Comments For other QoI s, the adjoint solution is, essentially, a generalized Green s function Often referred to as generalized Green s function in the literature Excellent discussion in Estep short course here: colostate.edu/~estep/research/talks/adjointcourse.pdf So why the optimal control approach? There is no unique definition for the adjoint of a nonlinear operator The choice made is the most common one, but others are possible Extends the linear case Gives a systematic framework for handling nonlinear problems You re probably not solving linear equations! P. T. Bauman Error Estimation and Adaptivity August 14, / 112

66 Error Estimation for Discretized PDE s Alternative Adjoint-Based Error Indicators Bound on Error See [2], for example R(u h ; v h, p) K R K u u h p p h Comments Although the actual error estimate is much more inaccurate than the form we ve been discussing, this can be very convenient as an error indicator In particular, we can solve the adjoint problem on the same grid! Use global error estimators to estimate u u h and p p h Gives an error indicator for QoI-based adaptivity Good adaptive strategy might be to use such an indicator for a few iterations to drive adaptivity, then switch to the more accurate error estimator P. T. Bauman Error Estimation and Adaptivity August 14, / 112

67 Modeling Error Estimation and Adaptivity Modeling Error Estimation Comments To this point, we ve considered the discretization error for single mathematical model In particular, we ve examined a framework for developing error estimates for quantities of interest This framework is actually amenable to examine modeling error This is the error due to the mathematical model being unable to capture essential features of the desired solution Modeling error considerations naturally arise in the use of multiphysics and multiscale models P. T. Bauman Error Estimation and Adaptivity August 14, / 112

68 Modeling Error Estimation and Adaptivity Modeling Error Estimation We begin as before: Base Model Find u U such that B(u; v) = F (v), v V Quantity of Interest Given u, find Q(u) such that Q : U R Comments In the context of modeling error, the base model is considered exact, in the sense that it captures all events/phenomena of interest For example, it is widely believed that the Navier-Stokes equations are an excellent model of turbulence However, the base model is, typically, intractable We never solve the base model We only use it as a basis for comparison to other models P. T. Bauman Error Estimation and Adaptivity August 14, / 112

69 Modeling Error Estimation and Adaptivity Modeling Error Estimation Surrogate Model Find u 0 U such that B 0 (u 0 ; v) = F 0 (v), v V Error in Quantity of Interest E = Q(u) Q(u 0 ) Comments We replace the base model by a surrogate model The surrogate model must be tractable Ideally, surrogate model captures coarse scale/far field features of the base model May involve fine and coarse scale models (and the interface between them) Examples later The error in the quantity of interest is now a modeling error We will reduce this error by model adaptivity P. T. Bauman Error Estimation and Adaptivity August 14, / 112

70 Modeling Error Estimation and Adaptivity Modeling Error Estimation Base Model Error Representation Q(u) Q(u 0 ) = R(u 0 ; p) + where p is the adjoint solution and is a higher order remainder Surrogate Model Comments The key insight is that there was nothing special about the choice u h We can choose any admissible approximation to u In particular, u 0 that is the solution to a different mathematical model. The devil is in the details as we will see... P. T. Bauman Error Estimation and Adaptivity August 14, / 112

71 Modeling Error Estimation and Adaptivity Model Adaptivity What is Model Adaptivity? Domain is partitioned into cells For simplicity, typically coincides with underlying discretization, but is not necessary Each cell has an identifier as to which model is activated in that cell Refining the model means which update the cell to locally use the base model instead of the approximate model As with mesh adaptivity, this is driven by computed local error indicators When QoI-based error estimators are used, such algorithms have been referred to as Goals algorithms P. T. Bauman Error Estimation and Adaptivity August 14, / 112

72 Modeling Error Estimation and Adaptivity Model Adaptivity ũ 1 Q(u) Q(ũ 1 ) = E 1 E 1 γ tol? ũ 2 Q(u) Q(ũ 2 ) = E 2 E 2 γ tol? ũ 3 Q(u) Q(ũ 3 ) = E 3 E 3 γ tol? P. T. Bauman Error Estimation and Adaptivity August 14, / 112

73 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Example: Coupled Stokes/Navier-Stokes Motivation: Airbag Deployment Airbag deployment canonical example of fluid-structure interaction Slender features present during majority of time for deployment of airbag Hypothesized that fluid in those slender features are amenable to approximation by Stokes equations (instead of Navier-Stokes) Ultimate goal would be boundary element methods for Stokes coupled with tradition FEM for Navier-Stokes (PhD work of Timo van Opstal) Natural first step is studying FEM-FEM coupled Stokes/Navier-Stokes Also a nice, simple example of modeling error estimation and adaptive modeling P. T. Bauman Error Estimation and Adaptivity August 14, / 112

74 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Example: Coupled Stokes/Navier-Stokes 1 0 u = g u = 0 σ n = Acknowledgements Timo M. van Opstal - Eindhoven University of Technology E. Harald van Brummelen - Eindhoven University of Technology Serge Prudhomme - Ecole Polytechnique de Montréal P. T. Bauman Error Estimation and Adaptivity August 14, / 112

75 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Fine Model Navier-Stokes u u σ(u, p) = 0 in Ω u = 0 in Ω Geometry u = g at Ω D Ω N σ(u, p) n = h at Ω N Ω D P. T. Bauman Error Estimation and Adaptivity August 14, / 112

76 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Mixed Model Navier-Stokes u u σ(u, p) = 0 in Ω n Stokes u = 0 in Ω n u = g at Ω D Ω n σ(u, p) n n = h at Ω N Ω n σ(u, p) = 0 in Ω s u = 0 in Ω s u = g at Ω D Ω s σ(u, p) n s = h at Ω N Ω s Geometry Ω s Ω D Σ Ω n Ω N Transmission γ s u = γ n u at Σ σ n s = σ n n at Σ P. T. Bauman Error Estimation and Adaptivity August 14, / 112

77 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Weak Form Definitions B ([u, p];[v, q]) := (u u, v) + 1 Re ( u, v) ( v, p) ( u, q) B 0 ([u, p];[v, q]) := (χ Ω nu u, v) + 1 Re ( u, v) ( v, p) ( u, q) F ([v, q]) := h v Ω N V Q H 1 g, Ω D (Ω) L 2 (Ω) Weak Form (Fine) Find [u, p] V Q : B ([u, p];[v, q]) = F ([v, q]) [v, q] V Q Weak Form (Mixed) Find [u 0, p 0 ] V Q : B 0 ([u 0, p 0 ];[v, q]) = F ([v, q]) [v, q] V Q P. T. Bauman Error Estimation and Adaptivity August 14, / 112

78 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Goal-oriented model adaptivity Model-adaptive process 1. Define quantity of interest (QoI): Q([u, p]) 2. Compute solution to approximate model: u 0 3. Compute adjoint solution [z, ζ] 4. Estimate error in QoI: Q([u, p]) Q([u 0, p 0 ]) 5. Control error: Design element-wise error indicator η κ Choose refinement strategy P. T. Bauman Error Estimation and Adaptivity August 14, / 112

79 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Model adaptivity: 2. Error estimate Adjoint problem Find [z, ζ] V Q : B ([u 0, p 0 ];[v, q], [z, ζ]) = Q ([u 0, p 0 ];[v, q]) [v, q] V Q Error estimate Q ([u, p]) Q ([u 0, p 0 ]) = R([u 0, p 0 ]; [z, ζ]) 1 ( B ([u 0 + se, p 0 + sɛ]; [z, ζ], [e, ɛ], [e, ɛ])+ 0 ) Q ([u 0 + se, p 0 + sɛ]; [e, ɛ], [e, ɛ]) (1 s)ds. P. T. Bauman Error Estimation and Adaptivity August 14, / 112

80 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Model adaptivity: 2. Error estimate Adjoint problem Find [z, ζ] V Q : B ([u 0, p 0 ];[v, q], [z, ζ]) = Q ([u 0, p 0 ];[v, q]) [v, q] V Q Error estimate Q ([u, p]) Q ([u 0, p 0 ]) R([u 0, p 0 ]; [z, ζ]) 1 ( B ([u 0 + se, p 0 + sɛ]; [z, ζ], [e, ɛ], [e, ɛ])+ 0 ) Q ([u 0 + se, p 0 + sɛ]; [e, ɛ], [e, ɛ]) (1 s)ds. P. T. Bauman Error Estimation and Adaptivity August 14, / 112

81 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Model adaptivity: 3. Error indicators Q ((u, p)) Q ((u 0, p 0 )) R([u 0, p 0 ];[z, ζ]) P. T. Bauman Error Estimation and Adaptivity August 14, / 112

82 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Model adaptivity: 3. Error indicators Q ((u, p)) Q ((u 0, p 0 )) R([u 0, p 0 ];[z, ζ]) = R([u 0, p 0 ];φ i ẑ i ) i<n P. T. Bauman Error Estimation and Adaptivity August 14, / 112

83 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Model adaptivity: 3. Error indicators Q ((u, p)) Q ((u 0, p 0 )) R([u 0, p 0 ];[z, ζ]) = R([u 0, p 0 ];φ i ẑ i ) i<n = β i R([u 0, p 0 ];φ i ) ẑ }{{} i κ T i I κ ˆR i P. T. Bauman Error Estimation and Adaptivity August 14, / 112

84 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Model adaptivity: 3. Error indicators Q ((u, p)) Q ((u 0, p 0 )) R([u 0, p 0 ];[z, ζ]) = R([u 0, p 0 ];φ i ẑ i ) i<n = β i R([u 0, p 0 ];φ i ) ẑ }{{} i κ T i I κ ˆR i Would like something similar to β i = κ φ i/ Ω φ i Could choose simple rule by splitting equally: β i = 1/#T i We use slight better: β i = µ(κ)/µ( κ Ti κ) P. T. Bauman Error Estimation and Adaptivity August 14, / 112

85 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Model adaptivity: 3. Error indicators Q ((u, p)) Q ((u 0, p 0 )) R([u 0, p 0 ];[z, ζ]) = R([u 0, p 0 ];φ i ẑ i ) i<n = β i R([u 0, p 0 ];φ i ) ẑ }{{} i κ T i I κ ˆR i µ(κ) = µ( κ Ti κ) ˆR i ẑ i κ T i I κ P. T. Bauman Error Estimation and Adaptivity August 14, / 112

86 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Model adaptivity: 3. Error indicators Q ((u, p)) Q ((u 0, p 0 )) R([u 0, p 0 ];[z, ζ]) = R([u 0, p 0 ];φ i ẑ i ) i<n = β i R([u 0, p 0 ];φ i ) ẑ }{{} i κ T i I κ ˆR i µ(κ) = µ( κ Ti κ) ˆR i ẑ i κ T i I κ µ(κ) µ( κ Ti κ) ˆR i ẑ i κ T i I } κ {{} η κ P. T. Bauman Error Estimation and Adaptivity August 14, / 112

87 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Model adaptivity: 3. Error indicators z 1 2 κ 0 κ κ 0 κ 1 P. T. Bauman Error Estimation and Adaptivity August 14, / 112

88 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Experiment setup Discretization details QoI: Q ([u, p]) := ω curlu Parabolic { inflow} 4y(1 y) g = 0 Initially, Ω s = Ω Re {10, 100, 1000} Q 2 Q 1 element Greedy refinement θ = 0.1 Test setup u = 0 u = g Σ Ω n Ω s σ n = ω P. T. Bauman Error Estimation and Adaptivity August 14, / 112

89 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Meshes Meshes generated by QoI-based adaptivity for the average vorticity QoI Re = 10 P. T. Bauman Error Estimation and Adaptivity August 14, / 112

90 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Meshes Meshes generated by QoI-based adaptivity for the average vorticity QoI Re = 1000 P. T. Bauman Error Estimation and Adaptivity August 14, / 112

91 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Re = 10 case True solution: (velocity magnitude and streamlines) P. T. Bauman Error Estimation and Adaptivity August 14, / 112

92 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Re = 10 case i = 0, ɛ Q = , #T n h /#T h = log η κ log u 0 0 P. T. Bauman Error Estimation and Adaptivity August 14, / 112

93 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Re = 10 case i = 1, ɛ Q = , #T n h /#T h = log η κ log u 0 0 P. T. Bauman Error Estimation and Adaptivity August 14, / 112

94 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Re = 10 case i = 4, ɛ Q = , #T n h /#T h = log η κ log u 0 0 P. T. Bauman Error Estimation and Adaptivity August 14, / 112

95 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Re = 10 case i = 6, ɛ Q = , #T n h /#T h = log η κ log u 0 0 P. T. Bauman Error Estimation and Adaptivity August 14, / 112

96 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Re = 10 case i = 8, ɛ Q = , #T n h /#T h = log η κ log u 0 0 P. T. Bauman Error Estimation and Adaptivity August 14, / 112

97 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Re = 1000 case True solution (velocity magnitude and streamlines) P. T. Bauman Error Estimation and Adaptivity August 14, / 112

98 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Re = 1000 case i = 0, ɛ Q = , #T n h /#T h = P. T. Bauman Error Estimation and Adaptivity August 14, / 112

99 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Re = 1000 case i = 2, ɛ Q = , #T n h /#T h = P. T. Bauman Error Estimation and Adaptivity August 14, / 112

100 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Re = 1000 case i = 8, ɛ Q = , #T n h /#T h = P. T. Bauman Error Estimation and Adaptivity August 14, / 112

101 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Re = 1000 case i = 12, ɛ Q = , #T n h /#T h = P. T. Bauman Error Estimation and Adaptivity August 14, / 112

102 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Re = 1000 case i = 18, ɛ Q = , #T n h /#T h = P. T. Bauman Error Estimation and Adaptivity August 14, / 112

103 Modeling Error Estimation and Adaptivity Example: Coupled Stokes/Navier-Stokes Effectivity index θ eff = R([u 0,p 0 ];[z,ζ]) Q([u,p]) Q([u 0,p 0 ]) θeff Re = 10 Re = 100 Re = #T N h /#T h P. T. Bauman Error Estimation and Adaptivity August 14, / 112

104 Modeling Error Estimation and Adaptivity Relative error in Q([u, p]) Example: Coupled Stokes/Navier-Stokes ɛq ɛ Q = Q([u,p]) Q([u 0,p 0 ]) Q([u,p]) Re = 10 Re = 100 Re = #T N h /#T h P. T. Bauman Error Estimation and Adaptivity August 14, / 112

105 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Example: Coupled Particle/Continuum Multiscale Model Motivation Study multiscale models of polymer deformation that is a component of a lithography process in semiconductor manufacturing These models involve coupling of particle models with continuum, nonlinear elasticity models Study modeling error estimation and adaptivity in this context This application illustrates some of the additional complexities one faces when studying modeling error estimation References [4, 5, 3, 19, 20] Acknowledgements J. Tinsley Oden - The University of Texas at Austin Serge Prudhomme - Ecole Polytechnique de Montréal P. T. Bauman Error Estimation and Adaptivity August 14, / 112

106 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Particle Configuration P. T. Bauman Error Estimation and Adaptivity August 14, / 112

107 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Base Model Given: 1 Lattice with N molecules, each with position x i. 2 N i neighbors/molecule. 3 E ik (x i, x k ) = potential energy between particle i and neighbor k. Goal: where System of equations: Find x = arg min E(x) x E(x) = N N i E ik (x i, x k ) i=1 k=1 E x (x ) = f(x ) = 0 P. T. Bauman Error Estimation and Adaptivity August 14, / 112

108 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Base Model Written in Weak Form Base Primal and Adjoint Problems: For u, v, p R 3N, B(u; v) = N B (u; v, p) = Q(u) = 1 M N i=1 k=1 N E ik u i i=1 j=1 N v j M u m e 1 m=1 v i N k=1 2 E ik u i u j p i P. T. Bauman Error Estimation and Adaptivity August 14, / 112

109 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Arlequin Method P. T. Bauman Error Estimation and Adaptivity August 14, / 112

110 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Arlequin Method Find (u, w) X, λ M such that: a ((u, w), (v, z)) + b (λ, (v, z)) = l((v, z)) (v, z) X b (µ, (u, w)) = 0 µ M where m a ((u, w), (v, z)) = α c W (u)v dx + α d E i(w i, w i 1 )(z i z i 1 ) Ω c i=1 b (µ, (v, z)) = β 1 µ(v Πz) + β 2 µ (v Πz) dx Ω o l((v, z)) = fz m P. T. Bauman Error Estimation and Adaptivity August 14, / 112

111 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Example 3D Arlequin Calculation Solution Comments Reduced 375,000 unknowns to 18,228 5 mins. on a workstation from 1.4 CPU hours on 32 processors A factor of 21 time and cost P. T. Bauman Error Estimation and Adaptivity August 14, / 112

112 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation Surrogate Solution Q(u) Q(u 0 ) = R(u 0 ; p) + P. T. Bauman Error Estimation and Adaptivity August 14, / 112

113 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation Surrogate Solution Q(u) Q(u 0 ) = R(u 0 ; p) + P. T. Bauman Error Estimation and Adaptivity August 14, / 112

114 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation Q(u) Q(u 0 ) = R(u 0 ; p) + Surrogate Solution Base Solution P. T. Bauman Error Estimation and Adaptivity August 14, / 112

115 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation Comments The surrogate solution is not compatible as is with the base model residual operator Surrogate solution is a mixed particle and continuum model Base model residual is only defined for particles P. T. Bauman Error Estimation and Adaptivity August 14, / 112

116 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation Comments The surrogate solution is not compatible as is with the base model residual operator Surrogate solution is a mixed particle and continuum model Base model residual is only defined for particles Furthermore, we require the fine scale adjoint solution Adjoint problem requires surrogate solution (because we don t have the exact solution) Again, base model adjoint equations only defined for particles P. T. Bauman Error Estimation and Adaptivity August 14, / 112

117 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation Comments The surrogate solution is not compatible as is with the base model residual operator Surrogate solution is a mixed particle and continuum model Base model residual is only defined for particles Furthermore, we require the fine scale adjoint solution Adjoint problem requires surrogate solution (because we don t have the exact solution) Again, base model adjoint equations only defined for particles We must make the surrogate solution compatible with the base model operators! P. T. Bauman Error Estimation and Adaptivity August 14, / 112

118 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation Comments The surrogate solution is not compatible as is with the base model residual operator Surrogate solution is a mixed particle and continuum model Base model residual is only defined for particles Furthermore, we require the fine scale adjoint solution Adjoint problem requires surrogate solution (because we don t have the exact solution) Again, base model adjoint equations only defined for particles We must make the surrogate solution compatible with the base model operators! We will use interpolation P. T. Bauman Error Estimation and Adaptivity August 14, / 112

119 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Interpolant Model Partition Comments Must choose how to interpolate each of the three regions Particle region (pink) Overlap region (red) Continuum region (green) P. T. Bauman Error Estimation and Adaptivity August 14, / 112

120 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Interpolant Model Partition Comments Must choose how to interpolate each of the three regions Particle region (pink) Overlap region (red) Continuum region (green) Particle Interpolation Copy particle to particle P. T. Bauman Error Estimation and Adaptivity August 14, / 112

121 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Interpolant Continuum Mapping Reference Config Current Config Comments Continuum model is large deformation Displacement gives mapping from reference configuration to current configuration (in continuum mechanics parlance) Use this mapping to construct interpolant in continuum region P. T. Bauman Error Estimation and Adaptivity August 14, / 112

122 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Interpolant Continuum Interpolant Reference Config Current Config Interpolate displacement of continuum P. T. Bauman Error Estimation and Adaptivity August 14, / 112

123 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation Surrogate Interpolant We have now constructed an interpolant for the surrogate solution, Πu 0, that takes us back to the base model configuration P. T. Bauman Error Estimation and Adaptivity August 14, / 112

124 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation Surrogate Interpolant We have now constructed an interpolant for the surrogate solution, Πu 0, that takes us back to the base model configuration We can now pose the adjoint problem B (Πu 0 ; v, ˆp) = Q (Πu 0, v) We use the ˆ notation to delineate that we ve used the interpolated surrogate solution to compute the adjoint P. T. Bauman Error Estimation and Adaptivity August 14, / 112

125 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation Surrogate Interpolant We have now constructed an interpolant for the surrogate solution, Πu 0, that takes us back to the base model configuration We can now pose the adjoint problem B (Πu 0 ; v, ˆp) = Q (Πu 0, v) We use the ˆ notation to delineate that we ve used the interpolated surrogate solution to compute the adjoint And evaluate the residual R(Πu 0 ; ˆp) to estimate the error P. T. Bauman Error Estimation and Adaptivity August 14, / 112

126 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation Adjoint Solution ˆp P. T. Bauman Error Estimation and Adaptivity August 14, / 112

127 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation The Problem In principle, the previous strategy is not feasible P. T. Bauman Error Estimation and Adaptivity August 14, / 112

128 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation The Problem In principle, the previous strategy is not feasible Solving the base model adjoint problem and evaluating the base model residual is not tractable! P. T. Bauman Error Estimation and Adaptivity August 14, / 112

129 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation The Problem In principle, the previous strategy is not feasible Solving the base model adjoint problem and evaluating the base model residual is not tractable! We need a different strategy that is both tractable and effective for error estimation P. T. Bauman Error Estimation and Adaptivity August 14, / 112

130 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation The Problem In principle, the previous strategy is not feasible Solving the base model adjoint problem and evaluating the base model residual is not tractable! We need a different strategy that is both tractable and effective for error estimation What About the Surrogate Model? Adjoint problem: B 0 (u 0; v 0, p 0 ) = Q (u 0, v 0 ) P. T. Bauman Error Estimation and Adaptivity August 14, / 112

131 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation The Problem In principle, the previous strategy is not feasible Solving the base model adjoint problem and evaluating the base model residual is not tractable! We need a different strategy that is both tractable and effective for error estimation What About the Surrogate Model? Adjoint problem: B 0 (u 0; v 0, p 0 ) = Q (u 0, v 0 ) Residual evaluation: Q(u) Q(u 0 ) R 0 (u 0 ; p 0 ) P. T. Bauman Error Estimation and Adaptivity August 14, / 112

132 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation The Problem In principle, the previous strategy is not feasible Solving the base model adjoint problem and evaluating the base model residual is not tractable! We need a different strategy that is both tractable and effective for error estimation What About the Surrogate Model? Adjoint problem: B 0 (u 0; v 0, p 0 ) = Q (u 0, v 0 ) Residual evaluation: Q(u) Q(u 0 ) R 0 (u 0 ; p 0 ) = 0! P. T. Bauman Error Estimation and Adaptivity August 14, / 112

133 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation The Problem In principle, the previous strategy is not feasible Solving the base model adjoint problem and evaluating the base model residual is not tractable! We need a different strategy that is both tractable and effective for error estimation What About the Surrogate Model? Adjoint problem: B 0 (u 0; v 0, p 0 ) = Q (u 0, v 0 ) Residual evaluation: Q(u) Q(u 0 ) R 0 (u 0 ; p 0 ) = 0! Analogous to Galerkin orthogonality in the discretized PDE case! P. T. Bauman Error Estimation and Adaptivity August 14, / 112

134 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Error Estimation The Problem In principle, the previous strategy is not feasible Solving the base model adjoint problem and evaluating the base model residual is not tractable! We need a different strategy that is both tractable and effective for error estimation What About the Surrogate Model? Adjoint problem: B 0 (u 0; v 0, p 0 ) = Q (u 0, v 0 ) Residual evaluation: Q(u) Q(u 0 ) R 0 (u 0 ; p 0 ) = 0! Analogous to Galerkin orthogonality in the discretized PDE case! Conclusion: We need to solve the dual problem and evaluate the residual on something between the coarse model and the full lattice. P. T. Bauman Error Estimation and Adaptivity August 14, / 112

135 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Enrichment Strategy Enrich the original coarse model to include more particle regions P. T. Bauman Error Estimation and Adaptivity August 14, / 112

136 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Enrichment Strategy Enrich the original coarse model to include more particle regions Use the same interpolation procedure as before P. T. Bauman Error Estimation and Adaptivity August 14, / 112

137 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Enrichment Strategy Enrich the original coarse model to include more particle regions Use the same interpolation procedure as before Solve the adjoint problem and evaluate the residual on this configuration P. T. Bauman Error Estimation and Adaptivity August 14, / 112

138 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Enrichment Enriched Adjoint and Residual Adjoint: B ( Πu 0 ; ṽ, p) = Q ( Πu 0, ṽ) Residual: Q(u) Q( Πu 0 ) R( Πu 0 ; p) P. T. Bauman Error Estimation and Adaptivity August 14, / 112

139 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Example Calculations Smooth Problem η eff η eff η eff η eff # of Enrich. R(Πu 0,p) Q(u) Q(Πu 0 ) R(Πu 0,ˆp) Q(u) Q(Πu 0 ) R(Πu 0,Π p) Q(u) Q(Πu 0 ) R( Πu 0, p) Q(u) Q( Πu 0 ) P. T. Bauman Error Estimation and Adaptivity August 14, / 112

140 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Example Calculations Rough Problem η eff η eff η eff η eff # of Enrich. R(Πu 0,p) Q(u) Q(Πu 0 ) R(Πu 0,ˆp) Q(u) Q(Πu 0 ) R(Πu 0,Π p) Q(u) Q(Πu 0 ) R( Πu 0, p) Q(u) Q( Πu 0 ) P. T. Bauman Error Estimation and Adaptivity August 14, / 112

141 Modeling Error Estimation and Adaptivity Example: Coupled Particle/Continuum Multiscale Models Example Calculations Smooth Problem Rough Problem Step 1 Step 2 Step 1 Step 2 Step 3 Step 4 Step 3 Step 4 Step 5 Step 5 P. T. Bauman Error Estimation and Adaptivity August 14, / 112

142 Software libmesh Software: libmesh Finite Element Library libmesh [15] Originated in 2002 in order to abstract & implement major components of mesh based simulations in a reusable software library Primary goal is to provide data structures and algorithms that can be shared by disparate physical applications, that may need some combination of Implicit numerical methods Adaptive mesh refinement techniques Parallel computing Parallel mesh distribution Unifying theme: mesh-based simulation of partial differential equations (PDEs). P. T. Bauman Error Estimation and Adaptivity August 14, / 112

143 Software libmesh Software: libmesh Finite Element Library Software Reuse Tumor Angiogenesis Compressible RBM NS DD LibMesh Petsc Laspack STL Metis Mpich Image courtesy Benjamin S. Kirk, Roy H. Stogner, John W. Peterson P. T. Bauman Error Estimation and Adaptivity August 14, / 112

144 Software libmesh Software: libmesh Finite Element Library Key Points The libmesh library is designed to be used by students, researchers, scientists, and engineers as a tool for developing simulation codes or as a tool for rapidly implementing a numerical method libmesh is not an application code It does not solve problem XYZ It can be used to help you develop an application to solve problem XYZ, and to do so quickly with advanced numerical algorithms on high-performance computing platforms Written in object-oriented C++ P. T. Bauman Error Estimation and Adaptivity August 14, / 112

145 Software GRINS Software: GRINS Multiphysics Framework General Reacting Incompressible Navier-Stokes Began as an application code centered around incompressible Navier-Stokes Evolved into more general multiphysics framework using finite element methods Heavily leverages libmesh through the FEMSystem framework Designed to be flexible for adding new physics, solvers, boundary conditions, etc. Want computational scientist to easily express system simulation in input file At the same time, easily enabling experimentation with new numerical methods in code Easily enable statistical forward and inverse problem P. T. Bauman Error Estimation and Adaptivity August 14, / 112

146 Software GRINS Software: GRINS Multiphysics Framework Key Points Heavily utilizes libmesh Leverages many solvers through libmesh Automatically get access to 3rd party libraries (e.g. PETSc) Supports mesh adaptivity Written in object-oriented C++ Several physics kernels already implemented Preliminary model adaptivity support implemented Available at https: //github.com/grinsfem Example: Vacuum Arc Remelting P. T. Bauman Error Estimation and Adaptivity August 14, / 112

147 Software deal.ii Software: deal.ii Finite Element Library [1] Sophisticated C++ finite element library Supports mesh adaptivity Parallel mesh distribution supported through p4est Supports geometric elements based on tensor product Progenitor of libmesh libmesh was started in order to support triangle and tets, which deal.ii cannot Geometric multi grid available Winner of Wilkinson prize for numerical software Available at P. T. Bauman Error Estimation and Adaptivity August 14, / 112

148 Software FEniCS Software: FEniCS [16] Automated FEM Solutions Collection of Python tools to automate the solution of differential equations using the finite element method Essentially a domain specific language to generate FEM weak forms for problems of interest Interfaces to many external scientific computing packages Gaining a lot of traction in the scientific Python community Comes with all the strengths (and weaknesses...) of Python fenicsproject.org P. T. Bauman Error Estimation and Adaptivity August 14, / 112

149 Contemporary Issues Boundary Flux QoI s Boundary derivatives are a common example of a QoI However, depending on the problem that we are solving, such QoI s may not be well defined This is related to the regularity of the solution, Sobolev spaces, and the Trace theorem In particular, we may not get a well posed adjoint problem Must modify the formulation in order to have well defined adjoint solution Example in electroosmosis, part of Vikram Garg s PhD work [14, 13] P. T. Bauman Error Estimation and Adaptivity August 14, / 112

150 Contemporary Issues Maximum QoI Adjoint-base AMR for Hypersonic Flows. QoI here is the maximum heat flux on the surface. Primal Error Adjoint Error QoI Error P. T. Bauman Error Estimation and Adaptivity August 14, / 112

151 Contemporary Issues Maximum QoI Boundary Layer Hanging Nodes Stress test: Ungraded boundary layer Underresolved viscous fluxes Valid initial refinement step Subsequent refinements: Coarse elements currently overestimate convective flux Fine element equilibrium temperature drops Peak surface value QoI location moves Wasteful overrefinement downstream P. T. Bauman Error Estimation and Adaptivity August 14, / 112

The Immersed Interface Method

The Immersed Interface Method The Immersed Interface Method Numerical Solutions of PDEs Involving Interfaces and Irregular Domains Zhiiin Li Kazufumi Ito North Carolina State University Raleigh, North Carolina Society for Industrial

More information

ADAPTIVE FINITE ELEMENT

ADAPTIVE FINITE ELEMENT Finite Element Methods In Linear Structural Mechanics Univ. Prof. Dr. Techn. G. MESCHKE SHORT PRESENTATION IN ADAPTIVE FINITE ELEMENT Abdullah ALSAHLY By Shorash MIRO Computational Engineering Ruhr Universität

More information

1.2 Numerical Solutions of Flow Problems

1.2 Numerical Solutions of Flow Problems 1.2 Numerical Solutions of Flow Problems DIFFERENTIAL EQUATIONS OF MOTION FOR A SIMPLIFIED FLOW PROBLEM Continuity equation for incompressible flow: 0 Momentum (Navier-Stokes) equations for a Newtonian

More information

AUTOMATED ADAPTIVE ERROR CONTROL IN FINITE ELEMENT METHODS USING THE ERROR REPRESENTATION AS ERROR INDICATOR

AUTOMATED ADAPTIVE ERROR CONTROL IN FINITE ELEMENT METHODS USING THE ERROR REPRESENTATION AS ERROR INDICATOR AUTOMATED ADAPTIVE ERROR CONTROL IN FINITE ELEMENT METHODS USING THE ERROR REPRESENTATION AS ERROR INDICATOR JOHAN JANSSON, JOHAN HOFFMAN, CEM DEGIRMENCI, JEANNETTE SPÜHLER Abstract. In this paper we present

More information

Adaptive-Mesh-Refinement Pattern

Adaptive-Mesh-Refinement Pattern Adaptive-Mesh-Refinement Pattern I. Problem Data-parallelism is exposed on a geometric mesh structure (either irregular or regular), where each point iteratively communicates with nearby neighboring points

More information

Unstructured Mesh Generation for Implicit Moving Geometries and Level Set Applications

Unstructured Mesh Generation for Implicit Moving Geometries and Level Set Applications Unstructured Mesh Generation for Implicit Moving Geometries and Level Set Applications Per-Olof Persson (persson@mit.edu) Department of Mathematics Massachusetts Institute of Technology http://www.mit.edu/

More information

CHAPTER 1. Introduction

CHAPTER 1. Introduction ME 475: Computer-Aided Design of Structures 1-1 CHAPTER 1 Introduction 1.1 Analysis versus Design 1.2 Basic Steps in Analysis 1.3 What is the Finite Element Method? 1.4 Geometrical Representation, Discretization

More information

Stabilized Finite Element Method for 3D Navier-Stokes Equations with Physical Boundary Conditions

Stabilized Finite Element Method for 3D Navier-Stokes Equations with Physical Boundary Conditions Stabilized Finite Element Method for 3D Navier-Stokes Equations with Physical Boundary Conditions Mohamed Amara, Daniela Capatina, David Trujillo Université de Pau et des Pays de l Adour Laboratoire de

More information

Multigrid Pattern. I. Problem. II. Driving Forces. III. Solution

Multigrid Pattern. I. Problem. II. Driving Forces. III. Solution Multigrid Pattern I. Problem Problem domain is decomposed into a set of geometric grids, where each element participates in a local computation followed by data exchanges with adjacent neighbors. The grids

More information

Introduction to C omputational F luid Dynamics. D. Murrin

Introduction to C omputational F luid Dynamics. D. Murrin Introduction to C omputational F luid Dynamics D. Murrin Computational fluid dynamics (CFD) is the science of predicting fluid flow, heat transfer, mass transfer, chemical reactions, and related phenomena

More information

Department of Computing and Software

Department of Computing and Software Department of Computing and Software Faculty of Engineering McMaster University Assessment of two a posteriori error estimators for steady-state flow problems by A. H. ElSheikh, S.E. Chidiac and W. S.

More information

arxiv: v1 [math.na] 20 Sep 2016

arxiv: v1 [math.na] 20 Sep 2016 arxiv:1609.06236v1 [math.na] 20 Sep 2016 A Local Mesh Modification Strategy for Interface Problems with Application to Shape and Topology Optimization P. Gangl 1,2 and U. Langer 3 1 Doctoral Program Comp.

More information

The 3D DSC in Fluid Simulation

The 3D DSC in Fluid Simulation The 3D DSC in Fluid Simulation Marek K. Misztal Informatics and Mathematical Modelling, Technical University of Denmark mkm@imm.dtu.dk DSC 2011 Workshop Kgs. Lyngby, 26th August 2011 Governing Equations

More information

Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich

Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich 1 Computational Fluid dynamics Computational fluid dynamics (CFD) is the analysis of systems involving fluid flow, heat

More information

Fluent User Services Center

Fluent User Services Center Solver Settings 5-1 Using the Solver Setting Solver Parameters Convergence Definition Monitoring Stability Accelerating Convergence Accuracy Grid Independence Adaption Appendix: Background Finite Volume

More information

ADVANCES IN ADAPTIVE METHODS IN COMPUTATIONAL FLUID MECHANICS. J. Tinsley Oden. Abstract

ADVANCES IN ADAPTIVE METHODS IN COMPUTATIONAL FLUID MECHANICS. J. Tinsley Oden. Abstract ADVANCES N ADAPTVE METHODS N COMPUTATONAL FLUD MECHANCS J. Tinsley Oden Texas nstitute for Computational Mechanics The University of Texas at Austin Austin, Texas 78712 Abstract Recent developments in

More information

Domain Decomposition and hp-adaptive Finite Elements

Domain Decomposition and hp-adaptive Finite Elements Domain Decomposition and hp-adaptive Finite Elements Randolph E. Bank 1 and Hieu Nguyen 1 Department of Mathematics, University of California, San Diego, La Jolla, CA 9093-011, USA, rbank@ucsd.edu. Department

More information

Adaptive numerical methods

Adaptive numerical methods METRO MEtallurgical TRaining On-line Adaptive numerical methods Arkadiusz Nagórka CzUT Education and Culture Introduction Common steps of finite element computations consists of preprocessing - definition

More information

Predictive Engineering and Computational Sciences. Data Structures and Methods for Unstructured Distributed Meshes. Roy H. Stogner

Predictive Engineering and Computational Sciences. Data Structures and Methods for Unstructured Distributed Meshes. Roy H. Stogner PECOS Predictive Engineering and Computational Sciences Data Structures and Methods for Unstructured Distributed Meshes Roy H. Stogner The University of Texas at Austin May 23, 2012 Roy H. Stogner Distributed

More information

GEOMETRY MODELING & GRID GENERATION

GEOMETRY MODELING & GRID GENERATION GEOMETRY MODELING & GRID GENERATION Dr.D.Prakash Senior Assistant Professor School of Mechanical Engineering SASTRA University, Thanjavur OBJECTIVE The objectives of this discussion are to relate experiences

More information

Conforming Vector Interpolation Functions for Polyhedral Meshes

Conforming Vector Interpolation Functions for Polyhedral Meshes Conforming Vector Interpolation Functions for Polyhedral Meshes Andrew Gillette joint work with Chandrajit Bajaj and Alexander Rand Department of Mathematics Institute of Computational Engineering and

More information

Robust Numerical Methods for Singularly Perturbed Differential Equations SPIN Springer s internal project number, if known

Robust Numerical Methods for Singularly Perturbed Differential Equations SPIN Springer s internal project number, if known Hans-Görg Roos Martin Stynes Lutz Tobiska Robust Numerical Methods for Singularly Perturbed Differential Equations SPIN Springer s internal project number, if known Convection-Diffusion-Reaction and Flow

More information

Dual Interpolants for Finite Element Methods

Dual Interpolants for Finite Element Methods Dual Interpolants for Finite Element Methods Andrew Gillette joint work with Chandrajit Bajaj and Alexander Rand Department of Mathematics Institute of Computational Engineering and Sciences University

More information

Mid-Year Report. Discontinuous Galerkin Euler Equation Solver. Friday, December 14, Andrey Andreyev. Advisor: Dr.

Mid-Year Report. Discontinuous Galerkin Euler Equation Solver. Friday, December 14, Andrey Andreyev. Advisor: Dr. Mid-Year Report Discontinuous Galerkin Euler Equation Solver Friday, December 14, 2012 Andrey Andreyev Advisor: Dr. James Baeder Abstract: The focus of this effort is to produce a two dimensional inviscid,

More information

MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP

MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP Vol. 12, Issue 1/2016, 63-68 DOI: 10.1515/cee-2016-0009 MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP Juraj MUŽÍK 1,* 1 Department of Geotechnics, Faculty of Civil Engineering, University

More information

NIA CFD Seminar, October 4, 2011 Hyperbolic Seminar, NASA Langley, October 17, 2011

NIA CFD Seminar, October 4, 2011 Hyperbolic Seminar, NASA Langley, October 17, 2011 NIA CFD Seminar, October 4, 2011 Hyperbolic Seminar, NASA Langley, October 17, 2011 First-Order Hyperbolic System Method If you have a CFD book for hyperbolic problems, you have a CFD book for all problems.

More information

Predictive Engineering and Computational Sciences. Full System Simulations with Fully Implicit Navier-Stokes

Predictive Engineering and Computational Sciences. Full System Simulations with Fully Implicit Navier-Stokes PECOS Predictive Engineering and Computational Sciences Full System Simulations with Fully Implicit Navier-Stokes Roy Stogner, Benjamin Kirk, Paul Bauman, Todd Oliver, Kemelli Estacio, Marco Panesi, Juan

More information

Techniques for Using the Method of Manufactured Solutions for Verification and Uncertainty Quantification of CFD Simulations Having Discontinuities

Techniques for Using the Method of Manufactured Solutions for Verification and Uncertainty Quantification of CFD Simulations Having Discontinuities Techniques for Using the Method of Manufactured Solutions for Verification and Uncertainty Quantification of CFD Simulations Having Discontinuities Ben Grier Clemson University Richard Figliola, Larry

More information

Continuum-Microscopic Models

Continuum-Microscopic Models Scientific Computing and Numerical Analysis Seminar October 1, 2010 Outline Heterogeneous Multiscale Method Adaptive Mesh ad Algorithm Refinement Equation-Free Method Incorporates two scales (length, time

More information

Fully discrete Finite Element Approximations of Semilinear Parabolic Equations in a Nonconvex Polygon

Fully discrete Finite Element Approximations of Semilinear Parabolic Equations in a Nonconvex Polygon Fully discrete Finite Element Approximations of Semilinear Parabolic Equations in a Nonconvex Polygon Tamal Pramanick 1,a) 1 Department of Mathematics, Indian Institute of Technology Guwahati, Guwahati

More information

Topology optimization of heat conduction problems

Topology optimization of heat conduction problems Topology optimization of heat conduction problems Workshop on industrial design optimization for fluid flow 23 September 2010 Misha Marie Gregersen Anton Evgrafov Mads Peter Sørensen Technical University

More information

Partial Differential Equations

Partial Differential Equations Simulation in Computer Graphics Partial Differential Equations Matthias Teschner Computer Science Department University of Freiburg Motivation various dynamic effects and physical processes are described

More information

Homogenization and numerical Upscaling. Unsaturated flow and two-phase flow

Homogenization and numerical Upscaling. Unsaturated flow and two-phase flow Homogenization and numerical Upscaling Unsaturated flow and two-phase flow Insa Neuweiler Institute of Hydromechanics, University of Stuttgart Outline Block 1: Introduction and Repetition Homogenization

More information

Numerical Methods for (Time-Dependent) HJ PDEs

Numerical Methods for (Time-Dependent) HJ PDEs Numerical Methods for (Time-Dependent) HJ PDEs Ian Mitchell Department of Computer Science The University of British Columbia research supported by National Science and Engineering Research Council of

More information

Driven Cavity Example

Driven Cavity Example BMAppendixI.qxd 11/14/12 6:55 PM Page I-1 I CFD Driven Cavity Example I.1 Problem One of the classic benchmarks in CFD is the driven cavity problem. Consider steady, incompressible, viscous flow in a square

More information

Lecture 2 Unstructured Mesh Generation

Lecture 2 Unstructured Mesh Generation Lecture 2 Unstructured Mesh Generation MIT 16.930 Advanced Topics in Numerical Methods for Partial Differential Equations Per-Olof Persson (persson@mit.edu) February 13, 2006 1 Mesh Generation Given a

More information

NUMERICAL VISCOSITY. Convergent Science White Paper. COPYRIGHT 2017 CONVERGENT SCIENCE. All rights reserved.

NUMERICAL VISCOSITY. Convergent Science White Paper. COPYRIGHT 2017 CONVERGENT SCIENCE. All rights reserved. Convergent Science White Paper COPYRIGHT 2017 CONVERGENT SCIENCE. All rights reserved. This document contains information that is proprietary to Convergent Science. Public dissemination of this document

More information

A NURBS-BASED APPROACH FOR SHAPE AND TOPOLOGY OPTIMIZATION OF FLOW DOMAINS

A NURBS-BASED APPROACH FOR SHAPE AND TOPOLOGY OPTIMIZATION OF FLOW DOMAINS 6th European Conference on Computational Mechanics (ECCM 6) 7th European Conference on Computational Fluid Dynamics (ECFD 7) 11 15 June 2018, Glasgow, UK A NURBS-BASED APPROACH FOR SHAPE AND TOPOLOGY OPTIMIZATION

More information

Control Volume Finite Difference On Adaptive Meshes

Control Volume Finite Difference On Adaptive Meshes Control Volume Finite Difference On Adaptive Meshes Sanjay Kumar Khattri, Gunnar E. Fladmark, Helge K. Dahle Department of Mathematics, University Bergen, Norway. sanjay@mi.uib.no Summary. In this work

More information

Contents. I The Basic Framework for Stationary Problems 1

Contents. I The Basic Framework for Stationary Problems 1 page v Preface xiii I The Basic Framework for Stationary Problems 1 1 Some model PDEs 3 1.1 Laplace s equation; elliptic BVPs... 3 1.1.1 Physical experiments modeled by Laplace s equation... 5 1.2 Other

More information

Finite Element Convergence for Time-Dependent PDEs with a Point Source in COMSOL 4.2

Finite Element Convergence for Time-Dependent PDEs with a Point Source in COMSOL 4.2 Finite Element Convergence for Time-Dependent PDEs with a Point Source in COMSOL 4.2 David W. Trott and Matthias K. Gobbert Department of Mathematics and Statistics, University of Maryland, Baltimore County,

More information

1. Mathematical Modelling

1. Mathematical Modelling 1. describe a given problem with some mathematical formalism in order to get a formal and precise description see fundamental properties due to the abstraction allow a systematic treatment and, thus, solution

More information

New Mexico Tech Hyd 510

New Mexico Tech Hyd 510 Numerics Motivation Modeling process (JLW) To construct a model we assemble and synthesize data and other information to formulate a conceptual model of the situation. The model is conditioned on the science

More information

f xx + f yy = F (x, y)

f xx + f yy = F (x, y) Application of the 2D finite element method to Laplace (Poisson) equation; f xx + f yy = F (x, y) M. R. Hadizadeh Computer Club, Department of Physics and Astronomy, Ohio University 4 Nov. 2013 Domain

More information

computational Fluid Dynamics - Prof. V. Esfahanian

computational Fluid Dynamics - Prof. V. Esfahanian Three boards categories: Experimental Theoretical Computational Crucial to know all three: Each has their advantages and disadvantages. Require validation and verification. School of Mechanical Engineering

More information

Verification of PDE Discretization Library and Flow Application Codes

Verification of PDE Discretization Library and Flow Application Codes Verification of PDE Discretization Library and Flow Application Codes Roy H. Stogner The University of Texas at Austin Jul 31, 2009 Roy H. Stogner PDE Verification Jul 31, 2009 1 / 30 The Problem 3D Hypersonic

More information

Numerical schemes for Hamilton-Jacobi equations, control problems and games

Numerical schemes for Hamilton-Jacobi equations, control problems and games Numerical schemes for Hamilton-Jacobi equations, control problems and games M. Falcone H. Zidani SADCO Spring School Applied and Numerical Optimal Control April 23-27, 2012, Paris Lecture 2/3 M. Falcone

More information

Numerical Analysis of Shock Tube Problem by using TVD and ACM Schemes

Numerical Analysis of Shock Tube Problem by using TVD and ACM Schemes Numerical Analysis of Shock Tube Problem by using TVD and Schemes Dr. Mukkarum Husain, Dr. M. Nauman Qureshi, Syed Zaid Hasany IST Karachi, Email: mrmukkarum@yahoo.com Abstract Computational Fluid Dynamics

More information

AMS527: Numerical Analysis II

AMS527: Numerical Analysis II AMS527: Numerical Analysis II A Brief Overview of Finite Element Methods Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao SUNY Stony Brook AMS527: Numerical Analysis II 1 / 25 Overview Basic concepts Mathematical

More information

Non-Linear Finite Element Methods in Solid Mechanics Attilio Frangi, Politecnico di Milano, February 3, 2017, Lesson 1

Non-Linear Finite Element Methods in Solid Mechanics Attilio Frangi, Politecnico di Milano, February 3, 2017, Lesson 1 Non-Linear Finite Element Methods in Solid Mechanics Attilio Frangi, attilio.frangi@polimi.it Politecnico di Milano, February 3, 2017, Lesson 1 1 Politecnico di Milano, February 3, 2017, Lesson 1 2 Outline

More information

Adaptive Isogeometric Analysis by Local h-refinement with T-splines

Adaptive Isogeometric Analysis by Local h-refinement with T-splines Adaptive Isogeometric Analysis by Local h-refinement with T-splines Michael Dörfel 1, Bert Jüttler 2, Bernd Simeon 1 1 TU Munich, Germany 2 JKU Linz, Austria SIMAI, Minisymposium M13 Outline Preliminaries:

More information

FLUENT Secondary flow in a teacup Author: John M. Cimbala, Penn State University Latest revision: 26 January 2016

FLUENT Secondary flow in a teacup Author: John M. Cimbala, Penn State University Latest revision: 26 January 2016 FLUENT Secondary flow in a teacup Author: John M. Cimbala, Penn State University Latest revision: 26 January 2016 Note: These instructions are based on an older version of FLUENT, and some of the instructions

More information

Finite Element Method. Chapter 7. Practical considerations in FEM modeling

Finite Element Method. Chapter 7. Practical considerations in FEM modeling Finite Element Method Chapter 7 Practical considerations in FEM modeling Finite Element Modeling General Consideration The following are some of the difficult tasks (or decisions) that face the engineer

More information

APPROXIMATING PDE s IN L 1

APPROXIMATING PDE s IN L 1 APPROXIMATING PDE s IN L 1 Veselin Dobrev Jean-Luc Guermond Bojan Popov Department of Mathematics Texas A&M University NONLINEAR APPROXIMATION TECHNIQUES USING L 1 Texas A&M May 16-18, 2008 Outline 1 Outline

More information

Chapter 6. Semi-Lagrangian Methods

Chapter 6. Semi-Lagrangian Methods Chapter 6. Semi-Lagrangian Methods References: Durran Chapter 6. Review article by Staniford and Cote (1991) MWR, 119, 2206-2223. 6.1. Introduction Semi-Lagrangian (S-L for short) methods, also called

More information

Verification and Validation in CFD and Heat Transfer: ANSYS Practice and the New ASME Standard

Verification and Validation in CFD and Heat Transfer: ANSYS Practice and the New ASME Standard Verification and Validation in CFD and Heat Transfer: ANSYS Practice and the New ASME Standard Dimitri P. Tselepidakis & Lewis Collins ASME 2012 Verification and Validation Symposium May 3 rd, 2012 1 Outline

More information

Literature Report. Daniël Pols. 23 May 2018

Literature Report. Daniël Pols. 23 May 2018 Literature Report Daniël Pols 23 May 2018 Applications Two-phase flow model The evolution of the momentum field in a two phase flow problem is given by the Navier-Stokes equations: u t + u u = 1 ρ p +

More information

Overview of Traditional Surface Tracking Methods

Overview of Traditional Surface Tracking Methods Liquid Simulation With Mesh-Based Surface Tracking Overview of Traditional Surface Tracking Methods Matthias Müller Introduction Research lead of NVIDIA PhysX team PhysX GPU acc. Game physics engine www.nvidia.com\physx

More information

Implementation of the Continuous-Discontinuous Galerkin Finite Element Method

Implementation of the Continuous-Discontinuous Galerkin Finite Element Method Implementation of the Continuous-Discontinuous Galerkin Finite Element Method Andrea Cangiani, John Chapman, Emmanuil Georgoulis and Max Jensen Abstract For the stationary advection-diffusion problem the

More information

The Level Set Method. Lecture Notes, MIT J / 2.097J / 6.339J Numerical Methods for Partial Differential Equations

The Level Set Method. Lecture Notes, MIT J / 2.097J / 6.339J Numerical Methods for Partial Differential Equations The Level Set Method Lecture Notes, MIT 16.920J / 2.097J / 6.339J Numerical Methods for Partial Differential Equations Per-Olof Persson persson@mit.edu March 7, 2005 1 Evolving Curves and Surfaces Evolving

More information

cuibm A GPU Accelerated Immersed Boundary Method

cuibm A GPU Accelerated Immersed Boundary Method cuibm A GPU Accelerated Immersed Boundary Method S. K. Layton, A. Krishnan and L. A. Barba Corresponding author: labarba@bu.edu Department of Mechanical Engineering, Boston University, Boston, MA, 225,

More information

LS-DYNA 980 : Recent Developments, Application Areas and Validation Process of the Incompressible fluid solver (ICFD) in LS-DYNA.

LS-DYNA 980 : Recent Developments, Application Areas and Validation Process of the Incompressible fluid solver (ICFD) in LS-DYNA. 12 th International LS-DYNA Users Conference FSI/ALE(1) LS-DYNA 980 : Recent Developments, Application Areas and Validation Process of the Incompressible fluid solver (ICFD) in LS-DYNA Part 1 Facundo Del

More information

Surface Parameterization

Surface Parameterization Surface Parameterization A Tutorial and Survey Michael Floater and Kai Hormann Presented by Afra Zomorodian CS 468 10/19/5 1 Problem 1-1 mapping from domain to surface Original application: Texture mapping

More information

CS205b/CME306. Lecture 9

CS205b/CME306. Lecture 9 CS205b/CME306 Lecture 9 1 Convection Supplementary Reading: Osher and Fedkiw, Sections 3.3 and 3.5; Leveque, Sections 6.7, 8.3, 10.2, 10.4. For a reference on Newton polynomial interpolation via divided

More information

2.7 Cloth Animation. Jacobs University Visualization and Computer Graphics Lab : Advanced Graphics - Chapter 2 123

2.7 Cloth Animation. Jacobs University Visualization and Computer Graphics Lab : Advanced Graphics - Chapter 2 123 2.7 Cloth Animation 320491: Advanced Graphics - Chapter 2 123 Example: Cloth draping Image Michael Kass 320491: Advanced Graphics - Chapter 2 124 Cloth using mass-spring model Network of masses and springs

More information

Shape Modeling and Geometry Processing

Shape Modeling and Geometry Processing 252-0538-00L, Spring 2018 Shape Modeling and Geometry Processing Discrete Differential Geometry Differential Geometry Motivation Formalize geometric properties of shapes Roi Poranne # 2 Differential Geometry

More information

CS 468 (Spring 2013) Discrete Differential Geometry

CS 468 (Spring 2013) Discrete Differential Geometry CS 468 (Spring 2013) Discrete Differential Geometry 1 Math Review Lecture 14 15 May 2013 Discrete Exterior Calculus Lecturer: Justin Solomon Scribe: Cassidy Saenz Before we dive into Discrete Exterior

More information

Possibility of Implicit LES for Two-Dimensional Incompressible Lid-Driven Cavity Flow Based on COMSOL Multiphysics

Possibility of Implicit LES for Two-Dimensional Incompressible Lid-Driven Cavity Flow Based on COMSOL Multiphysics Possibility of Implicit LES for Two-Dimensional Incompressible Lid-Driven Cavity Flow Based on COMSOL Multiphysics Masanori Hashiguchi 1 1 Keisoku Engineering System Co., Ltd. 1-9-5 Uchikanda, Chiyoda-ku,

More information

Collocation and optimization initialization

Collocation and optimization initialization Boundary Elements and Other Mesh Reduction Methods XXXVII 55 Collocation and optimization initialization E. J. Kansa 1 & L. Ling 2 1 Convergent Solutions, USA 2 Hong Kong Baptist University, Hong Kong

More information

Imaging of flow in porous media - from optimal transport to prediction

Imaging of flow in porous media - from optimal transport to prediction Imaging of flow in porous media - from optimal transport to prediction Eldad Haber Dept of EOS and Mathematics, UBC October 15, 2013 With Rowan Lars Jenn Cocket Ruthotto Fohring Outline Prediction is very

More information

Outline. Level Set Methods. For Inverse Obstacle Problems 4. Introduction. Introduction. Martin Burger

Outline. Level Set Methods. For Inverse Obstacle Problems 4. Introduction. Introduction. Martin Burger For Inverse Obstacle Problems Martin Burger Outline Introduction Optimal Geometries Inverse Obstacle Problems & Shape Optimization Sensitivity Analysis based on Gradient Flows Numerical Methods University

More information

THE MORTAR FINITE ELEMENT METHOD IN 2D: IMPLEMENTATION IN MATLAB

THE MORTAR FINITE ELEMENT METHOD IN 2D: IMPLEMENTATION IN MATLAB THE MORTAR FINITE ELEMENT METHOD IN D: IMPLEMENTATION IN MATLAB J. Daněk, H. Kutáková Department of Mathematics, University of West Bohemia, Pilsen MECAS ESI s.r.o., Pilsen Abstract The paper is focused

More information

MODELING MIXED BOUNDARY PROBLEMS WITH THE COMPLEX VARIABLE BOUNDARY ELEMENT METHOD (CVBEM) USING MATLAB AND MATHEMATICA

MODELING MIXED BOUNDARY PROBLEMS WITH THE COMPLEX VARIABLE BOUNDARY ELEMENT METHOD (CVBEM) USING MATLAB AND MATHEMATICA A. N. Johnson et al., Int. J. Comp. Meth. and Exp. Meas., Vol. 3, No. 3 (2015) 269 278 MODELING MIXED BOUNDARY PROBLEMS WITH THE COMPLEX VARIABLE BOUNDARY ELEMENT METHOD (CVBEM) USING MATLAB AND MATHEMATICA

More information

Accelerating Double Precision FEM Simulations with GPUs

Accelerating Double Precision FEM Simulations with GPUs Accelerating Double Precision FEM Simulations with GPUs Dominik Göddeke 1 3 Robert Strzodka 2 Stefan Turek 1 dominik.goeddeke@math.uni-dortmund.de 1 Mathematics III: Applied Mathematics and Numerics, University

More information

Development of a Maxwell Equation Solver for Application to Two Fluid Plasma Models. C. Aberle, A. Hakim, and U. Shumlak

Development of a Maxwell Equation Solver for Application to Two Fluid Plasma Models. C. Aberle, A. Hakim, and U. Shumlak Development of a Maxwell Equation Solver for Application to Two Fluid Plasma Models C. Aberle, A. Hakim, and U. Shumlak Aerospace and Astronautics University of Washington, Seattle American Physical Society

More information

Numerical and theoretical analysis of shock waves interaction and reflection

Numerical and theoretical analysis of shock waves interaction and reflection Fluid Structure Interaction and Moving Boundary Problems IV 299 Numerical and theoretical analysis of shock waves interaction and reflection K. Alhussan Space Research Institute, King Abdulaziz City for

More information

Debojyoti Ghosh. Adviser: Dr. James Baeder Alfred Gessow Rotorcraft Center Department of Aerospace Engineering

Debojyoti Ghosh. Adviser: Dr. James Baeder Alfred Gessow Rotorcraft Center Department of Aerospace Engineering Debojyoti Ghosh Adviser: Dr. James Baeder Alfred Gessow Rotorcraft Center Department of Aerospace Engineering To study the Dynamic Stalling of rotor blade cross-sections Unsteady Aerodynamics: Time varying

More information

SPH: Why and what for?

SPH: Why and what for? SPH: Why and what for? 4 th SPHERIC training day David Le Touzé, Fluid Mechanics Laboratory, Ecole Centrale de Nantes / CNRS SPH What for and why? How it works? Why not for everything? Duality of SPH SPH

More information

An Interface-fitted Mesh Generator and Polytopal Element Methods for Elliptic Interface Problems

An Interface-fitted Mesh Generator and Polytopal Element Methods for Elliptic Interface Problems An Interface-fitted Mesh Generator and Polytopal Element Methods for Elliptic Interface Problems Long Chen University of California, Irvine chenlong@math.uci.edu Joint work with: Huayi Wei (Xiangtan University),

More information

ALF USER GUIDE. Date: September

ALF USER GUIDE. Date: September ALF USER GUIDE R. VERFÜRTH Contents 1. Introduction 1 2. User interface 2 3. Domain and initial grid 3 4. Differential equation 9 5. Discretization 12 6. Solver 12 7. Mesh refinement 14 8. Number of nodes

More information

Epistemic/Non-probabilistic Uncertainty Propagation Using Fuzzy Sets

Epistemic/Non-probabilistic Uncertainty Propagation Using Fuzzy Sets Epistemic/Non-probabilistic Uncertainty Propagation Using Fuzzy Sets Dongbin Xiu Department of Mathematics, and Scientific Computing and Imaging (SCI) Institute University of Utah Outline Introduction

More information

Studies of the Continuous and Discrete Adjoint Approaches to Viscous Automatic Aerodynamic Shape Optimization

Studies of the Continuous and Discrete Adjoint Approaches to Viscous Automatic Aerodynamic Shape Optimization Studies of the Continuous and Discrete Adjoint Approaches to Viscous Automatic Aerodynamic Shape Optimization Siva Nadarajah Antony Jameson Stanford University 15th AIAA Computational Fluid Dynamics Conference

More information

Adaptive Mesh Refinement Based on a Posteriori Error Estimation. Martin Juhas

Adaptive Mesh Refinement Based on a Posteriori Error Estimation. Martin Juhas Adaptive Mesh Refinement Based on a Posteriori Error Estimation by Martin Juhas A thesis submitted in conformity with the requirements for the degree of Master of Applied Science Graduate Department of

More information

Parallel High-Order Geometric Multigrid Methods on Adaptive Meshes for Highly Heterogeneous Nonlinear Stokes Flow Simulations of Earth s Mantle

Parallel High-Order Geometric Multigrid Methods on Adaptive Meshes for Highly Heterogeneous Nonlinear Stokes Flow Simulations of Earth s Mantle ICES Student Forum The University of Texas at Austin, USA November 4, 204 Parallel High-Order Geometric Multigrid Methods on Adaptive Meshes for Highly Heterogeneous Nonlinear Stokes Flow Simulations of

More information

Proposal of Research Activity. PhD Course in Space Sciences, Technologies and Measurements (STMS)

Proposal of Research Activity. PhD Course in Space Sciences, Technologies and Measurements (STMS) Proposal of Research Activity PhD Course in Space Sciences, Technologies and Measurements (STMS) Curriculum: Sciences and Technologies for Aeronautics and Satellite Applications (STASA) XXXIV Cycle PhD

More information

Isogeometric Analysis of Fluid-Structure Interaction

Isogeometric Analysis of Fluid-Structure Interaction Isogeometric Analysis of Fluid-Structure Interaction Y. Bazilevs, V.M. Calo, T.J.R. Hughes Institute for Computational Engineering and Sciences, The University of Texas at Austin, USA e-mail: {bazily,victor,hughes}@ices.utexas.edu

More information

MATHEMATICAL ANALYSIS, MODELING AND OPTIMIZATION OF COMPLEX HEAT TRANSFER PROCESSES

MATHEMATICAL ANALYSIS, MODELING AND OPTIMIZATION OF COMPLEX HEAT TRANSFER PROCESSES MATHEMATICAL ANALYSIS, MODELING AND OPTIMIZATION OF COMPLEX HEAT TRANSFER PROCESSES Goals of research Dr. Uldis Raitums, Dr. Kārlis Birģelis To develop and investigate mathematical properties of algorithms

More information

Solutions of 3D Navier-Stokes benchmark problems with adaptive finite elements 1

Solutions of 3D Navier-Stokes benchmark problems with adaptive finite elements 1 Solutions of 3D Navier-Stokes benchmark problems with adaptive finite elements 1 M. Braack a T. Richter b a Institute of Applied Mathematics, University of Heidelberg, INF 294, 69120 Heidelberg, Germany

More information

: What is Finite Element Analysis (FEA)?

: What is Finite Element Analysis (FEA)? Q: What is Finite Element Analysis (FEA)? A1: It is a numerical technique for finding approximate solutions of partial differential equations (PDE) as well as of integral equations. The solution approach

More information

Modeling with Uncertainty Interval Computations Using Fuzzy Sets

Modeling with Uncertainty Interval Computations Using Fuzzy Sets Modeling with Uncertainty Interval Computations Using Fuzzy Sets J. Honda, R. Tankelevich Department of Mathematical and Computer Sciences, Colorado School of Mines, Golden, CO, U.S.A. Abstract A new method

More information

Metafor FE Software. 2. Operator split. 4. Rezoning methods 5. Contact with friction

Metafor FE Software. 2. Operator split. 4. Rezoning methods 5. Contact with friction ALE simulations ua sus using Metafor eao 1. Introduction 2. Operator split 3. Convection schemes 4. Rezoning methods 5. Contact with friction 1 Introduction EULERIAN FORMALISM Undistorted mesh Ideal for

More information

Module 1 Lecture Notes 2. Optimization Problem and Model Formulation

Module 1 Lecture Notes 2. Optimization Problem and Model Formulation Optimization Methods: Introduction and Basic concepts 1 Module 1 Lecture Notes 2 Optimization Problem and Model Formulation Introduction In the previous lecture we studied the evolution of optimization

More information

A brief description of the particle finite element method (PFEM2). Extensions to free surface

A brief description of the particle finite element method (PFEM2). Extensions to free surface A brief description of the particle finite element method (PFEM2). Extensions to free surface flows. Juan M. Gimenez, L.M. González, CIMEC Universidad Nacional del Litoral (UNL) Santa Fe, Argentina Universidad

More information

Multi-Mesh CFD. Chris Roy Chip Jackson (1 st year PhD student) Aerospace and Ocean Engineering Department Virginia Tech

Multi-Mesh CFD. Chris Roy Chip Jackson (1 st year PhD student) Aerospace and Ocean Engineering Department Virginia Tech Multi-Mesh CFD Chris Roy Chip Jackson (1 st year PhD student) Aerospace and Ocean Engineering Department Virginia Tech cjroy@vt.edu May 21, 2014 CCAS Program Review, Columbus, OH 1 Motivation Automated

More information

Preliminary Spray Cooling Simulations Using a Full-Cone Water Spray

Preliminary Spray Cooling Simulations Using a Full-Cone Water Spray 39th Dayton-Cincinnati Aerospace Sciences Symposium Preliminary Spray Cooling Simulations Using a Full-Cone Water Spray Murat Dinc Prof. Donald D. Gray (advisor), Prof. John M. Kuhlman, Nicholas L. Hillen,

More information

Final Report. Discontinuous Galerkin Compressible Euler Equation Solver. May 14, Andrey Andreyev. Adviser: Dr. James Baeder

Final Report. Discontinuous Galerkin Compressible Euler Equation Solver. May 14, Andrey Andreyev. Adviser: Dr. James Baeder Final Report Discontinuous Galerkin Compressible Euler Equation Solver May 14, 2013 Andrey Andreyev Adviser: Dr. James Baeder Abstract: In this work a Discontinuous Galerkin Method is developed for compressible

More information

FEMLAB Exercise 1 for ChE366

FEMLAB Exercise 1 for ChE366 FEMLAB Exercise 1 for ChE366 Problem statement Consider a spherical particle of radius r s moving with constant velocity U in an infinitely long cylinder of radius R that contains a Newtonian fluid. Let

More information

Modeling External Compressible Flow

Modeling External Compressible Flow Tutorial 3. Modeling External Compressible Flow Introduction The purpose of this tutorial is to compute the turbulent flow past a transonic airfoil at a nonzero angle of attack. You will use the Spalart-Allmaras

More information

CONFORMAL MAPPING POTENTIAL FLOW AROUND A WINGSECTION USED AS A TEST CASE FOR THE INVISCID PART OF RANS SOLVERS

CONFORMAL MAPPING POTENTIAL FLOW AROUND A WINGSECTION USED AS A TEST CASE FOR THE INVISCID PART OF RANS SOLVERS European Conference on Computational Fluid Dynamics ECCOMAS CFD 2006 P. Wesseling, E. Oñate and J. Périaux (Eds) c TU Delft, The Netherlands, 2006 CONFORMAL MAPPING POTENTIAL FLOW AROUND A WINGSECTION

More information

Calculate a solution using the pressure-based coupled solver.

Calculate a solution using the pressure-based coupled solver. Tutorial 19. Modeling Cavitation Introduction This tutorial examines the pressure-driven cavitating flow of water through a sharpedged orifice. This is a typical configuration in fuel injectors, and brings

More information