Cahn-Hilliard Phase Decomposition and

Size: px
Start display at page:

Download "Cahn-Hilliard Phase Decomposition and"

Transcription

1 Decomposition and Roy H. Stogner 1 Graham F. Carey 1 1 Computational Fluid Dynamics Lab Institute for Computational Engineering and Sciences University of Texas at Austin 9th US National Congress on Computational Mechanics

2 Outline

3 Separation Phenomena Example Applications Tin-Lead solder aging Void lattice formation in irradiated semiconductors Self-assembly of thin film patterns

4 Patterned Separation Electric Voltage (Suo, Hong) Filler Particles (Lee, Douglas, Glotzer) Surface Monolayers (Böltau, Walheim, Mlynek, Krausch, Steiner; Karim, Douglas, Lee, Glotzer, Rogers, Jackman, Amis, Whitesides) Reacting Chemicals (Glotzer, Coniglio; Di Marzio, Muthukumar) Surface Stress (Lu, Suo; Yu, Lu)

5 Free Energy Formulation systems model material separation and interface evolution based on a weakly non-local free energy density. f (c, c) f 0 (c) + f γ ( c) f γ ( c) ɛ2 c c c 2 f 0 (c) NkT (c ln (c)+ (1 c) ln (1 c)) + Nωc(1 c) Bulk Free Energy Density Flory Huggins Free Energy Density Concentration NkT = 0.4 NkT = 0.5 NkT = 0.6 NkT = 0.7 NkT = 0.8 NkT = 0.9

6 A mobility coefficient M c defines the concentration flux J. For positive definite M c, the resulting equation gives globally non-increasing free energy. J = M c df dc = M c ( f 0(c) + f γ(c) ) c t = M c ( f 0(c) ɛ 2 c c )

7 Weak Taking a weighted residual and integrating by parts twice, ( c t, φ) Ω = ( M c f 0(c), φ ) Ω ( ɛ2 c c, M T c φ ) Ω + (( M c ( f 0(c) ɛ 2 c c )) n, φ ) Ω +ɛ 2 c ( c, M T c φ n ) Ω

8 C 1 Finite In the Galerkin formulation of transport, we find integrated products of second derivatives of trial and test functions. We use C 1 continuous,w 2,p conforming finite elements: Element Types Clough-Tocher macroelement triangles Bogner-Fox- Schmidt squares, analogous Hermite cubes

9 h Adaptivity Function space continuity requires constraining hanging node Degrees of Freedom in terms of DoFs on coarse elements. f k ( i u F = u C ) u F i φ F i = f k j u C j φ C j Both Hermite and Clough-Tocher elements are subdivision compatible. u i = (A ki ) 1 B kj u j

10 libmesh Finite Element Library Initial developers: Benjamin Kirk, John Peterson Key Features Mixed element geometries in unstructured grids Adaptive mesh h-refinement with hanging nodes Parallel system assembly and solution Integration w/ PETSc, ParMETIS, more Export/import to common data formats New Development C 1 macroelement, Hermite classes Fourth order problem calculations Parallel adaptivity for general element types Additional error estimators, adaptivity strategies New nonlinear solver, timestepping frameworks

11 Separation - Spinodal Decomposition Initial Evolution Initial homogeneous blend quenched below critical T Random perturbations rapidly segregate into two distinct phases, divided by a labyrinth of sharp interfaces Rapid anti-diffusionary process

12 Separation - Interfacial Flow Long-term Evolution Single-phase regions gradually coalesce Motion into curvature vector resembles surface tension Patterning may occur when additional stress, surface tropisms are applied

13 Mesh Refinement Coarse mesh bicubic elements t = t = Mesh resolution must capture equilibrium interface width Timesteps are limited by nonlinear solver

14 Mesh Refinement One Refinement bicubic elements t = t = Free energy decay limits most error growth Primary exception: interface topology changes

15 Mesh Refinement Two Refinements bicubic elements t = t = Finite Element error becomes negligible Uncertainty issues remain

16 Mesh Refinement L 2 error coarse medium fine Time Transient Error With sufficient resolution, error remains bounded Errors decay on moderately refined meshes

17 with AMR/C Interface Tracking Problem Coarsening in single-phase regions is traded for refinement in sharp layers Equivalent accuracy achieved here with 75% fewer degrees of freedom

18 with AMR/C Decomposition Problem Laplacian Jump error indicator keeps up with moving interfaces Coarsening strategy for spinodal decomposition raises new questions

19 Thin Film Patterning Material Self- Electrostatic or chemical surface treatment attracts one material component preferentially A patterned spatially varying bias is added to the configurational free energy

20 Film Thickness Effects Thin films rapidly become uniform in z direction Thick films show more connectivity, fewer defects

21 Effects of Bias Strength Low surface potential energy biases are overwhelmed by random noise

22 Effects of Bias Strength Higher surface potential energy biases form patterns with decreasing defect density

23 Correlation Lengths Correlation Length x 1y 3x 3y 5x 5y 7x 7y Time Correlation between c( x), c( x + y) averaged over all x Anisotropic effects quickly visible Correlation lengths in pattern direction diverge

24 Effects of Quench Temperature Defects Time Defect Count Reduction Lower T freezes random defects in place Higher T gives more diffuse interfaces, smoother/faster defect reduction Near-critical T prevents full phase decomposition

