SlideShare a Scribd company logo
High Order Finite Elements for Lagrangian
     Computational Fluid Dynamics


                  Truman E. Ellis
               Advisor: Dr. Faisal Kolkailah
    LLNL Mentors: Dr. Robert Rieben and Dr. Tzanio Kolev



     Department of Aerospace Engineering
     California Polytechnic State University
              San Luis Obispo, CA
            ellis.truman@gmail.com


                    November 18, 2009


               This work performed under the auspices
                of the U.S. Department of Energy by
               Lawrence Livermore National Laboratory
                under Contract DE-AC52-07NA27344
                     LLNL-PRES-416883, -416822



                                                           Powered by L EX
                                                                      AT
Introduction



  We are developing advanced finite element
  discretization methods for Lagrangian
  hydrodynamics.
  Our goal is to improve the current
  staggered grid hydro (SGH) algorithms in
  multi-material ALE codes with respect to:
       symmetry preservation
       energy conservation
       artificial viscosity discretization
       hourglass-mode instabilities
  We consider a general framework for
  solving the Euler equations with the
  following features:
       allows for high order field representations
       allows for curved element geometry
       exact energy conservation by construction
       reduces to classical SGH under simplifying assumptions




     Truman Ellis (Cal Poly)           High Order Finite Elements for Lagrangian CFD   November 2009   2 / 27
Glossary


We consider several different hydro methods which make use of various finite element spaces.
The specific finite element spaces considered in this talk are:

    Q0: constant function on quadrilaterals
    Q1: continuous bi linear functions on quadrilaterals
    Q2: continuous bi-quadratic functions on quadrilaterals
    Q1d: discontinuous bi-linear functions on quadrilaterals
    Q2d: discontinuous bi-quadratic function on quadrilaterals

Each hydro method is designated by a pair of finite element spaces:

    A continuous kinematic space
    A discontinuous thermodynamic space

For example: Q2-Q1d uses continuous quadratic velocities and positions with discontinuous bi-
linear pressures and densities.




       Truman Ellis (Cal Poly)    High Order Finite Elements for Lagrangian CFD   November 2009   3 / 27
Euler Equations in a Lagrangian Frame

                                                                                                  Typically, these equations are
                                                                                                  solved on a staggered spatial grid
                                                                                                  [1,2] where thermodynamic
   The Euler equations of gas dynamics in a Lagrangian                                            variables are approximated as
   reference frame can be written in differential form as:                                        piece-wise constants defined on
                                                                                                  zone centers and kinematic
                                                                                                  variables are defined on the
                                                         ∂v
      Momentum Conservation:                         ρ      = −∇p + ...                           nodes.
                                                         ∂t
                                                                                                  Spatial gradients are computed
                                                      1 ∂ρ                                        using finite volume and/or finite
      Mass Conservation:                                   = −∇ · v
                                                      ρ ∂t                                        difference methods:

                                                         ∂e
      Energy Conservation:                           ρ      = −p∇ · v + ...
                                                         ∂t

      Equation of State:                             p = EOS(e, ρ)




[1] R. Tipton, CALE Lagrange Step, unpublished LLNL report, 1990
[2] M. Wilkins, Calculations of Elastic-Plastic Flow, In Methods of Computational Physics, 1964



           Truman Ellis (Cal Poly)                     High Order Finite Elements for Lagrangian CFD                   November 2009   4 / 27
Semi-Discrete Finite Element Approximation: Computational Mesh

We propose a general semi-discrete FEM approach to solving the Euler equations in a Lagrangian
frame. A semi-discrete method is only concerned with the spatial approximation of the continuum
equations.
To begin, we decompose the continuum domain at an initial time into a set of non-overlapping
discrete volumes (zones). The union of these volumes forms the computational mesh:




                                                −→

                      Ω(t0 )                                                     ˜
                                                                                 Ω(t0 ) = ∪Z ΩZ (t0 )


The motion of the continuous medium will therefore be described by the motion of only a finite
number of particles (mesh vertices, edge midpoints, etc )


       Truman Ellis (Cal Poly)   High Order Finite Elements for Lagrangian CFD                 November 2009   5 / 27
Semi-Discrete Finite Element Approximation: Lagrangian Mesh Motion
After deformation in time, zones are reconstructed based on                       This reconstruction process
particle locations, thus defining the moved mesh.                                  has an inherent geometric
                                                                                  error.




                                                                                  Initial Cartesian mesh
                                           Q2 (Bi-Quadratic)                      deformed with the exact
 Q1 (Bi-Linear) Approximation                                                     solution of the Sedov blast
                                            Approximation
                                                                                  wave problem.


This built in geometric error motivates the use of (higher order) finite elements which can use the
additional particle degrees of freedom to more accurately represent continuous deformations.

       Truman Ellis (Cal Poly)    High Order Finite Elements for Lagrangian CFD                 November 2009   6 / 27
Lagrangian Mesh Motion: Animation




    Truman Ellis (Cal Poly)   High Order Finite Elements for Lagrangian CFD   November 2009   7 / 27
Semi-Discrete Finite Element Approximation: Curved Geometries
Finite element basis functions are defined on a reference (unit) zone. To compute quantities on an
arbitrary mesh zone, we use the Jacobian matrix which defines the geometric transformation (or
mapping) from reference space:
         Reference Space:                                                    Physical Space:




                   ˆ
                φ (x)                                                               φ (x) = φ (Φ−1 (x))
                                                                                            ˆ

                   ˆ                                                                        −1 ˆ
               ∇φ (x)                                                                 ∇φ = JZ ∇φ


A standard Q1 mapping gives zones with straight edges, while Q2 mappings produce curved zones.
Note that we can have Q1 elements defined with a Q2 mapping and vice versa. The finite element
reference degrees of freedom are in general different from the nodes of the mapping.

       Truman Ellis (Cal Poly)      High Order Finite Elements for Lagrangian CFD              November 2009   8 / 27
Semi-Discrete Finite Element Approximation: Basis Functions
We approximate each of the continuum fields with a basis function expansion, where the
expansion coefficients are independent of space:
                                            Nv                                                                              Np
              Velocity: v(x, t) ≈ ∑ vi (t)wi (x)                                                Pressure: p(x, t) ≈ ∑ pi (t)φi (x)
                                             i                                                                               i
                                                   Ne                                                                      Nρ
        Internal Energy: e(x, t) ≈ ∑ ei (t)θi (x)                                                Density: ρ(x, t) ≈ ∑ ρi (t)ψi (x)
                                                    i                                                                       i

Our formulation is general; we are free to choose various types of basis functions. However,
stability requires that certain choices are not independent[1] (e.g. pressure and velocity.)




                                                                                                                Q2 basis function with degrees of
     Q1 (Bi-Linear) basis function                       Q2 (Bi-Quadratic) basis function
                                                                                                                        freedom at the 9
          4 DOF per Quad                                        9 DOF per Quad
                                                                                                                  Gauss-Legendre quadrature
                                                                                                                             points
