Coupled Fluid-Structural Solver CFD incompressible flow solver has been coupled with a FEA code to analyze dynamic fluid-structure coupling phenomena CFD.

Slides:



Advertisements
Similar presentations
THE FINITE ELEMENT METHOD
Advertisements

Steady-state heat conduction on triangulated planar domain May, 2002
Finite Volume II Philip Mocz. Goals Construct a robust, 2nd order FV method for the Euler equation (Navier-Stokes without the viscous term, compressible)
Chapter 8 Elliptic Equation.
By Paul Delgado. Motivation Flow-Deformation Equations Discretization Operator Splitting Multiphysics Coupling Fixed State Splitting Other Splitting Conclusions.
Point-wise Discretization Errors in Boundary Element Method for Elasticity Problem Bart F. Zalewski Case Western Reserve University Robert L. Mullen Case.
Beams and Frames.
Some Ideas Behind Finite Element Analysis
By S Ziaei-Rad Mechanical Engineering Department, IUT.
Section 4: Implementation of Finite Element Analysis – Other Elements
Introduction to numerical simulation of fluid flows
A Bezier Based Approach to Unstructured Moving Meshes ALADDIN and Sangria Gary Miller David Cardoze Todd Phillips Noel Walkington Mark Olah Miklos Bergou.
1 Internal Seminar, November 14 th Effects of non conformal mesh on LES S. Rolfo The University of Manchester, M60 1QD, UK School of Mechanical,
12/21/2001Numerical methods in continuum mechanics1 Continuum Mechanics On the scale of the object to be studied the density and other fluid properties.
Finite Element Method Introduction General Principle
Steady Aeroelastic Computations to Predict the Flying Shape of Sails Sriram Antony Jameson Dept. of Aeronautics and Astronautics Stanford University First.
Parallel Mesh Refinement with Optimal Load Balancing Jean-Francois Remacle, Joseph E. Flaherty and Mark. S. Shephard Scientific Computation Research Center.
MCE 561 Computational Methods in Solid Mechanics
Ordinary Differential Equations (ODEs)
© 2011 Autodesk Freely licensed for use by educational institutions. Reuse and changes require a note indicating that content has been modified from the.
1 CFD Analysis Process. 2 1.Formulate the Flow Problem 2.Model the Geometry 3.Model the Flow (Computational) Domain 4.Generate the Grid 5.Specify the.
The Finite Element Method
Introduction to virtual engineering László Horváth Budapest Tech John von Neumann Faculty of Informatics Institute of Intelligent Engineering.
Tutorial 5: Numerical methods - buildings Q1. Identify three principal differences between a response function method and a numerical method when both.
Lecture Objectives Review SIMPLE CFD Algorithm SIMPLE Semi-Implicit Method for Pressure-Linked Equations Define Residual and Relaxation.
Finite Differences Finite Difference Approximations  Simple geophysical partial differential equations  Finite differences - definitions  Finite-difference.
Multidisciplinary Computation:
C M C C Centro Euro-Mediterraneo per i Cambiamenti Climatici COSMO General Meeting - September 8th, 2009 COSMO WG 2 - CDC 1 An implicit solver based on.
Finite Element Method.
Discontinuous Galerkin Methods and Strand Mesh Generation
The Finite Element Method A Practical Course
A particle-gridless hybrid methods for incompressible flows
Integration of 3-body encounter. Figure taken from
Discontinuous Galerkin Methods Li, Yang FerienAkademie 2008.
Discontinuous Galerkin Methods for Solving Euler Equations Andrey Andreyev Advisor: James Baeder Mid.
Lecture Objectives: Explicit vs. Implicit Residual, Stability, Relaxation Simple algorithm.
Mass Transfer Coefficient
7. Introduction to the numerical integration of PDE. As an example, we consider the following PDE with one variable; Finite difference method is one of.
CFD Refinement By: Brian Cowley. Overview 1.Background on CFD 2.How it works 3.CFD research group on campus for which problem exists o Our current techniques.
11/11/20151 Trusses. 11/11/20152 Element Formulation by Virtual Work u Use virtual work to derive element stiffness matrix based on assumed displacements.
Illustration of FE algorithm on the example of 1D problem Problem: Stress and displacement analysis of a one-dimensional bar, loaded only by its own weight,
© Fluent Inc. 11/24/2015J1 Fluids Review TRN Overview of CFD Solution Methodologies.
1 Flux Numerical Methods. 2 Flux Basics The finite-volume formulation of the conservation equations resulted in the equation where was the flux of the.
Lecture Objectives Review Define Residual and Relaxation SIMPLE CFD Algorithm SIMPLE Semi-Implicit Method for Pressure-Linked Equations.
HEAT TRANSFER FINITE ELEMENT FORMULATION
COMPUTATIONAL FLUID DYNAMICS (AE 2402) Presented by IRISH ANGELIN S AP/AERO.
CHAP 3 WEIGHTED RESIDUAL AND ENERGY METHOD FOR 1D PROBLEMS
FALL 2015 Esra Sorgüven Öner
AMS 691 Special Topics in Applied Mathematics Lecture 8
Discretization Methods Chapter 2. Training Manual May 15, 2001 Inventory # Discretization Methods Topics Equations and The Goal Brief overview.
(*) CIMNE: International Center for Numerical Methods in Engineering, Barcelona, Spain Innovative Finite Element Methods For Aeroelastic Analysis Presented.
Multipole-Based Preconditioners for Sparse Linear Systems. Ananth Grama Purdue University. Supported by the National Science Foundation.
M. Khalili1, M. Larsson2, B. Müller1
Model Anything. Quantity Conserved c  advect  diffuse S ConservationConstitutiveGoverning Mass, M  q -- M Momentum fluid, Mv -- F Momentum fluid.
Computational Fluid Dynamics Lecture II Numerical Methods and Criteria for CFD Dr. Ugur GUVEN Professor of Aerospace Engineering.
1 CHAP 3 WEIGHTED RESIDUAL AND ENERGY METHOD FOR 1D PROBLEMS FINITE ELEMENT ANALYSIS AND DESIGN Nam-Ho Kim.
Convection-Dominated Problems
© Fluent Inc. 1/10/2018L1 Fluids Review TRN Solution Methods.
FEA Introduction.
Convergence in Computational Science
Objective Unsteady state Numerical methods Discretization
AIAA OBSERVATIONS ON CFD SIMULATION UNCERTAINITIES
AIAA OBSERVATIONS ON CFD SIMULATION UNCERTAINTIES
GENERAL VIEW OF KRATOS MULTIPHYSICS
Supported by the National Science Foundation.
Objective Numerical methods Finite volume.
AIAA OBSERVATIONS ON CFD SIMULATION UNCERTAINTIES
High Accuracy Schemes for Inviscid Traffic Models
topic11_shocktube_problem
Comparison of CFEM and DG methods
Presentation transcript:

Coupled Fluid-Structural Solver CFD incompressible flow solver has been coupled with a FEA code to analyze dynamic fluid-structure coupling phenomena CFD solver uses pressure splitting and orthogonal subgrid subscale stabilization to prevent non-physical behavior Structural solver suitable for large deformation analysis, including wrinkling of structural membranes All coding has been done in C++ inside the KRATOS object- oriented development framework for multiphysics analysis KRATOS allows for completely modular code design and ease of incorporation of new capabilities

KRATOS An environment for implementing innovative computational methods Under continual development at CIMNE specifically to address coupled problems Based on Object Oriented Approach using C++ Features a Python-Based programmable input Featured coupling strategies: STRONG COUPLING  “SAFE” but often computationally expensive, requires iterative solving strategy LOOSE COUPLING  is often considered “UNSAFE”, computational efficiency is potentially very HIGH

Incompressible CFD Solver ALE formulation Orthogonal subgrid subscale stabilization Choice of: Second-Order Accurate Fractional Step solver Monolithic solver

Structural Solver Non-linear large displacement/deformation capability Features advanced membrane elements including wrinkling Total Lagrangian model

Structural Deformation Change in fluid Boundary conditions Change in the pressure field Coupled Fluid-Structure Interaction Problem Boundary conditions for the fluid are not known until the structure displacement is calculated BUT Loads on the structure cannot be determined until the flow field has been solved for