25 QuasiNewton, GMRES + Block Jacobi + ILU give efficient implicit parallel solve performance on a adaptive spline and macroelement meshes Realistic spinodal decomposition, pattern formation results with degrees of freedom Qualitative identification of key parameters for pattern formation

26 Ongoing Work Lyapunov free energy functional analysis Adaptive time discretization Monte Carlo simulation Continuing parameter studies Additional patterning physics

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Roy Stogner Computational Fluid Dynamics Lab Institute for Computational Engineering and Sciences University of Texas at Austin March

More information

LibMesh Experience and Usage

LibMesh Experience and Usage LibMesh Experience and Usage John W. Peterson peterson@cfdlab.ae.utexas.edu and Roy H. Stogner roystgnr@cfdlab.ae.utexas.edu Univ. of Texas at Austin September 9, 2008 1 Introduction 2 Weighted Residuals

More information

Hp-Adaptivity on Anisotropic Meshes for Hybridized Discontinuous Galerkin Scheme

Hp-Adaptivity on Anisotropic Meshes for Hybridized Discontinuous Galerkin Scheme Hp-Adaptivity on Anisotropic Meshes for Hybridized Discontinuous Galerkin Scheme Aravind Balan, Michael Woopen and Georg May AICES Graduate School, RWTH Aachen University, Germany 22nd AIAA Computational

More information

Finite Difference Solution of the Heat Equation

Finite Difference Solution of the Heat Equation Finite Difference Solution of the Heat Equation Adam Powell 22.091 March 13 15, 2002 In example 4.3 (p. 10) of his lecture notes for March 11, Rodolfo Rosales gives the constant-density heat equation as:

More information

LibMesh Experience and Usage

LibMesh Experience and Usage LibMesh Experience and Usage John W. Peterson peterson@cfdlab.ae.utexas.edu Univ. of Texas at Austin January 12, 2007 1 Introduction 2 Weighted Residuals 3 Poisson Equation 4 Other Examples 5 Essential

More information

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Per-Olof Persson and Jaime Peraire Massachusetts Institute of Technology 7th World Congress on Computational Mechanics

More information

Is My CFD Mesh Adequate? A Quantitative Answer

Is My CFD Mesh Adequate? A Quantitative Answer Is My CFD Mesh Adequate? A Quantitative Answer Krzysztof J. Fidkowski Gas Dynamics Research Colloqium Aerospace Engineering Department University of Michigan January 26, 2011 K.J. Fidkowski (UM) GDRC 2011

More information

Phase-field modeling of step dynamics. University of California, Irvine, CA Caesar Research Center, Friedensplatz 16, 53111, Bonn, Germany.

Phase-field modeling of step dynamics. University of California, Irvine, CA Caesar Research Center, Friedensplatz 16, 53111, Bonn, Germany. Phase-field modeling of step dynamics ABSTRACT J.S. Lowengrub 1, Zhengzheng Hu 1, S.M. Wise 1, J.S. Kim 1, A. Voigt 2 1 Dept. Mathematics, University of California, Irvine, CA 92697 2 The Crystal Growth

More information

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems P.-O. Persson and J. Peraire Massachusetts Institute of Technology 2006 AIAA Aerospace Sciences Meeting, Reno, Nevada January 9,

More information

Phase-field modeling of nanoscale island dynamics

Phase-field modeling of nanoscale island dynamics Title of Publication Edited by TMS (The Minerals, Metals & Materials Society), Year Phase-field modeling of nanoscale island dynamics Zhengzheng Hu, Shuwang Li, John Lowengrub, Steven Wise 2, Axel Voigt

More information

Multiphysics Coupling: Hypersonic Flow with Radiation and Ablation

Multiphysics Coupling: Hypersonic Flow with Radiation and Ablation Multiphysics Coupling: Hypersonic Flow with Radiation and Ablation Current Results and Future Strategies Paul T. Bauman, Roy H. Stogner The University of Texas at Austin February 20, 2009 Paul T. Bauman,

More information

Direct numerical simulation of interfacial instability in gas-liquid flows

Direct numerical simulation of interfacial instability in gas-liquid flows Direct numerical simulation of interfacial instability in gas-liquid flows Iain Bethune 1, Lennon Ó Náraigh 2, David Scott 1, Peter Spelt 3,4, Prashant Valluri 5, Zlatko Solomenko 3 1 Edinburgh Parallel

More information

libmesh Finite Element Library

libmesh Finite Element Library libmesh Finite Element Library Roy Stogner roystgnr@cfdlab.ae.utexas.edu Derek Gaston drgasto@sandia.gov 1 Univ. of Texas at Austin 2 Sandia National Laboratories Albuquerque,NM August 22, 2007 Outline

More information

Technology Computer Aided Design (TCAD) Laboratory. Lecture 2, A simulation primer

Technology Computer Aided Design (TCAD) Laboratory. Lecture 2, A simulation primer Technology Computer Aided Design (TCAD) Laboratory Lecture 2, A simulation primer [Source: Synopsys] Giovanni Betti Beneventi E-mail: gbbeneventi@arces.unibo.it ; giobettibeneventi@gmail.com Office: Engineering

More information