[1] See for example: D. Arnold et. al., Differential Complexes and stability of Finite Element Methods, 2005.

            Truman Ellis (Cal Poly)                     High Order Finite Elements for Lagrangian CFD                            November 2009   9 / 27
Semi-Discrete Momentum Conservation

To derive a semi-discrete momentum conservation law, we begin with a variational formulation:

         dv                                           dv
     ρ      = −∇p            =⇒                  ρ           ·w =             (∇p) · w        =                 p(∇ · w ) −               p(w · n)
                                                                                                                                                ˆ
         dt                              ˜
                                         Ω(t)         dt               ˜
                                                                       Ω(t)                            ˜
                                                                                                       Ω(t)                        ˜
                                                                                                                                 ∂ Ω(t)
               Multiply by vector valued test
                                                                                       Perform integration
                 function, integrate over
                                                                                            by parts
                   computational mesh

Inserting our basis function expansions and applying Galerkins method by picking the velocity
basis as the test function yields the following linear system of equations:


                                                                                      −→
                                                                                Write in matrix / vector form
                      dvi                                                                                                        dv
     ˜
              ρ∑
                      dt
                          wi · wj =
                                            ˜
                                                 ∑ pi φi (∇· wj )                                                          M        = DT p
     Ω(t)         i                         Ω(t)  i                                                                              dt
The Mass and Derivative matrices are computed zone by zone and assembled to form global
systems:


                (Mz )ij =            Ω(t) ρ(wi · wj )
                                     ˜                                                  (Dz )ij =            Ω(t) φi (∇ · wj )
                                                                                                             ˜
                  The symmetric positive definite mass matrix
                                                                                             The rectangular derivative matrix maps
                  describes how matter is distributed in space
                                                                                          between pressure and velocity spaces. This
                                                                                         matrix is a discrete version of the Div operator.
                                                                                           Its adjoint (transpose) is the Grad operator




         Truman Ellis (Cal Poly)                      High Order Finite Elements for Lagrangian CFD                                November 2009     10 / 27
Computing Mass and Derivative Matrices

In practice, we compute the mass and derivative matrices by integrating over the reference volume
using a change of variables:
                                                          f=          (f ◦ Φ)|Jz |
                                                   Ω(t)        ˜
                                                               Ω(t)

The integrals are computed using Gaussian quadrature of a specified order. For certain integrands
and quadrature rules, this can be computed exactly:
                                                               Nq

                                       ˜
                                       Ω(t)
                                              (f ◦ Φ)|Jz | ≈   ∑ αn {f ◦ Φ)|Jz |}x=qˆn
                                                                                 ˆ
                                                               n=1




   2D Order 1 Gauss-Legendre      2D Order 2 Gauss-Legendre             2D Order 3 Gauss-Legendre   2D Order 4 Gauss-Legendre
       rule (exact for Q1)            rule (exact for Q3)                   rule (exact for Q5)         rule (exact for Q7)




        Truman Ellis (Cal Poly)           High Order Finite Elements for Lagrangian CFD                   November 2009     11 / 27
Semi-Discrete Mass Conservation

We define the zonal mass moments in a natural manner:                          mz,i =              ρψi
                                                                                         Ωz (t)

                                                       dmz,i
The Lagrangian description requires that:                    =0
                                                        dt

From the representation:         ρ(x, t) ≈ ∑ρi (t)ψi (x)        it follows that:           mz,i = ∑ ρz,j             ψi ψj
                                            i                                                           j
                                                                                                            Ωz (t)


In matrix form we have:          mz = Mρ ρz
                                       z           where         (Mρ )i,j =
                                                                   z                    ψi ψj
                                                                              Ωz (t)

                                                d
If we impose the stronger condition:                    ρψ = 0         for any function ψ
                                                dt Ω(t)

then we obtain the strong mass conservation principle:
                                   ρ(t)|J(t)| = ρ(t0 )|J(t0 )|

Note that, in general, the density defined by the above equation is not polynomial.

             Note that both generalizations imply the standard zonal mass conservation



       Truman Ellis (Cal Poly)          High Order Finite Elements for Lagrangian CFD                          November 2009   12 / 27
Mixed Finite Elements




     Truman Ellis (Cal Poly)   High Order Finite Elements for Lagrangian CFD   November 2009   13 / 27
High Order Methods Using the Q2 Basis

                                                           Points in reference space           Points in physical space

For each Q2 zone, we track 9
independent vertices
(coordinates, velocities,
accelerations etc ) which define
the quadratic mapping from
reference space to physical
space. This mapping is defined
using the Q2 Jacobian matrix,
which is a function:

 Jmat=[(-4*(y - 1)*(2*y - 1)*(2*x - 1)*X5 +
                                                       Basis function in reference space    Basis function in physical space
(y - 1)*(2*y - 1)*(4*x - 3)*X1 + (y- 1)*(2*y
- 1)*(4*x - 1)*X2 + 16*(y - 1)*(2*x - 1)*X9*y
- 4*(y - 1)*(4*x- 3)*X8*y - 4*(y - 1)*(4*x -
1)*X6*y - 4*(2*y - 1)*(2*x - 1)*X7*y + (2*y-
1)*(4*x - 3)*X4*y + (2*y - 1)*(4*x -
1)*X3*y); (-4*(2*y - 1)*(x - 1)*(2*x - 1)*X8
+ 16*(2*y - 1)*(x - 1)*X9*x - 4*(2*y -1)*(2*x
- 1)*X6*x + (4*y - 3)*(x - 1)*(2*x - 1)*X1 -
4*(4*y - 3)*(x -1)*X5*x + (4*y - 3)*(2*x -
1)*X2*x + (4*y - 1)*(x - 1)*(2*x - 1)*X4
-4*(4*y - 1)*(x - 1)*X7*x + (4*y - 1)*(2*x -
1)*X3*x)];




        Truman Ellis (Cal Poly)             High Order Finite Elements for Lagrangian CFD                November 2009         14 / 27
High Order Methods Using the Q2 Basis

For each zone in the computational mesh, we compute the following matrices using
Gauss-Legendre quadrature of a specified order.:

     The symmetric positive definite 9 by 9 mass
     matrix describes how matter is distributed                     (Mz )i,j ≡          ρz (wi wj )|Jz |
     within the Q2 zone                                                            ˆ
                                                                                   Ωz



     The rectangular derivative matrix maps
     between the pressure and velocity spaces.
                                                                    (Dx )i,j ≡
                                                                      z                 φi (J−1 ∇wj ) · {1, 0}|Jz |
                                                                                             z
                                                                                  ˆ
                                                                                  Ωz
     This matrix is a discrete version of the Div
     operator. Its adjoint (transpose) is the Grad
     operator
                                                                    (Dy )i,j ≡
                                                                      z                 φi (J−1 ∇wj ) · {0, 1}|Jz |
                                                                                             z
                                                                                  ˆ
                                                                                  Ωz


     The symmetric positive definite 9 by 9 stiffness
     matrix is a discrete version of the second order
     DivGrad operator. It is used to compute the
                                                                    (Sz )i,j ≡         µz (J−1 ∇wi )(Jz ∇wj )|Jz |
                                                                                            z
                                                                                                      −1
                                                                                  ˆ
                                                                                  Ωz
     artificial viscosity