Coupled “Fractional Step” Strategy It follows the same rationale as the fractional step (pressure segregation) procedures used for the solution of the Navier- Stokes equations Structural Prediction Mesh movement step Fluid Solution Structural Correction Prediction is done by SOLVING the structure subjected to a predicted pressure field (the simplest choice is the pressure at the end of the step before)

Error due to the coupling algorithm Assuming that the pressure can be described in the form and that the structural time integrator can be expressed in a form of the type it is possible to express the solution of the coupled problem “in the future” as where y n is an error term, for the coupling procedure to be stable this term must not grow without bounds

The amplification factor of the error term is convergence is achieved when the amplification factor is less than one Remark: The amplification factor does not depend on the particular time integration scheme selected The basic scheme: can be replaced with the procedure remains consistent, as there is no change when Δt→0

Inserting the assumed form of the pressure into the modified algorithm we have now the scheme is stable when By choosing an appropriate value for the procedure can be made stable irrespective of the mass ratio A suitable value can be estimated from the structure of the stiffness matrix of the fluid problem

Example: Flag Flutter F coupled simulation = 3.05HzF coupled experiment = 3.10Hz F von Karman = 3.7Hz

Example: 2D & 3D driven cavity with deformable base

PUMI 3D CFD Solver Finite element unstructured compressible flow solver Edge-based data structure for minimum memory footprint and optimum performance Second order space accuracy Explicit multistage Runge-Kutta time integration scheme Convective stabilization through limited upwinding Implicit residual smoothing for convergence acceleration Parallel execution on shared memory architectures via OPEN-MP directives Capabilities Overview:

Algorithm Overview NS equations in conservative form

Weak form of the NS equations Finite element discretization Weak semi-discrete form

The numerical fluxes are now approximated by by introducing the mass matrix, the last expression can be solved for the time derivatives of the nodal variables

To improve computational efficiency the residual is split two parts (from this point on, no sum is assumed on i, and all sums on j are carried out for j≠i) integrating by parts and rearranging the expression must now be symmetrized to realize the benefits of the edge data structure

using the shape function property and after some manipulation

Please remark that thus, only one coefficient need be stored for each internal edge (pair of connected nodes, i.e. nodes belonging to the same element) The scheme is conservative because for any given edge e connecting two internal nodes i-j, the total contribution the residual is zero When solving a viscous problem, nodal values the solution gradient are required to obtain the nodal diffusive fluxes. These can be recovered by means of a smoothing step. Using the regular FE interpolation for the gradients we set

It is well known that the basic Galerkin discretization is inherently unstable (it is equivalent to a centered difference scheme). To overcome this limitation the interface fluxes are modified according to Roe’s upwind scheme where the matrix represents the positive flux jacobian along the direction of the edge, evaluated at the Roe average state between states i and j This scheme, while stable, provides only first order space accuracy. The amount of artificial dissipation must be reduced. Two additional states i+ and j- are introduced

from the backward and forward extrapolated differences the new interface states are calculated as where the parameter k controls the degree of approximation. Near discontinuities the scheme must revert to first order. This is accomplished by limiting the degree of extrapolation

There are many possible choices for the limiting parameter. As an example, we show here the van Albada limiter Remark: It is in theory possible to achieve a higher accuracy by calculating the interface fluxes using the extrapolated values, i.e. however there is usually little difference in practice, so this enhancement can de omitted without noticeable loss of accuracy

Time integration is performed using a n-stage Runge-Kutta scheme this scheme is conditionally stable, the nodal allowable time step is calculated as h i being the nodal size, the maximum fluid diffusivity and CFL the allowable Courant number

By means of implicit residual smoothing the allowable time step can be increased which is solved using Jacobi iterations Time derivatives (and solution gradients) can be solved for very efficiently using the following iterative process

Example: Transonic flow over a commercial airliner test model