Parallel Discontinuous Galerkin Method

Parallel Discontinuous Galerkin Method Parallel Discontinuous Galerkin Method Yin Ki, NG The Chinese University of Hong Kong Aug 5, 2015 Mentors: Dr. Ohannes Karakashian, Dr. Kwai Wong Overview Project Goal Implement parallelization on Discontinuous

More information

Olga Wodo Iowa State University. Baskar Ganapathysubramanian Iowa State University,

Olga Wodo Iowa State University. Baskar Ganapathysubramanian Iowa State University, Mechanical Engineering Publications Mechanical Engineering 7-2011 Computationally efficient solution to the Cahn Hilliard equation: Adaptive implicit time schemes, mesh sensitivity analysis and the 3D

More information

Nonlinear Iterative Solution of the Neutron Transport Equation

Nonlinear Iterative Solution of the Neutron Transport Equation Nonlinear Iterative Solution of the Neutron Transport Equation Emiliano Masiello Commissariat à l Energie Atomique de Saclay /DANS//SERMA/LTSD emiliano.masiello@cea.fr 1/37 Outline - motivations and framework

More information

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

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

More information

Solving PDEs with Multigrid Methods p.1

Solving PDEs with Multigrid Methods p.1 Solving PDEs with Multigrid Methods Scott MacLachlan maclachl@colorado.edu Department of Applied Mathematics, University of Colorado at Boulder Solving PDEs with Multigrid Methods p.1 Support and Collaboration

More information

Discontinuous Galerkin methods for nonlinear elasticity

Discontinuous Galerkin methods for nonlinear elasticity Discontinuous Galerkin methods for nonlinear elasticity Preprint submitted to lsevier Science 8 January 2008 The goal of this paper is to introduce Discontinuous Galerkin (DG) methods for nonlinear elasticity

More information

First-Passage Kinetic Monte Carlo Algorithm for Complex Reaction-Diffusion Systems

First-Passage Kinetic Monte Carlo Algorithm for Complex Reaction-Diffusion Systems First-Passage Kinetic Monte Carlo Algorithm for Complex Reaction-Diffusion Systems Aleksandar Donev 1 Lawrence Postdoctoral Fellow Lawrence Livermore National Laboratory In collaboration with: Vasily V.

More information

Multigrid Methods and their application in CFD

Multigrid Methods and their application in CFD Multigrid Methods and their application in CFD Michael Wurst TU München 16.06.2009 1 Multigrid Methods Definition Multigrid (MG) methods in numerical analysis are a group of algorithms for solving differential

More information

Physic-based Preconditioning and B-Splines finite elements method for Tokamak MHD

Physic-based Preconditioning and B-Splines finite elements method for Tokamak MHD Physic-based Preconditioning and B-Splines finite elements method for Tokamak MHD E. Franck 1, M. Gaja 2, M. Mazza 2, A. Ratnani 2, S. Serra Capizzano 3, E. Sonnendrücker 2 ECCOMAS Congress 2016, 5-10

More information

Compressible Navier-Stokes (Euler) Solver based on Deal.II Library

Compressible Navier-Stokes (Euler) Solver based on Deal.II Library Compressible Navier-Stokes (Euler) Solver based on Deal.II Library Lei Qiao Northwestern Polytechnical University Xi an, China Texas A&M University College Station, Texas Fifth deal.ii Users and Developers

More information

Advanced numerical methods for nonlinear advectiondiffusion-reaction. Peter Frolkovič, University of Heidelberg

Advanced numerical methods for nonlinear advectiondiffusion-reaction. Peter Frolkovič, University of Heidelberg Advanced numerical methods for nonlinear advectiondiffusion-reaction equations Peter Frolkovič, University of Heidelberg Content Motivation and background R 3 T Numerical modelling advection advection

More information

Local discontinuous Galerkin methods for elliptic problems

Local discontinuous Galerkin methods for elliptic problems COMMUNICATIONS IN NUMERICAL METHODS IN ENGINEERING Commun. Numer. Meth. Engng 2002; 18:69 75 [Version: 2000/03/22 v1.0] Local discontinuous Galerkin methods for elliptic problems P. Castillo 1 B. Cockburn

More information

Weak Galerkin Finite Element Methods and Applications

Weak Galerkin Finite Element Methods and Applications Weak Galerkin Finite Element Methods and Applications Lin Mu mul1@ornl.gov Computational and Applied Mathematics Computationa Science and Mathematics Division Oak Ridge National Laboratory Georgia Institute

More information

Monte Carlo. Lecture 15 4/9/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky

Monte Carlo. Lecture 15 4/9/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky Monte Carlo Lecture 15 4/9/18 1 Sampling with dynamics In Molecular Dynamics we simulate evolution of a system over time according to Newton s equations, conserving energy Averages (thermodynamic properties)

More information

Coarsening process in the 2d voter model

Coarsening process in the 2d voter model Alessandro Tartaglia (LPTHE) Coarsening in the 2d voter model May 8, 2015 1 / 34 Coarsening process in the 2d voter model Alessandro Tartaglia LPTHE, Université Pierre et Marie Curie alessandro.tartaglia91@gmail.com

More information

Steps in the Finite Element Method. Chung Hua University Department of Mechanical Engineering Dr. Ching I Chen