The bulk of the computational effort is in computing the high order Jacobian matrix. However, this
can be computed once per DOF and shared between each matrix.


For the remaining examples, we apply mass lumping to the mass matrix to eliminate the need for
a global linear solve. In addition, we compute the mass matrix only once as an initial condition.


       Truman Ellis (Cal Poly)                       High Order Finite Elements for Lagrangian CFD                    November 2009   15 / 27
Static Momentum Equation Solve Convergence Study
In this simple test, we project an analytic pressure function                       Lumped mass matrix
onto a randomly perturbed mesh and solve for the
resulting accelerations:



                  π       π
    p(x, y) = cos( x) cos( y)
                  2       2
             ma = −∇p
            Ma = −DT p

                                                                                      Full linear solve

Randomly perturbed base line mesh and a sequence of
refinements




        Truman Ellis (Cal Poly)     High Order Finite Elements for Lagrangian CFD                November 2009   16 / 27
1D Sod Shock Tube: Velocity and Density




   We consider two meshes: A coarse 60 zone mesh and fine 120 zone mesh
   For each method, qlin = qquad = 1.0, no monotonic limiter is used
   We acknowledge this is sub-standard for Q1 (i.e. limiters make a difference); however, this a
   fair comparison between each method
   For each zone, 5 plot points are evaluated
   Each method captures contact discontinuity exactly due to discontinuous thermodynamic
   basis


     Truman Ellis (Cal Poly)     High Order Finite Elements for Lagrangian CFD   November 2009   17 / 27
1D Sod Shock Tube: Velocity and Density (Zoomed View)




   We consider two meshes: A coarse 60 zone mesh and fine 120 zone mesh
   For each method, qlin = qquad = 1.0, no monotonic limiter is used
   We acknowledge this is sub-standard for Q1 (i.e. limiters make a difference); however, this a
   fair comparison between each method
   For each zone, 5 plot points are evaluated
   Each method captures contact discontinuity exactly due to discontinuous thermodynamic
   basis


     Truman Ellis (Cal Poly)     High Order Finite Elements for Lagrangian CFD   November 2009   18 / 27
Sedov Blast Problem, 20 by 20 Mesh: Q1-Q0 FEM


 Standard HG filter
 required
 Shock is not well
 resolved on this
 coarse mesh




      Truman Ellis (Cal Poly)   High Order Finite Elements for Lagrangian CFD   November 2009   19 / 27
Sedov Blast Problem, 20 by 20 Mesh: Q2-Q1d FEM


 No HG filter used
 Curved elements
 81 plot points used per cell
 Shock front is much sharper
 on the same mesh
 Zone at origin has incorrect
 deformation
 Velocity oscillations are
 observed in post shock region




        Truman Ellis (Cal Poly)   High Order Finite Elements for Lagrangian CFD   November 2009   20 / 27
Sedov Blast Problem, 20 by 20 Mesh: Q2-Q1d FEM


 No HG filter used
 81 plot points used per cell
 Allowing 25% of the linear-q
 term in expansion has a
 significant benefit
 Velocity oscillations in post
 shock region are eliminated
 Curved deformation of zones
 closely resembles exact
 deformation
 We have not taken full benefit
 of the high order information
 in each cell to compute the
 viscosity coefficient, this is an
 area we plan to investigate
 much further




         Truman Ellis (Cal Poly)    High Order Finite Elements for Lagrangian CFD   November 2009   21 / 27
Sedov Blast Problem, 20 by 20 Mesh Comparison




    Truman Ellis (Cal Poly)   High Order Finite Elements for Lagrangian CFD   November 2009   22 / 27
Noh Implosion Problem, 30 by 30 Mesh: Q1-Q0 FEM


 Standard HG filter
 required
 Shock is not well
 resolved on this
 coarse mesh
 No overshoots or
 undershoots are
 observed




      Truman Ellis (Cal Poly)   High Order Finite Elements for Lagrangian CFD   November 2009   23 / 27
Noh Implosion Problem, 30 by 30 Mesh: Q2-Q1d FEM


 No HG filter used
 36 plot points per zone
 Shock is more sharply
 resolved
 Wall heating is diminished
 Post shock density is closer
 to correct value
 Strong undershoots and
 overshoots in the density are
 observed in the single layer of
 zones at shock front




        Truman Ellis (Cal Poly)    High Order Finite Elements for Lagrangian CFD   November 2009   24 / 27
Noh Implosion Problem, 30 by 30 Mesh: Q2-Q2d FEM


 No HG filter used
 36 plot points per zone
 Shock is more sharply
 resolved
 Wall heating is diminished
 Post shock density is closer
 to correct value
 Under shoots in density
 diminished, but overshoots
 persist




        Truman Ellis (Cal Poly)   High Order Finite Elements for Lagrangian CFD   November 2009   25 / 27
Conclusions

We have developed a general FEM framework for Lagrangian CFD

    Kinematic and thermodynamic space can be chosen independently
    For triangles:
          Linear, quadratic, cubic, etc. kinematic space
          Constant, linear, quadratic, etc. thermodynamic space
    For quads:
          Bi-linear, bi-quadratic, bi-cubic, etc. kinematic space
          Constant, bi-linear, bi-quadratic, etc. thermodynamic space
    This allows us to experiment with many different finite element pairs

We have also demonstrated that high order Lagrangian methods have significant promise

    Permits curved elements
    Increased accuracy
    Sharper shocks
    Density/pressure gradients in a single cell
    Second derivatives of velocity in a single cell
    Potential improvements for sub-zonal physics / multi-material ALE
    Post shock ringing is still an issue and we plan to address this by improving the artificial
    viscosity coefficient (e.g. the Hyper Viscosity technique of Cook and Cabot)


       Truman Ellis (Cal Poly)        High Order Finite Elements for Lagrangian CFD   November 2009   26 / 27

More Related Content

What's hot

Introduction to Quantum Monte Carlo
Introduction to Quantum Monte CarloIntroduction to Quantum Monte Carlo
Introduction to Quantum Monte Carlo
Claudio Attaccalite
 
Large scale coherent structures and turbulence in quasi-2D hydrodynamic models
Large scale coherent structures and turbulence in quasi-2D hydrodynamic modelsLarge scale coherent structures and turbulence in quasi-2D hydrodynamic models
Large scale coherent structures and turbulence in quasi-2D hydrodynamic modelsColm Connaughton
 
Density functional theory (DFT) and the concepts of the augmented-plane-wave ...
Density functional theory (DFT) and the concepts of the augmented-plane-wave ...Density functional theory (DFT) and the concepts of the augmented-plane-wave ...
Density functional theory (DFT) and the concepts of the augmented-plane-wave ...
ABDERRAHMANE REGGAD
 
Introduction to (weak) wave turbulence
Introduction to (weak) wave turbulenceIntroduction to (weak) wave turbulence
Introduction to (weak) wave turbulence
Colm Connaughton
 
Fluctuations and rare events in stochastic aggregation
Fluctuations and rare events in stochastic aggregationFluctuations and rare events in stochastic aggregation
Fluctuations and rare events in stochastic aggregation
Colm Connaughton
 
"Warm tachyon matter" - N. Bilic
"Warm tachyon matter" - N. Bilic"Warm tachyon matter" - N. Bilic
"Warm tachyon matter" - N. Bilic
SEENET-MTP
 
Nonequilibrium statistical mechanics of cluster-cluster aggregation, School o...
Nonequilibrium statistical mechanics of cluster-cluster aggregation, School o...Nonequilibrium statistical mechanics of cluster-cluster aggregation, School o...
Nonequilibrium statistical mechanics of cluster-cluster aggregation, School o...Colm Connaughton
 
An R-matrix approach for plasma modelling and the interpretation of astrophys...
An R-matrix approach for plasma modelling and the interpretation of astrophys...An R-matrix approach for plasma modelling and the interpretation of astrophys...
An R-matrix approach for plasma modelling and the interpretation of astrophys...
AstroAtom
 
Localized Electrons with Wien2k
Localized Electrons with Wien2kLocalized Electrons with Wien2k
Localized Electrons with Wien2k
ABDERRAHMANE REGGAD
 
CP and Discrete Symmetries
CP and Discrete SymmetriesCP and Discrete Symmetries
CP and Discrete Symmetries
mholthau
 
Cluster aggregation with complete collisional fragmentation
Cluster aggregation with complete collisional fragmentationCluster aggregation with complete collisional fragmentation
Cluster aggregation with complete collisional fragmentationColm Connaughton
 
A. Morozov - Black Hole Motion in Entropic Reformulation of General Relativity
A. Morozov - Black Hole Motion in Entropic Reformulation of General RelativityA. Morozov - Black Hole Motion in Entropic Reformulation of General Relativity
A. Morozov - Black Hole Motion in Entropic Reformulation of General Relativity
SEENET-MTP
 
10.1.1.2.9988
10.1.1.2.998810.1.1.2.9988
10.1.1.2.9988
ahmedmudher
 
The inverse droplet coagulation problem
The inverse droplet coagulation problemThe inverse droplet coagulation problem
The inverse droplet coagulation problem
Colm Connaughton
 
Wien2k getting started
Wien2k getting startedWien2k getting started
Wien2k getting started
ABDERRAHMANE REGGAD
 

What's hot (20)

Introduction to Quantum Monte Carlo
Introduction to Quantum Monte CarloIntroduction to Quantum Monte Carlo
Introduction to Quantum Monte Carlo
 
Large scale coherent structures and turbulence in quasi-2D hydrodynamic models
Large scale coherent structures and turbulence in quasi-2D hydrodynamic modelsLarge scale coherent structures and turbulence in quasi-2D hydrodynamic models
Large scale coherent structures and turbulence in quasi-2D hydrodynamic models
 
Dressing2011
Dressing2011Dressing2011
Dressing2011
 
Dressing2011
Dressing2011Dressing2011
Dressing2011
 
Dressing2011
Dressing2011Dressing2011
Dressing2011
 
Density functional theory (DFT) and the concepts of the augmented-plane-wave ...
Density functional theory (DFT) and the concepts of the augmented-plane-wave ...Density functional theory (DFT) and the concepts of the augmented-plane-wave ...
Density functional theory (DFT) and the concepts of the augmented-plane-wave ...
 
Introduction to (weak) wave turbulence
Introduction to (weak) wave turbulenceIntroduction to (weak) wave turbulence
Introduction to (weak) wave turbulence
 
Serie de dyson
Serie de dysonSerie de dyson
Serie de dyson
 
Fluctuations and rare events in stochastic aggregation
Fluctuations and rare events in stochastic aggregationFluctuations and rare events in stochastic aggregation
Fluctuations and rare events in stochastic aggregation
 
"Warm tachyon matter" - N. Bilic
"Warm tachyon matter" - N. Bilic"Warm tachyon matter" - N. Bilic
"Warm tachyon matter" - N. Bilic
 
Nonequilibrium statistical mechanics of cluster-cluster aggregation, School o...
Nonequilibrium statistical mechanics of cluster-cluster aggregation, School o...Nonequilibrium statistical mechanics of cluster-cluster aggregation, School o...
Nonequilibrium statistical mechanics of cluster-cluster aggregation, School o...
 
An R-matrix approach for plasma modelling and the interpretation of astrophys...
An R-matrix approach for plasma modelling and the interpretation of astrophys...An R-matrix approach for plasma modelling and the interpretation of astrophys...
An R-matrix approach for plasma modelling and the interpretation of astrophys...
 
Localized Electrons with Wien2k
Localized Electrons with Wien2kLocalized Electrons with Wien2k
Localized Electrons with Wien2k
 
Hui - modified gravity
Hui -  modified gravityHui -  modified gravity
Hui - modified gravity
 
CP and Discrete Symmetries
CP and Discrete SymmetriesCP and Discrete Symmetries
CP and Discrete Symmetries
 
Cluster aggregation with complete collisional fragmentation
Cluster aggregation with complete collisional fragmentationCluster aggregation with complete collisional fragmentation
Cluster aggregation with complete collisional fragmentation
 
A. Morozov - Black Hole Motion in Entropic Reformulation of General Relativity
A. Morozov - Black Hole Motion in Entropic Reformulation of General RelativityA. Morozov - Black Hole Motion in Entropic Reformulation of General Relativity
A. Morozov - Black Hole Motion in Entropic Reformulation of General Relativity
 
10.1.1.2.9988
10.1.1.2.998810.1.1.2.9988
10.1.1.2.9988
 
The inverse droplet coagulation problem
The inverse droplet coagulation problemThe inverse droplet coagulation problem
The inverse droplet coagulation problem
 
Wien2k getting started
Wien2k getting startedWien2k getting started
Wien2k getting started
 

Viewers also liked

Project Proposal Edee
Project Proposal EdeeProject Proposal Edee
Project Proposal Edee
antimmermans
 
Columbus Metropolitan Library Survey
Columbus Metropolitan Library SurveyColumbus Metropolitan Library Survey
Columbus Metropolitan Library Survey
Julie Theado
 
An Introduction To Pbworks
An Introduction To PbworksAn Introduction To Pbworks
An Introduction To Pbworkschoikwokto
 