Steps in the Finite Element Method. Chung Hua University Department of Mechanical Engineering Dr. Ching I Chen Steps in the Finite Element Method Chung Hua University Department of Mechanical Engineering Dr. Ching I Chen General Idea Engineers are interested in evaluating effects such as deformations, stresses,

More information

Numerical Simulation of Gas-Liquid-Reactors with Bubbly Flows using a Hybrid Multiphase-CFD Approach

Numerical Simulation of Gas-Liquid-Reactors with Bubbly Flows using a Hybrid Multiphase-CFD Approach Numerical Simulation of Gas-Liquid-Reactors with Bubbly Flows using a Hybrid Multiphase-CFD Approach TFM Hybrid Interface Resolving Two-Fluid Model (HIRES-TFM) by Coupling of the Volume-of-Fluid (VOF)

More information

Finite Element Solver for Flux-Source Equations

Finite Element Solver for Flux-Source Equations Finite Element Solver for Flux-Source Equations Weston B. Lowrie A thesis submitted in partial fulfillment of the requirements for the degree of Master of Science in Aeronautics Astronautics University

More information

A MATLAB Program for Quantitative Simulation. Nano-scaled Features

A MATLAB Program for Quantitative Simulation. Nano-scaled Features A MATLAB Program for Quantitative Simulation arxiv:1007.1254v1 [cond-mat.mtrl-sci] 7 Jul 2010 of Self-assembly of Polymer Blend Films with Nano-scaled Features Yingrui Shang and David Kazmer Center of

More information

Homogenization Methods for Full Core Solution of the Pn Transport Equations with 3-D Cross Sections. Andrew Hall October 16, 2015

Homogenization Methods for Full Core Solution of the Pn Transport Equations with 3-D Cross Sections. Andrew Hall October 16, 2015 Homogenization Methods for Full Core Solution of the Pn Transport Equations with 3-D Cross Sections Andrew Hall October 16, 2015 Outline Resource-Renewable Boiling Water Reactor (RBWR) Current Neutron

More information

Phenomenological Theories of Nucleation

Phenomenological Theories of Nucleation Chapter 1 Phenomenological Theories of Nucleation c 2012 by William Klein, Harvey Gould, and Jan Tobochnik 16 September 2012 1.1 Introduction These chapters discuss the problems of nucleation, spinodal

More information

A sharp diffuse interface tracking method for approximating evolving interfaces

A sharp diffuse interface tracking method for approximating evolving interfaces A sharp diffuse interface tracking method for approximating evolving interfaces Vanessa Styles and Charlie Elliott University of Sussex Overview Introduction Phase field models Double well and double obstacle

More information

Algebraic Multigrid as Solvers and as Preconditioner

Algebraic Multigrid as Solvers and as Preconditioner Ò Algebraic Multigrid as Solvers and as Preconditioner Domenico Lahaye domenico.lahaye@cs.kuleuven.ac.be http://www.cs.kuleuven.ac.be/ domenico/ Department of Computer Science Katholieke Universiteit Leuven

More information

Breakdown of classical nucleation theory in nucleation kinetics

Breakdown of classical nucleation theory in nucleation kinetics Chapter 6 Breakdown of classical nucleation theory in nucleation kinetics In this chapter we present results of a study of nucleation of nematic droplets from the metastable isotropic phase. To the best

More information

Coarsening kinetics from a variable-mobility Cahn-Hilliard equation: Application of a semi-implicit Fourier spectral method

Coarsening kinetics from a variable-mobility Cahn-Hilliard equation: Application of a semi-implicit Fourier spectral method PHYSICAL REVIEW E VOLUME 60, NUMBER 4 OCTOBER 1999 Coarsening kinetics from a variable-mobility Cahn-Hilliard equation: Application of a semi-implicit Fourier spectral method Jingzhi Zhu and Long-Qing

More information

Dynamics of wrinkle growth and coarsening in stressed thin films

Dynamics of wrinkle growth and coarsening in stressed thin films Dynamics of wrinkle growth and coarsening in stressed thin films Rui Huang and Se Hyuk Im Department of Aerospace Engineering & Engineering Mechanics, University of Texas, Austin, Texas 78712, USA Received

More information

Coupling atomistic and continuum modelling of magnetism

Coupling atomistic and continuum modelling of magnetism Coupling atomistic and continuum modelling of magnetism M. Poluektov 1,2 G. Kreiss 2 O. Eriksson 3 1 University of Warwick WMG International Institute for Nanocomposites Manufacturing 2 Uppsala University

More information

On Multigrid for Phase Field

On Multigrid for Phase Field On Multigrid for Phase Field Carsten Gräser (FU Berlin), Ralf Kornhuber (FU Berlin), Rolf Krause (Uni Bonn), and Vanessa Styles (University of Sussex) Interphase 04 Rome, September, 13-16, 2004 Synopsis

More information

Solution Methods. Steady State Diffusion Equation. Lecture 04

Solution Methods. Steady State Diffusion Equation. Lecture 04 Solution Methods Steady State Diffusion Equation Lecture 04 1 Solution methods Focus on finite volume method. Background of finite volume method. Discretization example. General solution method. Convergence.

More information

DG Methods for Aerodynamic Flows: Higher Order, Error Estimation and Adaptive Mesh Refinement