Introduction To Bussines 2
Introduction To Bussines 2Introduction To Bussines 2
Introduction To Bussines 2
guest0eb086
 
เรื่องการบวกเลข
เรื่องการบวกเลขเรื่องการบวกเลข
เรื่องการบวกเลขguest3d36fe9
 
Academic Advising 101
Academic Advising 101Academic Advising 101
Academic Advising 101
gainesla
 
Ppt pembinaan kes haji wus kel. 1
Ppt pembinaan kes haji wus kel. 1Ppt pembinaan kes haji wus kel. 1
Ppt pembinaan kes haji wus kel. 1
Mardiani Jaidi
 
Abuses Of Smoking
Abuses Of SmokingAbuses Of Smoking
Abuses Of Smoking
guest4f45e9
 
Gizi jamaah haji
Gizi jamaah hajiGizi jamaah haji
Gizi jamaah haji
Mardiani Jaidi
 
Kesehatan jamaah haji
Kesehatan jamaah hajiKesehatan jamaah haji
Kesehatan jamaah haji
Mardiani Jaidi
 
Effectief samenwerken in de bouwketen - deel 2
Effectief samenwerken in de bouwketen - deel 2Effectief samenwerken in de bouwketen - deel 2
Effectief samenwerken in de bouwketen - deel 2Atrivé
 
Vestia en Governance of Governance en Vestia 29-2-2012
Vestia en Governance of Governance en Vestia 29-2-2012Vestia en Governance of Governance en Vestia 29-2-2012
Vestia en Governance of Governance en Vestia 29-2-2012
Atrivé
 
Hanemaaijer governance nieuw
Hanemaaijer   governance nieuwHanemaaijer   governance nieuw
Hanemaaijer governance nieuwAtrivé
 
Presentatie22 juni 2011 thuistechnologie overijssel
Presentatie22 juni 2011 thuistechnologie overijsselPresentatie22 juni 2011 thuistechnologie overijssel
Presentatie22 juni 2011 thuistechnologie overijssel
Atrivé
 
Waardeverkenner
WaardeverkennerWaardeverkenner
WaardeverkennerAtrivé
 

Viewers also liked (17)

EMed Math Ii Day3
EMed Math Ii Day3EMed Math Ii Day3
EMed Math Ii Day3
 
Project Proposal Edee
Project Proposal EdeeProject Proposal Edee
Project Proposal Edee
 
Columbus Metropolitan Library Survey
Columbus Metropolitan Library SurveyColumbus Metropolitan Library Survey
Columbus Metropolitan Library Survey
 
An Introduction To Pbworks
An Introduction To PbworksAn Introduction To Pbworks
An Introduction To Pbworks
 
Med Math Ii Day3
Med Math Ii Day3Med Math Ii Day3
Med Math Ii Day3
 
Introduction To Bussines 2
Introduction To Bussines 2Introduction To Bussines 2
Introduction To Bussines 2
 
เรื่องการบวกเลข
เรื่องการบวกเลขเรื่องการบวกเลข
เรื่องการบวกเลข
 
Academic Advising 101
Academic Advising 101Academic Advising 101
Academic Advising 101
 
Ppt pembinaan kes haji wus kel. 1
Ppt pembinaan kes haji wus kel. 1Ppt pembinaan kes haji wus kel. 1
Ppt pembinaan kes haji wus kel. 1
 
Abuses Of Smoking
Abuses Of SmokingAbuses Of Smoking
Abuses Of Smoking
 
Gizi jamaah haji
Gizi jamaah hajiGizi jamaah haji
Gizi jamaah haji
 
Kesehatan jamaah haji
Kesehatan jamaah hajiKesehatan jamaah haji
Kesehatan jamaah haji
 
Effectief samenwerken in de bouwketen - deel 2
Effectief samenwerken in de bouwketen - deel 2Effectief samenwerken in de bouwketen - deel 2
Effectief samenwerken in de bouwketen - deel 2
 
Vestia en Governance of Governance en Vestia 29-2-2012
Vestia en Governance of Governance en Vestia 29-2-2012Vestia en Governance of Governance en Vestia 29-2-2012
Vestia en Governance of Governance en Vestia 29-2-2012
 
Hanemaaijer governance nieuw
Hanemaaijer   governance nieuwHanemaaijer   governance nieuw
Hanemaaijer governance nieuw
 
Presentatie22 juni 2011 thuistechnologie overijssel
Presentatie22 juni 2011 thuistechnologie overijsselPresentatie22 juni 2011 thuistechnologie overijssel
Presentatie22 juni 2011 thuistechnologie overijssel
 
Waardeverkenner
WaardeverkennerWaardeverkenner
Waardeverkenner
 

Similar to Aerospace Engineering Seminar Series

High-order Finite Elements for Computational Physics
High-order Finite Elements for Computational PhysicsHigh-order Finite Elements for Computational Physics
High-order Finite Elements for Computational PhysicsRobert Rieben
 
Gauge theory field
Gauge theory fieldGauge theory field
Gauge theory field
Nguyên Bình
 
E05731721
E05731721E05731721
E05731721
IOSR-JEN
 
Mom slideshow
Mom slideshowMom slideshow
Mom slideshow
ashusuzie
 
Fatigue damage in solder joint interconnects - presentation
Fatigue damage in solder joint interconnects - presentationFatigue damage in solder joint interconnects - presentation
Fatigue damage in solder joint interconnects - presentationDr. Adnan Judeh (Abdul-Baqi)
 
SCF methods, basis sets, and integrals part III
SCF methods, basis sets, and integrals part IIISCF methods, basis sets, and integrals part III
SCF methods, basis sets, and integrals part III
AkefAfaneh2
 
Yurri Sitenko "Boundary effects for magnetized quantum matter in particle and...
Yurri Sitenko "Boundary effects for magnetized quantum matter in particle and...Yurri Sitenko "Boundary effects for magnetized quantum matter in particle and...
Yurri Sitenko "Boundary effects for magnetized quantum matter in particle and...
SEENET-MTP
 
slides_cedric_weber_1.pdf
slides_cedric_weber_1.pdfslides_cedric_weber_1.pdf
slides_cedric_weber_1.pdf
sasdude1
 
Topological Inference via Meshing
Topological Inference via MeshingTopological Inference via Meshing
Topological Inference via Meshing
Don Sheehy
 
Bubbles of True Vacuum and Duality in M-theory
Bubbles of True Vacuum and Duality in M-theoryBubbles of True Vacuum and Duality in M-theory
Bubbles of True Vacuum and Duality in M-theory
Sebastian De Haro
 
Instantons and Chern-Simons Terms in AdS4/CFT3: Gravity on the Brane?
Instantons and Chern-Simons Terms in AdS4/CFT3: Gravity on the Brane?Instantons and Chern-Simons Terms in AdS4/CFT3: Gravity on the Brane?
Instantons and Chern-Simons Terms in AdS4/CFT3: Gravity on the Brane?
Sebastian De Haro
 
Fundamentals of Finite Difference Methods
Fundamentals of Finite Difference MethodsFundamentals of Finite Difference Methods
Fundamentals of Finite Difference Methods
1rj
 
Conformal Nonlinear Fluid Dynamics from Gravity in Arbitrary Dimensions
Conformal Nonlinear Fluid Dynamics from Gravity in Arbitrary DimensionsConformal Nonlinear Fluid Dynamics from Gravity in Arbitrary Dimensions
Conformal Nonlinear Fluid Dynamics from Gravity in Arbitrary DimensionsMichaelRabinovich
 
My Prize Winning Physics Poster from 2006
My Prize Winning Physics Poster from 2006My Prize Winning Physics Poster from 2006
My Prize Winning Physics Poster from 2006
Dr. Catherine Sinclair She/Her
 
Functional analysis in mechanics
Functional analysis in mechanicsFunctional analysis in mechanics
Functional analysis in mechanicsSpringer
 
Functional analysis in mechanics 2e
Functional analysis in mechanics  2eFunctional analysis in mechanics  2e
Functional analysis in mechanics 2eSpringer
 
Bird’s-eye view of Gaussian harmonic analysis
Bird’s-eye view of Gaussian harmonic analysisBird’s-eye view of Gaussian harmonic analysis
Bird’s-eye view of Gaussian harmonic analysis
Radboud University Medical Center
 
Nonlinear viscous hydrodynamics in various dimensions using AdS/CFT
Nonlinear viscous hydrodynamics in various dimensions using AdS/CFTNonlinear viscous hydrodynamics in various dimensions using AdS/CFT
Nonlinear viscous hydrodynamics in various dimensions using AdS/CFTMichaelRabinovich
 

Similar to Aerospace Engineering Seminar Series (20)

Presentation gauge field theory
Presentation gauge field theoryPresentation gauge field theory
Presentation gauge field theory
 
High-order Finite Elements for Computational Physics
High-order Finite Elements for Computational PhysicsHigh-order Finite Elements for Computational Physics
High-order Finite Elements for Computational Physics
 
Gauge theory field
Gauge theory fieldGauge theory field
Gauge theory field
 
E05731721
E05731721E05731721
E05731721
 
Mom slideshow
Mom slideshowMom slideshow
Mom slideshow
 
Fatigue damage in solder joint interconnects - presentation
Fatigue damage in solder joint interconnects - presentationFatigue damage in solder joint interconnects - presentation
Fatigue damage in solder joint interconnects - presentation
 
SCF methods, basis sets, and integrals part III
SCF methods, basis sets, and integrals part IIISCF methods, basis sets, and integrals part III
SCF methods, basis sets, and integrals part III
 
Yurri Sitenko "Boundary effects for magnetized quantum matter in particle and...
Yurri Sitenko "Boundary effects for magnetized quantum matter in particle and...Yurri Sitenko "Boundary effects for magnetized quantum matter in particle and...
Yurri Sitenko "Boundary effects for magnetized quantum matter in particle and...
 
slides_cedric_weber_1.pdf
slides_cedric_weber_1.pdfslides_cedric_weber_1.pdf
slides_cedric_weber_1.pdf
 
Topological Inference via Meshing
Topological Inference via MeshingTopological Inference via Meshing
Topological Inference via Meshing
 
Bubbles of True Vacuum and Duality in M-theory
Bubbles of True Vacuum and Duality in M-theoryBubbles of True Vacuum and Duality in M-theory
Bubbles of True Vacuum and Duality in M-theory
 
Reflection Data Analysis
Reflection Data AnalysisReflection Data Analysis
Reflection Data Analysis
 
Instantons and Chern-Simons Terms in AdS4/CFT3: Gravity on the Brane?
Instantons and Chern-Simons Terms in AdS4/CFT3: Gravity on the Brane?Instantons and Chern-Simons Terms in AdS4/CFT3: Gravity on the Brane?
Instantons and Chern-Simons Terms in AdS4/CFT3: Gravity on the Brane?
 
Fundamentals of Finite Difference Methods
Fundamentals of Finite Difference MethodsFundamentals of Finite Difference Methods
Fundamentals of Finite Difference Methods
 
Conformal Nonlinear Fluid Dynamics from Gravity in Arbitrary Dimensions
Conformal Nonlinear Fluid Dynamics from Gravity in Arbitrary DimensionsConformal Nonlinear Fluid Dynamics from Gravity in Arbitrary Dimensions
Conformal Nonlinear Fluid Dynamics from Gravity in Arbitrary Dimensions
 
My Prize Winning Physics Poster from 2006
My Prize Winning Physics Poster from 2006My Prize Winning Physics Poster from 2006
My Prize Winning Physics Poster from 2006
 
Functional analysis in mechanics
Functional analysis in mechanicsFunctional analysis in mechanics
Functional analysis in mechanics
 
Functional analysis in mechanics 2e
Functional analysis in mechanics  2eFunctional analysis in mechanics  2e
Functional analysis in mechanics 2e
 
Bird’s-eye view of Gaussian harmonic analysis
Bird’s-eye view of Gaussian harmonic analysisBird’s-eye view of Gaussian harmonic analysis
Bird’s-eye view of Gaussian harmonic analysis
 
Nonlinear viscous hydrodynamics in various dimensions using AdS/CFT
Nonlinear viscous hydrodynamics in various dimensions using AdS/CFTNonlinear viscous hydrodynamics in various dimensions using AdS/CFT
Nonlinear viscous hydrodynamics in various dimensions using AdS/CFT
 