DG Methods for Aerodynamic Flows: Higher Order, Error Estimation and Adaptive Mesh Refinement HONOM 2011 in Trento DG Methods for Aerodynamic Flows: Higher Order, Error Estimation and Adaptive Mesh Refinement Institute of Aerodynamics and Flow Technology DLR Braunschweig 11. April 2011 1 / 35 Research

More information

Adaptive Time Space Discretization for Combustion Problems

Adaptive Time Space Discretization for Combustion Problems Konrad-Zuse-Zentrum fu r Informationstechnik Berlin Takustraße 7 D-14195 Berlin-Dahlem Germany JENS LANG 1,BODO ERDMANN,RAINER ROITZSCH Adaptive Time Space Discretization for Combustion Problems 1 Talk

More information

Positioning, Structuring and Controlling with Nanoprecision

Positioning, Structuring and Controlling with Nanoprecision Positioning, Structuring and Controlling with Nanoprecision Regine Hedderich 1,2, Tobias Heiler 2,3, Roland Gröger 2,3, Thomas Schimmel 2,3 and Stefan Walheim 2,3 1 Network NanoMat 2 Institute of Nanotechnology,

More information

Stabilization and Acceleration of Algebraic Multigrid Method

Stabilization and Acceleration of Algebraic Multigrid Method Stabilization and Acceleration of Algebraic Multigrid Method Recursive Projection Algorithm A. Jemcov J.P. Maruszewski Fluent Inc. October 24, 2006 Outline 1 Need for Algorithm Stabilization and Acceleration

More information

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

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

More information

Fluctuating Hydrodynamics for Transport in Neutral and Charged Fluid Mixtures

Fluctuating Hydrodynamics for Transport in Neutral and Charged Fluid Mixtures Fluctuating Hydrodynamics for Transport in Neutral and Charged Fluid Mixtures Alejandro L. Garcia San Jose State University Lawrence Berkeley Nat. Lab. Hydrodynamic Fluctuations in Soft Matter Simulations

More information

Motivation. Coupling of overset grids. Incompressible finite-volume methods. Non-conservative interpolation of field values Mass defect

Motivation. Coupling of overset grids. Incompressible finite-volume methods. Non-conservative interpolation of field values Mass defect Motivation Coupling of overset grids Non-conservative interpolation of field values Mass defect Incompressible finite-volume methods Violation of inherent mass conservation Pressure fluctuations Content

More information

Fine-grained Parallel Incomplete LU Factorization

Fine-grained Parallel Incomplete LU Factorization Fine-grained Parallel Incomplete LU Factorization Edmond Chow School of Computational Science and Engineering Georgia Institute of Technology Sparse Days Meeting at CERFACS June 5-6, 2014 Contribution

More information

Atomistic effect of delta doping layer in a 50 nm InP HEMT

Atomistic effect of delta doping layer in a 50 nm InP HEMT J Comput Electron (26) 5:131 135 DOI 1.7/s1825-6-8832-3 Atomistic effect of delta doping layer in a 5 nm InP HEMT N. Seoane A. J. García-Loureiro K. Kalna A. Asenov C Science + Business Media, LLC 26 Abstract

More information

Kinetics. Rate of change in response to thermodynamic forces

Kinetics. Rate of change in response to thermodynamic forces Kinetics Rate of change in response to thermodynamic forces Deviation from local equilibrium continuous change T heat flow temperature changes µ atom flow composition changes Deviation from global equilibrium

More information

Macroscopic Failure Analysis Based on a Random Field Representations Generated from Material Microstructures

Macroscopic Failure Analysis Based on a Random Field Representations Generated from Material Microstructures Macroscopic Failure Analysis Based on a Random Field Representations Generated from Material Microstructures Reza Abedi Mechanical, Aerospace & Biomedical Engineering University of Tennessee Knoxville

More information

J. Price, 1,2 Y. Q. An, 1 M. C. Downer 1 1 The university of Texas at Austin, Department of Physics, Austin, TX

J. Price, 1,2 Y. Q. An, 1 M. C. Downer 1 1 The university of Texas at Austin, Department of Physics, Austin, TX Understanding process-dependent oxygen vacancies in thin HfO 2 /SiO 2 stacked-films on Si (100) via competing electron-hole injection dynamic contributions to second harmonic generation. J. Price, 1,2

More information

BEST-ESTIMATE METHODOLOGY

BEST-ESTIMATE METHODOLOGY BEST-ESTIMATE METHODOLOGY CONTENT Recall of LB LOCA evaluation method EDF methodology presentation Principles DRM applied to LB LOCA CATHARE GB Key parameters PCT95 PCT DRM BE methodology feedback LB LOCA

More information

Modeling morphology evolution during solventbased fabrication of organic solar cells

Modeling morphology evolution during solventbased fabrication of organic solar cells Mechanical Engineering Publications Mechanical Engineering 4-2012 Modeling morphology evolution during solventbased fabrication of organic solar cells Olga Wodo Iowa State University Baskar Ganapathysubramanian

More information

Predictive Engineering and Computational Sciences. Full System Simulations. Algorithms and Uncertainty Quantification. Roy H.

Predictive Engineering and Computational Sciences. Full System Simulations. Algorithms and Uncertainty Quantification. Roy H. PECOS Predictive Engineering and Computational Sciences Full System Simulations Algorithms and Uncertainty Quantification Roy H. Stogner The University of Texas at Austin October 12, 2011 Roy H. Stogner

More information

Algebraic flux correction and its application to convection-dominated flow. Matthias Möller

Algebraic flux correction and its application to convection-dominated flow. Matthias Möller Algebraic flux correction and its application to convection-dominated flow Matthias Möller matthias.moeller@math.uni-dortmund.de Institute of Applied Mathematics (LS III) University of Dortmund, Germany

More information

Positioning, Structuring and Controlling with Nanoprecision

Positioning, Structuring and Controlling with Nanoprecision Positioning, Structuring and Controlling with Nanoprecision Regine Hedderich 1,2, Tobias Heiler 2,3, Roland Gröger 2,3, Thomas Schimmel 2,3, and Stefan Walheim 2,3 1 Network NanoMat 2 Institute of Nanotechnology,

More information

Tutorial for the heated pipe with constant fluid properties in STAR-CCM+

Tutorial for the heated pipe with constant fluid properties in STAR-CCM+ Tutorial for the heated pipe with constant fluid properties in STAR-CCM+ For performing this tutorial, it is necessary to have already studied the tutorial on the upward bend. In fact, after getting abilities

More information

arxiv: v1 [math.na] 11 Jul 2011

arxiv: v1 [math.na] 11 Jul 2011 Multigrid Preconditioner for Nonconforming Discretization of Elliptic Problems with Jump Coefficients arxiv:07.260v [math.na] Jul 20 Blanca Ayuso De Dios, Michael Holst 2, Yunrong Zhu 2, and Ludmil Zikatanov

More information

Modeling Interfaces in Structural Dynamics Analysis

Modeling Interfaces in Structural Dynamics Analysis Modeling Interfaces in Structural Dynamics Analysis Enriching our joints models and capabilities 2nd Workshop on Joints Modelling Dartington Hall Totnes, Devon, UK 26-29 April 2009 Michael Starr, Org.

More information

Adaptive algorithm for saddle point problem for Phase Field model

Adaptive algorithm for saddle point problem for Phase Field model Adaptive algorithm for saddle point problem for Phase Field model Jian Zhang Supercomputing Center, CNIC,CAS Collaborators: Qiang Du(PSU), Jingyan Zhang(PSU), Xiaoqiang Wang(FSU), Jiangwei Zhao(SCCAS),

More information

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN INTROUCTION TO FINITE ELEMENT METHOS ON ELLIPTIC EQUATIONS LONG CHEN CONTENTS 1. Poisson Equation 1 2. Outline of Topics 3 2.1. Finite ifference Method 3 2.2. Finite Element Method 3 2.3. Finite Volume

More information

Semiconductor Physics and Devices

Semiconductor Physics and Devices The pn Junction 1) Charge carriers crossing the junction. 3) Barrier potential Semiconductor Physics and Devices Chapter 8. The pn Junction Diode 2) Formation of positive and negative ions. 4) Formation

More information

Target Simulations. Roman Samulyak in collaboration with Y. Prykarpatskyy, T. Lu

Target Simulations. Roman Samulyak in collaboration with Y. Prykarpatskyy, T. Lu Muon Collider/Neutrino Factory Collaboration Meeting May 26 28, CERN, Geneva U.S. Department of Energy Target Simulations Roman Samulyak in collaboration with Y. Prykarpatskyy, T. Lu Center for Data Intensive

More information

An Introduction to the Discontinuous Galerkin Method

An Introduction to the Discontinuous Galerkin Method An Introduction to the Discontinuous Galerkin Method Krzysztof J. Fidkowski Aerospace Computational Design Lab Massachusetts Institute of Technology March 16, 2005 Computational Prototyping Group Seminar

More information

Lecture 8: Fast Linear Solvers (Part 7)

Lecture 8: Fast Linear Solvers (Part 7) Lecture 8: Fast Linear Solvers (Part 7) 1 Modified Gram-Schmidt Process with Reorthogonalization Test Reorthogonalization If Av k 2 + δ v k+1 2 = Av k 2 to working precision. δ = 10 3 2 Householder Arnoldi

More information

REORDERING EFFECTS ON PRECONDITIONED KRYLOV METHODS IN AMR SOLUTIONS OF FLOW AND TRANSPORT

REORDERING EFFECTS ON PRECONDITIONED KRYLOV METHODS IN AMR SOLUTIONS OF FLOW AND TRANSPORT Proc. of the XXVII Iberian Latin-American Congress on Computational Methods in Engineering CILAMCE 2006 Brazilian Assoc. for Comp. Mechanics & Latin American Assoc. of Comp. Methods in Engineering Belém,

More information

Simulating the Spontaneous Formation of Self-Organized Anode Spot Patterns in Arc Discharges

Simulating the Spontaneous Formation of Self-Organized Anode Spot Patterns in Arc Discharges Simulating the Spontaneous Formation of Self-Organized Anode Spot Patterns in Arc Discharges Juan Pablo Trelles Department of Mechanical Engineering and Energy Engineering Graduate Program University of

More information

Aspects of Multigrid