Aerospace Engineering Seminar Series

  • 1. High Order Finite Elements for Lagrangian Computational Fluid Dynamics Truman E. Ellis Advisor: Dr. Faisal Kolkailah LLNL Mentors: Dr. Robert Rieben and Dr. Tzanio Kolev Department of Aerospace Engineering California Polytechnic State University San Luis Obispo, CA ellis.truman@gmail.com November 18, 2009 This work performed under the auspices of the U.S. Department of Energy by Lawrence Livermore National Laboratory under Contract DE-AC52-07NA27344 LLNL-PRES-416883, -416822 Powered by L EX AT
  • 2. Introduction We are developing advanced finite element discretization methods for Lagrangian hydrodynamics. Our goal is to improve the current staggered grid hydro (SGH) algorithms in multi-material ALE codes with respect to: symmetry preservation energy conservation artificial viscosity discretization hourglass-mode instabilities We consider a general framework for solving the Euler equations with the following features: allows for high order field representations allows for curved element geometry exact energy conservation by construction reduces to classical SGH under simplifying assumptions Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 2 / 27
  • 3. Glossary We consider several different hydro methods which make use of various finite element spaces. The specific finite element spaces considered in this talk are: Q0: constant function on quadrilaterals Q1: continuous bi linear functions on quadrilaterals Q2: continuous bi-quadratic functions on quadrilaterals Q1d: discontinuous bi-linear functions on quadrilaterals Q2d: discontinuous bi-quadratic function on quadrilaterals Each hydro method is designated by a pair of finite element spaces: A continuous kinematic space A discontinuous thermodynamic space For example: Q2-Q1d uses continuous quadratic velocities and positions with discontinuous bi- linear pressures and densities. Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 3 / 27
  • 4. Euler Equations in a Lagrangian Frame Typically, these equations are solved on a staggered spatial grid [1,2] where thermodynamic The Euler equations of gas dynamics in a Lagrangian variables are approximated as reference frame can be written in differential form as: piece-wise constants defined on zone centers and kinematic variables are defined on the ∂v Momentum Conservation: ρ = −∇p + ... nodes. ∂t Spatial gradients are computed 1 ∂ρ using finite volume and/or finite Mass Conservation: = −∇ · v ρ ∂t difference methods: ∂e Energy Conservation: ρ = −p∇ · v + ... ∂t Equation of State: p = EOS(e, ρ) [1] R. Tipton, CALE Lagrange Step, unpublished LLNL report, 1990 [2] M. Wilkins, Calculations of Elastic-Plastic Flow, In Methods of Computational Physics, 1964 Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 4 / 27
  • 5. Semi-Discrete Finite Element Approximation: Computational Mesh We propose a general semi-discrete FEM approach to solving the Euler equations in a Lagrangian frame. A semi-discrete method is only concerned with the spatial approximation of the continuum equations. To begin, we decompose the continuum domain at an initial time into a set of non-overlapping discrete volumes (zones). The union of these volumes forms the computational mesh: −→ Ω(t0 ) ˜ Ω(t0 ) = ∪Z ΩZ (t0 ) The motion of the continuous medium will therefore be described by the motion of only a finite number of particles (mesh vertices, edge midpoints, etc ) Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 5 / 27
  • 6. Semi-Discrete Finite Element Approximation: Lagrangian Mesh Motion After deformation in time, zones are reconstructed based on This reconstruction process particle locations, thus defining the moved mesh. has an inherent geometric error. Initial Cartesian mesh Q2 (Bi-Quadratic) deformed with the exact Q1 (Bi-Linear) Approximation solution of the Sedov blast Approximation wave problem. This built in geometric error motivates the use of (higher order) finite elements which can use the additional particle degrees of freedom to more accurately represent continuous deformations. Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 6 / 27
  • 7. Lagrangian Mesh Motion: Animation Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 7 / 27
  • 8. Semi-Discrete Finite Element Approximation: Curved Geometries Finite element basis functions are defined on a reference (unit) zone. To compute quantities on an arbitrary mesh zone, we use the Jacobian matrix which defines the geometric transformation (or mapping) from reference space: Reference Space: Physical Space: ˆ φ (x) φ (x) = φ (Φ−1 (x)) ˆ ˆ −1 ˆ ∇φ (x) ∇φ = JZ ∇φ A standard Q1 mapping gives zones with straight edges, while Q2 mappings produce curved zones. Note that we can have Q1 elements defined with a Q2 mapping and vice versa. The finite element reference degrees of freedom are in general different from the nodes of the mapping. Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 8 / 27
  • 9. Semi-Discrete Finite Element Approximation: Basis Functions We approximate each of the continuum fields with a basis function expansion, where the expansion coefficients are independent of space: Nv Np Velocity: v(x, t) ≈ ∑ vi (t)wi (x) Pressure: p(x, t) ≈ ∑ pi (t)φi (x) i i Ne Nρ Internal Energy: e(x, t) ≈ ∑ ei (t)θi (x) Density: ρ(x, t) ≈ ∑ ρi (t)ψi (x) i i Our formulation is general; we are free to choose various types of basis functions. However, stability requires that certain choices are not independent[1] (e.g. pressure and velocity.) Q2 basis function with degrees of Q1 (Bi-Linear) basis function Q2 (Bi-Quadratic) basis function freedom at the 9 4 DOF per Quad 9 DOF per Quad Gauss-Legendre quadrature points [1] See for example: D. Arnold et. al., Differential Complexes and stability of Finite Element Methods, 2005. Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 9 / 27
  • 10. Semi-Discrete Momentum Conservation To derive a semi-discrete momentum conservation law, we begin with a variational formulation: dv dv ρ = −∇p =⇒ ρ ·w = (∇p) · w = p(∇ · w ) − p(w · n) ˆ dt ˜ Ω(t) dt ˜ Ω(t) ˜ Ω(t) ˜ ∂ Ω(t) Multiply by vector valued test Perform integration function, integrate over by parts computational mesh Inserting our basis function expansions and applying Galerkins method by picking the velocity basis as the test function yields the following linear system of equations: −→ Write in matrix / vector form dvi dv ˜ ρ∑ dt wi · wj = ˜ ∑ pi φi (∇· wj ) M = DT p Ω(t) i Ω(t) i dt The Mass and Derivative matrices are computed zone by zone and assembled to form global systems: (Mz )ij = Ω(t) ρ(wi · wj ) ˜ (Dz )ij = Ω(t) φi (∇ · wj ) ˜ The symmetric positive definite mass matrix The rectangular derivative matrix maps describes how matter is distributed in space between pressure and velocity spaces. This matrix is a discrete version of the Div operator. Its adjoint (transpose) is the Grad operator Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 10 / 27
  • 11. Computing Mass and Derivative Matrices In practice, we compute the mass and derivative matrices by integrating over the reference volume using a change of variables: f= (f ◦ Φ)|Jz | Ω(t) ˜ Ω(t) The integrals are computed using Gaussian quadrature of a specified order. For certain integrands and quadrature rules, this can be computed exactly: Nq ˜ Ω(t) (f ◦ Φ)|Jz | ≈ ∑ αn {f ◦ Φ)|Jz |}x=qˆn ˆ n=1 2D Order 1 Gauss-Legendre 2D Order 2 Gauss-Legendre 2D Order 3 Gauss-Legendre 2D Order 4 Gauss-Legendre rule (exact for Q1) rule (exact for Q3) rule (exact for Q5) rule (exact for Q7) Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 11 / 27
  • 12. Semi-Discrete Mass Conservation We define the zonal mass moments in a natural manner: mz,i = ρψi Ωz (t) dmz,i The Lagrangian description requires that: =0 dt From the representation: ρ(x, t) ≈ ∑ρi (t)ψi (x) it follows that: mz,i = ∑ ρz,j ψi ψj i j Ωz (t) In matrix form we have: mz = Mρ ρz z where (Mρ )i,j = z ψi ψj Ωz (t) d If we impose the stronger condition: ρψ = 0 for any function ψ dt Ω(t) then we obtain the strong mass conservation principle: ρ(t)|J(t)| = ρ(t0 )|J(t0 )| Note that, in general, the density defined by the above equation is not polynomial. Note that both generalizations imply the standard zonal mass conservation Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 12 / 27
  • 13. Mixed Finite Elements Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 13 / 27
  • 14. High Order Methods Using the Q2 Basis Points in reference space Points in physical space For each Q2 zone, we track 9 independent vertices (coordinates, velocities, accelerations etc ) which define the quadratic mapping from reference space to physical space. This mapping is defined using the Q2 Jacobian matrix, which is a function: Jmat=[(-4*(y - 1)*(2*y - 1)*(2*x - 1)*X5 + Basis function in reference space Basis function in physical space (y - 1)*(2*y - 1)*(4*x - 3)*X1 + (y- 1)*(2*y - 1)*(4*x - 1)*X2 + 16*(y - 1)*(2*x - 1)*X9*y - 4*(y - 1)*(4*x- 3)*X8*y - 4*(y - 1)*(4*x - 1)*X6*y - 4*(2*y - 1)*(2*x - 1)*X7*y + (2*y- 1)*(4*x - 3)*X4*y + (2*y - 1)*(4*x - 1)*X3*y); (-4*(2*y - 1)*(x - 1)*(2*x - 1)*X8 + 16*(2*y - 1)*(x - 1)*X9*x - 4*(2*y -1)*(2*x - 1)*X6*x + (4*y - 3)*(x - 1)*(2*x - 1)*X1 - 4*(4*y - 3)*(x -1)*X5*x + (4*y - 3)*(2*x - 1)*X2*x + (4*y - 1)*(x - 1)*(2*x - 1)*X4 -4*(4*y - 1)*(x - 1)*X7*x + (4*y - 1)*(2*x - 1)*X3*x)]; Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 14 / 27
  • 15. High Order Methods Using the Q2 Basis For each zone in the computational mesh, we compute the following matrices using Gauss-Legendre quadrature of a specified order.: The symmetric positive definite 9 by 9 mass matrix describes how matter is distributed (Mz )i,j ≡ ρz (wi wj )|Jz | within the Q2 zone ˆ Ωz The rectangular derivative matrix maps between the pressure and velocity spaces. (Dx )i,j ≡ z φi (J−1 ∇wj ) · {1, 0}|Jz | z ˆ Ωz This matrix is a discrete version of the Div operator. Its adjoint (transpose) is the Grad operator (Dy )i,j ≡ z φi (J−1 ∇wj ) · {0, 1}|Jz | z ˆ Ωz The symmetric positive definite 9 by 9 stiffness matrix is a discrete version of the second order DivGrad operator. It is used to compute the (Sz )i,j ≡ µz (J−1 ∇wi )(Jz ∇wj )|Jz | z −1 ˆ Ωz artificial viscosity The bulk of the computational effort is in computing the high order Jacobian matrix. However, this can be computed once per DOF and shared between each matrix. For the remaining examples, we apply mass lumping to the mass matrix to eliminate the need for a global linear solve. In addition, we compute the mass matrix only once as an initial condition. Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 15 / 27
  • 16. Static Momentum Equation Solve Convergence Study In this simple test, we project an analytic pressure function Lumped mass matrix onto a randomly perturbed mesh and solve for the resulting accelerations: π π p(x, y) = cos( x) cos( y) 2 2 ma = −∇p Ma = −DT p Full linear solve Randomly perturbed base line mesh and a sequence of refinements Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 16 / 27
  • 17. 1D Sod Shock Tube: Velocity and Density We consider two meshes: A coarse 60 zone mesh and fine 120 zone mesh For each method, qlin = qquad = 1.0, no monotonic limiter is used We acknowledge this is sub-standard for Q1 (i.e. limiters make a difference); however, this a fair comparison between each method For each zone, 5 plot points are evaluated Each method captures contact discontinuity exactly due to discontinuous thermodynamic basis Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 17 / 27
  • 18. 1D Sod Shock Tube: Velocity and Density (Zoomed View) We consider two meshes: A coarse 60 zone mesh and fine 120 zone mesh For each method, qlin = qquad = 1.0, no monotonic limiter is used We acknowledge this is sub-standard for Q1 (i.e. limiters make a difference); however, this a fair comparison between each method For each zone, 5 plot points are evaluated Each method captures contact discontinuity exactly due to discontinuous thermodynamic basis Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 18 / 27
  • 19. Sedov Blast Problem, 20 by 20 Mesh: Q1-Q0 FEM Standard HG filter required Shock is not well resolved on this coarse mesh Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 19 / 27
  • 20. Sedov Blast Problem, 20 by 20 Mesh: Q2-Q1d FEM No HG filter used Curved elements 81 plot points used per cell Shock front is much sharper on the same mesh Zone at origin has incorrect deformation Velocity oscillations are observed in post shock region Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 20 / 27
  • 21. Sedov Blast Problem, 20 by 20 Mesh: Q2-Q1d FEM No HG filter used 81 plot points used per cell Allowing 25% of the linear-q term in expansion has a significant benefit Velocity oscillations in post shock region are eliminated Curved deformation of zones closely resembles exact deformation We have not taken full benefit of the high order information in each cell to compute the viscosity coefficient, this is an area we plan to investigate much further Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 21 / 27
  • 22. Sedov Blast Problem, 20 by 20 Mesh Comparison Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 22 / 27
  • 23. Noh Implosion Problem, 30 by 30 Mesh: Q1-Q0 FEM Standard HG filter required Shock is not well resolved on this coarse mesh No overshoots or undershoots are observed Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 23 / 27
  • 24. Noh Implosion Problem, 30 by 30 Mesh: Q2-Q1d FEM No HG filter used 36 plot points per zone Shock is more sharply resolved Wall heating is diminished Post shock density is closer to correct value Strong undershoots and overshoots in the density are observed in the single layer of zones at shock front Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 24 / 27
  • 25. Noh Implosion Problem, 30 by 30 Mesh: Q2-Q2d FEM No HG filter used 36 plot points per zone Shock is more sharply resolved Wall heating is diminished Post shock density is closer to correct value Under shoots in density diminished, but overshoots persist Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 25 / 27
  • 26. Conclusions We have developed a general FEM framework for Lagrangian CFD Kinematic and thermodynamic space can be chosen independently For triangles: Linear, quadratic, cubic, etc. kinematic space Constant, linear, quadratic, etc. thermodynamic space For quads: Bi-linear, bi-quadratic, bi-cubic, etc. kinematic space Constant, bi-linear, bi-quadratic, etc. thermodynamic space This allows us to experiment with many different finite element pairs We have also demonstrated that high order Lagrangian methods have significant promise Permits curved elements Increased accuracy Sharper shocks Density/pressure gradients in a single cell Second derivatives of velocity in a single cell Potential improvements for sub-zonal physics / multi-material ALE Post shock ringing is still an issue and we plan to address this by improving the artificial viscosity coefficient (e.g. the Hyper Viscosity technique of Cook and Cabot) Truman Ellis (Cal Poly) High Order Finite Elements for Lagrangian CFD November 2009 26 / 27