Aspects of Multigrid Aspects of Multigrid Kees Oosterlee 1,2 1 Delft University of Technology, Delft. 2 CWI, Center for Mathematics and Computer Science, Amsterdam, SIAM Chapter Workshop Day, May 30th 2018 C.W.Oosterlee (CWI)

More information

Surface stress-induced self-assembly

Surface stress-induced self-assembly Surface stress-induced self-assembly Zhigang Suo Work with Wei Lu Solid surface Liquid surface Stretched solid surface Energy per surface atom depends on stretch Stretched liquid surface Energy per surface

More information

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Problem Jörg-M. Sautter Mathematisches Institut, Universität Düsseldorf, Germany, sautter@am.uni-duesseldorf.de

More information

Spri ringer. INTERFACIAL TRANSPORT PHENOMENA 2 nd Edition. John C. Slattery Department ofaerospace Engineering Texas A&M University

Spri ringer. INTERFACIAL TRANSPORT PHENOMENA 2 nd Edition. John C. Slattery Department ofaerospace Engineering Texas A&M University INTERFACIAL TRANSPORT PHENOMENA 2 nd Edition John C. Slattery Department ofaerospace Engineering Texas A&M University Leonard Sagis Department of Agrotechnology & Food Science Wageningen University Eun-Suok

More information

Modeling of Multicomponent Reactive Systems

Modeling of Multicomponent Reactive Systems TECHNISCHE MECHANIK, 32, 2-5, (2012), 105 112 submitted: October 11, 2011 Modeling of Multicomponent Reactive Systems D. Anders, K. Weinberg In recent engineering applications reaction-diffusion systems

More information

A surfactant-conserving volume-of-fluid method for interfacial flows with insoluble surfactant

A surfactant-conserving volume-of-fluid method for interfacial flows with insoluble surfactant A surfactant-conserving volume-of-fluid method for interfacial flows with insoluble surfactant Ashley J. James Department of Aerospace Engineering and Mechanics, University of Minnesota John Lowengrub

More information

Robust solution of Poisson-like problems with aggregation-based AMG

Robust solution of Poisson-like problems with aggregation-based AMG Robust solution of Poisson-like problems with aggregation-based AMG Yvan Notay Université Libre de Bruxelles Service de Métrologie Nucléaire Paris, January 26, 215 Supported by the Belgian FNRS http://homepages.ulb.ac.be/

More information

Quiz Polymer Properties

Quiz Polymer Properties Quiz 7 070521 Polymer Properties A mean field theory deals with interactions and takes a multi-bodied problem (that is interactions between many sites) and converts it to a single-bodied problem (interactions

More information

Development of discontinuous Galerkin method for linear strain gradient elasticity

Development of discontinuous Galerkin method for linear strain gradient elasticity Development of discontinuous Galerkin method for linear strain gradient elasticity R Bala Chandran Computation for Design and Optimizaton Massachusetts Institute of Technology Cambridge, MA L. Noels* Aerospace

More information

A. Kovacevic N. Stosic I. Smith. Screw Compressors. Three Dimensional Computational Fluid Dynamics and Solid Fluid Interaction.

A. Kovacevic N. Stosic I. Smith. Screw Compressors. Three Dimensional Computational Fluid Dynamics and Solid Fluid Interaction. Screw Compressors A. Kovacevic N. Stosic I. Smith Screw Compressors Three Dimensional Computational Fluid Dynamics and Solid Fluid Interaction With 83 Figures Ahmed Kovacevic Nikola Stosic Ian Smith School

More information

Large Deformation of Hydrogels Coupled with Solvent Diffusion Rui Huang

Large Deformation of Hydrogels Coupled with Solvent Diffusion Rui Huang Large Deformation of Hydrogels Coupled with Solvent Diffusion Rui Huang Center for Mechanics of Solids, Structures and Materials Department of Aerospace Engineering and Engineering Mechanics The University

More information

Adjoint-Fueled Advances in Error Estimation for Multiscale, Multiphysics Systems

Adjoint-Fueled Advances in Error Estimation for Multiscale, Multiphysics Systems Adjoint-Fueled Advances in Error Estimation for Multiscale, Multiphysics Systems Donald Estep University Interdisciplinary Research Scholar Department of Statistics Department of Mathematics Center for

More information

Sensitivity and Reliability Analysis of Nonlinear Frame Structures

Sensitivity and Reliability Analysis of Nonlinear Frame Structures Sensitivity and Reliability Analysis of Nonlinear Frame Structures Michael H. Scott Associate Professor School of Civil and Construction Engineering Applied Mathematics and Computation Seminar April 8,

More information

Metal Semiconductor Contacts

Metal Semiconductor Contacts Metal Semiconductor Contacts The investigation of rectification in metal-semiconductor contacts was first described by Braun [33-35], who discovered in 1874 the asymmetric nature of electrical conduction

More information

Kasetsart University Workshop. Multigrid methods: An introduction

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

More information

ICES REPORT Isogeometric Analysis of the Advective Cahn-Hilliard Equation: Spinodal Decomposition Under Shear Flow

ICES REPORT Isogeometric Analysis of the Advective Cahn-Hilliard Equation: Spinodal Decomposition Under Shear Flow ICES REPORT 12-12 March 2012 Isogeometric Analysis of the Advective Cahn-Hilliard Equation: Spinodal Decomposition Under Shear Flow by J. Liu, L. Dede, J.A. Evans, M.J. Borden, T.J.R. Hughes The Institute

More information

Progress in Mesh-Adaptive Discontinuous Galerkin Methods for CFD

Progress in Mesh-Adaptive Discontinuous Galerkin Methods for CFD Progress in Mesh-Adaptive Discontinuous Galerkin Methods for CFD German Aerospace Center Seminar Krzysztof Fidkowski Department of Aerospace Engineering The University of Michigan May 4, 2009 K. Fidkowski

More information

Role of Computer Experiment

Role of Computer Experiment Role of Computer Experiment Experimental World Computer Experiment Theoretical World Accumulation of factual information Checks and stimuli Ordering of factual information into logically coherent patterns

More information

Predictive Engineering and Computational Sciences. Local Sensitivity Derivative Enhanced Monte Carlo Methods. Roy H. Stogner, Vikram Garg

Predictive Engineering and Computational Sciences. Local Sensitivity Derivative Enhanced Monte Carlo Methods. Roy H. Stogner, Vikram Garg PECOS Predictive Engineering and Computational Sciences Local Sensitivity Derivative Enhanced Monte Carlo Methods Roy H. Stogner, Vikram Garg Institute for Computational Engineering and Sciences The University

More information

Yuri Feldman, MUMPS User Days, Grenoble, France, June 2017

Yuri Feldman, MUMPS User Days, Grenoble, France, June 2017 Yuri Feldman, MUMPS User Days, Grenoble, France, June 2017 1 Outline 1. History of using MUMPS 2. Motivation of the Research 3. Governing Equations 4. Numerical Method 5. Direct Numerical Simulations o

More information

Tdyn-CFD+HT - Validation Case 9

Tdyn-CFD+HT - Validation Case 9 Two-dimensional heat conduction with heat generation Version 14.0.0 Compass Ingeniería y Sistemas http://www.compassis.com Tel.: +34 932 181 989 - Fax.: +34 933 969 746 - E: info@compassis.com - C/ Tuset

More information

arxiv: v1 [physics.comp-ph] 29 Jun 2014

arxiv: v1 [physics.comp-ph] 29 Jun 2014 ENERGY MINIMIZATION FOR LIQUID CRYSTAL EQUILIBRIUM WITH ELECTRIC AND FLEXOELECTRIC EFFECTS J. H. ADLER, T. J. ATHERTON, T. R. BENSON, D. B. EMERSON, S. P. MACLACHLAN arxiv:1407.3197v1 [physics.comp-ph]

More information

Tutorial for the supercritical pressure pipe with STAR-CCM+

Tutorial for the supercritical pressure pipe with STAR-CCM+ Tutorial for the supercritical pressure pipe with STAR-CCM+ For performing this tutorial, it is necessary to have already studied the tutorial on the upward bend. In fact, after getting abilities with

More information

Numerical Methods of Applied Mathematics -- II Spring 2009

Numerical Methods of Applied Mathematics -- II Spring 2009 MIT OpenCourseWare http://ocw.mit.edu 18.336 Numerical Methods of Applied Mathematics -- II Spring 2009 For information about citing these materials or our Terms of Use, visit: http://ocw.mit.edu/terms.

More information

Compact High Order Finite Difference Stencils for Elliptic Variable Coefficient and Interface Problems

Compact High Order Finite Difference Stencils for Elliptic Variable Coefficient and Interface Problems Compact High Order Finite Difference Stencils for Elliptic Variable Coefficient and Interface Problems Daniel Ritter 1, Ulrich Rüde 1, Björn Gmeiner 1, Rochus Schmid 2 Copper Mountain, March 18th, 2013

More information

A primal-dual mixed finite element method. for accurate and efficient atmospheric. modelling on massively parallel computers

A primal-dual mixed finite element method. for accurate and efficient atmospheric. modelling on massively parallel computers A primal-dual mixed finite element method for accurate and efficient atmospheric modelling on massively parallel computers John Thuburn (University of Exeter, UK) Colin Cotter (Imperial College, UK) AMMW03,

More information

Fuel BurnupCalculations and Uncertainties

Fuel BurnupCalculations and Uncertainties Fuel BurnupCalculations and Uncertainties Outline Review lattice physics methods Different approaches to burnup predictions Linkage to fuel safety criteria Sources of uncertainty Survey of available codes

More information

Simulation of Aeroelastic System with Aerodynamic Nonlinearity

Simulation of Aeroelastic System with Aerodynamic Nonlinearity Simulation of Aeroelastic System with Aerodynamic Nonlinearity Muhamad Khairil Hafizi Mohd Zorkipli School of Aerospace Engineering, Universiti Sains Malaysia, Penang, MALAYSIA Norizham Abdul Razak School

More information

Preconditioned Locally Minimal Residual Method for Computing Interior Eigenpairs of Symmetric Operators

Preconditioned Locally Minimal Residual Method for Computing Interior Eigenpairs of Symmetric Operators Preconditioned Locally Minimal Residual Method for Computing Interior Eigenpairs of Symmetric Operators Eugene Vecharynski 1 Andrew Knyazev 2 1 Department of Computer Science and Engineering University

More information