1 / 57

Rudolf Žitný, Ústav procesní a zpracovatelské techniky ČVUT FS 2010

Computer Fluid Dynamics E181107. 2181106. CFD7. Solvers, schemes SIMPLEx, upwind,…. Remark : fo i l s with „ black background “ could be skipped, they are aimed to the more advanced courses. Rudolf Žitný, Ústav procesní a zpracovatelské techniky ČVUT FS 2010. FINITE VO LUME METHOD. CFD7.

nevan
Download Presentation

Rudolf Žitný, Ústav procesní a zpracovatelské techniky ČVUT FS 2010

An Image/Link below is provided (as is) to download presentation Download Policy: Content on the Website is provided to you AS IS for your information and personal use and may not be sold / licensed / shared on other websites without getting consent from its author. Content is provided to you AS IS for your information and personal use only. Download presentation by click this link. While downloading, if for some reason you are not able to download a presentation, the publisher may have deleted the file from their server. During download, if you can't get a presentation, the file might be deleted by the publisher.

E N D

Presentation Transcript


  1. ComputerFluid DynamicsE181107 2181106 CFD7 Solvers, schemes SIMPLEx, upwind,… Remark: foils with „black background“ could be skipped, they are aimed to the more advanced courses Rudolf Žitný, Ústav procesní a zpracovatelské techniky ČVUT FS 2010

  2. FINITE VOLUME METHOD CFD7 Principle of the Finite Volume Method is in application of Gauss theorem upon integral of the solved transport equation. Thus the volumetric integral inside the fluid element is replaced by surface integral, evaluated as the sum of integrals at faces of the fluid element.

  3. z y Top North E West South x z y x Bottom x FINITE VOLUME METHOD CFD7 FINITE CONTROL VOLUMEx = Fluid element dx Finite size Infinitely small size

  4. w e A W P E B FVM diffusion problem 1D CFD7 CV - control volume A – surface of CV Gauss theorem Diffusive flux 1D case

  5. FVM diffusion problem 1D CFD7 Overall flux from the west side Linearization of source term aE aW aP • Check properties • aP = aW+aE for S=0 (without sources) • All coefficients are positive

  6. Tutorial – sphere drying CFD7 Enthalpy of evaporation Heat transfer from air at temperature To W P E Mass transfer coefficient Diffusion coefficient Internal control volumes TR temperature at surface of sphere must be extrapolated (using TW and TP) x x/2 W P R

  7. FVM diffusion problem 2D CFD7 N W P E A S Boundary conditions Example: insulation q=0 • First kind (Dirichlet BC) • Second kind (Neumann BC) • Third kind (Newton’s BC) Example: Finite thermal resistance (heat transfer coefficient )

  8. w e A W P E B FVM convection diffusion 1D CFD7 CV - control volume A – surface of CV Gauss theorem 1D case

  9. FVM convection diffusion 1D CFD7 F-mass flux (through faces A) D-diffusion conductance Continuity equation (mass flowrate conservation) Fe=Fw Relative importance of convective transport is characterised by Peclet number of cell (of control volume, because Pe depends upon size of cell) Thermal conductivity Prandtl Binary diffusion coef Schmidt

  10. FVM convection diffusion 1D CFD7 • Methods differ in the way how the unknown transported values at the control volume faces (w , e) are calculated (different interpolation techniques) • Result can be always expressed in the form • Properties of resulting schemes should be evaluated • Conservativeness • Boundedness (positivity of coefficients) • Transportivity (schemes should depend upon the Peclet number of cell)

  11. FVM central scheme 1D CFD7 • Conservativeness (yes) • Boundedness (positivity of coefficients) • Transportivness (no) Very fine mesh is necessary

  12. FVM upwind 1st order 1D CFD7 • Conservativeness (yes) • Boundedness (positivity of coefficients) YES for any Pe • Transportivness (YES) But at a prize of decreased order of accuracy (only 1st order!!)

  13. FVM Upwind FLUENT CFD7 Upwind of the first order Upwind of the second order 1 f 0

  14. FVM hybrid upwind Spalding 19721D CFD7 • Central scheme for Pe<2 • Upwind with diffusion supressed for Pe>2 • Conservativeness (yes) • Boundedness (positivity of coefficients) YES for any Pe • Transportivness (YES) But at a prize of decreased order of accuracy at high Pe

  15. FVM power law Patankar 19801D CFD7 • Polynomial flow for Pe<10 • Upwind with zero diffusion for Pe>10 • Conservativeness (yes) • Boundedness (positivity of coefficients) YES for any Pe • Transportivness (YES)

  16. FVM QUICK Leonard 19791D CFD7 Quadratic Upwind Interpolation – more nodal points necessary w e WW W P E EE • Third order of accuracy very low numerical diffusion comparing with other schemes • Scheme is not bounded (stability problems are frequently encountered) e=1 for Fe>0 else e=0. w=1 for Fw>0 else w=0.

  17. FVM exponential Patankar 19801D CFD7 • Exact solution for constant velocity and diffusion coefficient  • Conservativeness (yes) • Boundedness (positivity of coefficients) YES for any Pe • Transportivness (YES)

  18. FVM exponential FLUENT CFD7 Called power law model in Fluent • Exact solution of Projection of velocity to the direction r 1 r 0 • For Pe<<1 the exponential profile is reduced to linear profile

  19. FVM exponential proof CFD7 • Exact solution for constant velocity and diffusion coefficient  Assume constant mass flux F and constant Pe=F/D. Analytical solution Boundary conditions Identified constants Exact solution at central point

  20. FVM central scheme with modified viscosity CFD7 Almost any scheme (with the exception of QUICK) can be converted to central scheme introducing modified transport coefficient  Modified diffusion conductances are and . Central scheme Upwind scheme Exponential scheme

  21. FVM dispersion / diffusion CFD7 There are two basic errors caused by approximation of convective terms • False diffusion(or numerical diffusion) – artificial smearing of jumps, discontinuities. Neglected terms in the Taylor series expansion of first derivatives (convective terms) represent in fact the terms with second derivatives (diffusion terms). So when using low order formula for convection terms (for example upwind of the first order), their inaccuracy is manifested by the artificial increase of diffusive terms (e.g. by increase of viscosity). The false diffusion effect is important first of all in the case when the flow direction is not aligned with mesh, see example • Dispersion(or aliasing) – causing overshoots, artificial oscillations. Dispersion means that different components of Fourier expansion (of numerical solution) move with different velocities, for example shorter wavelengths move slower than the velocity of flow. Numerical dispersion Numerical diffusion 1 0 - boundary condition, all values are zero in the right triangle (without diffusion)

  22. FVM unstructural mesh generation CFD7 Finite Volume Method Finite Element Method Voronoi polygons Delaunay triangulation each side of Voronoi polygon has a node associated with the node i and these nodes are vertices of Delaunay triangles Voronoi control volume associated with node i. Set of points x,y having distance to i less than the distance to any other node j. Property of Delaunay triangles: Circumcenter remains inside the Delaunay triangle i j

  23. 1 1 0 0 1 1 0 0 FVM structural mesh generation CFD7 Laplace equation solvers

  24. FVM Navier Stokes equations CFD7 Different methods are used for numerical solution of Navier Stokes equations at Compressible flows (finite speed of sound, existence of velocity discontinuities at shocks) Incompressible flows (infinite speed of sound) Explicit methods (e.g. MacCormax) but also implicit methods (Beam-Warming scheme) are used. These methods will not be discussed here. Vorticity and stream function methods (pressure is eliminated from NS equations). These methods are suitable especially for 2D flows. Primitive variable approach (formulation in terms of velocities and pressure). Pressure represents a continuity equation constraint. Only these methods (pressure corrections methods SIMPLE, SIMPLER, SIMPLEC and PISO) using staggered and collocated grid will be discussed in this lecture. Beckman

  25. FVM Navier Stokes equations CFD7 Example: Steady state and 2D (velocities u,v and pressure p are unknown functions) This is equation for u This is equation for v This is equation for p? But pressure p is not in the continuity equation!Solution of this problem is in SIMPLE methods, described later

  26. 0 0 10 0 10 10 10 10 10 10 10 0 10 0 0 0 0 0 0 0 10 FVM checkerboard pattern CFD7 Other problem is called checkerboard pattern This nonuniform distribution of pressure has no effect upon NS equations The problem appears as soon as the u,v,p values are concentrated in the same control volume W P E

  27. 0 0 10 0 10 10 10 10 10 10 10 0 10 0 0 0 0 0 0 0 10 FVM staggered grid CFD7 Different control volumes for different equations Control volume for momentum balance in y-direction Control volume for continuity equation, temperature, concentrations Control volume for momentum balance in x-direction

  28. FVM staggered grid CFD7 Location of velocities and pressure in staggered grid Control volume for momentum balance in y-direction j+2 j+1 j j-1 Control volume for continuity equation, temperature, concentrations J+1 J J-1 J-2 Pressure I,J U i,J V I,j u p v Control volume for momentum balance in x-direction I-2 I-1 I I+1 I+2 i-1 i i+1 i+2

  29. FVM continuity equation CFD7 j+2 j+1 j j-1 Control volume for continuity equation, temperature, concentrations x J+1 J J-1 J-2 Pressure I,J U i,J V I,j p u v I-2 I-1 I I+1 I+2 i-1 i i+1 i+2

  30. FVM momentum x CFD7 j+2 j+1 j j-1 J+1 J J-1 J-2 Pressure I,J U i,J V I,j u p p Control volume for momentum balance in x-direction I-2 I-1 I I+1 I+2 i-1 i i+1 i+2

  31. FVM momentum y CFD7 Control volume for momentum balance in y-direction j+2 j+1 j j-1 J+1 J J-1 J-2 Pressure I,J U i,J V I,j p v p I-2 I-1 I I+1 I+2 i-1 i i+1 i+2

  32. FVM SIMPLE step 1 (velocities) CFD7 Input: Approximation of pressure p*

  33. FVM SIMPLE step 2 (pressure correction) CFD7 “true” solution Neglect!!! subtract Substitute u*+u’ and v*+v’ into continuity equation Solve equations for pressure corrections

  34. FVM SIMPLE step 3 (update p,u,v) CFD7 Only these new pressures are necessary for next iteration Continue with the improved pressures to the step 1

  35. FVM SIMPLEC (SIMPLE corrected) CFD7 Neglect!!! Good estimate as soon as neighbours are not far from center Improved diJ

  36. FVM SIMPLER (SIMPLE Revised) CFD7 Idea: calculate pressure distribution directly from the Poisson’s equation

  37. FVM Rhie Chow (Fluent) CFD7 The way how to avoid staggering (difficult implementation in unstructured meshes) was suggested in the paper Rhie C.M., Chow W.L.: Numerical study of the turbulent flow past an airfoil with trailing edge separation. AIAA Journal, Vol.21, No.11, 1983 This technique is calledRhie-Chow interpolation.

  38. E P e FVM Rhie Chow (Fluent) CFD7 Rhie C.M., Chow W.L.: Numerical study of the turbulent flow past an airfoil with trailing edge separation. AIAA Journal, Vol.21, No.11, 1983 How to interpolate ue velocity at a control volume face

  39. Fluent - solvers CFD7 Segregated solver Coupled solver , , cp,… , , cp,… u… v… w… p… (SIMPLE…) CFL Courant Friedrichs Lewy criterion k,,…… T,k,,…… Nonstationary problem always solved by implicit Euler Nonstationary problem solved by implicit Euler (CFL~5), explicit Euler (CFL~1) or Runge Kutta Algebraic eq. by multigrid AMG, or FAS (Full Aproximation Storage) Algebraic eq. by multigrid AMG

  40. FVM solvers CFD7 Dalí

  41. FVM solvers CFD7 Solution of linear algebraic equation system Ax=b • TDMA – Gauss elimination tridiagonal matrix (obvious choice for 1D problems, but suitable for 2D and 3D problems too, iteratively along the x,y,z grid lines – method of alternating directions ADI) • PDMA – pentadiagonal matrix(suitable for QUICK), Fortran version • CGM – Conjugated Gradient Method(iterative method: each iteration calculates increment of vector  in the direction of gradient of minimised function – square of residual vector) • Multigrid method (Fluent)

  42. Solver TDMA tridiagonal system MATLAB CFD7 function x = TDMAsolver(a,b,c,d) %a, b, c, and d are the column vectors for the compressed tridiagonal matrix n = length(b); % n is the number of rows % Modify the first-row coefficients c(1) = c(1) / b(1); % Division by zero risk. d(1) = d(1) / b(1); % Division by zero would imply a singular matrix. for i = 2:n id = 1 / (b(i) - c(i-1) * a(i)); % Division by zero risk. c(i) = c(i)* id; % Last value calculated is redundant. d(i) = (d(i) - d(i-1) * a(i)) * id; end % Now back substitute. x(n) = d(n); for i = n-1:-1:1 x(i) = d(i) - c(i) * x(i + 1); end end Forward step (elimination entries bellow diagonal)

  43. Solver TDMA applied to 2D problems (ADI) CFD7 Y-implicit step (repeated application of TDMA for 10 equations, proceeds from left to right) X-implicit step (proceeds bottom up) y x

  44. Solver PDMA pentagonal system MATLAB CFD7 % Backsubstitution L'x=c x(N)=c(N); x(N-1)=c(N-1)-gamma(N-1)*x(N); for k=N-2:-1:1 x(k)=c(k)-gamma(k)*x(k+1)-delta(k)*x(k+2); end else % Non-symmetric Matrix Scheme d=diag(A); e=diag(A,1); f=diag(A,2); h=[0;diag(A,-1)]; g=[0;0;diag(A,-2)]; alpha=zeros(N,1); gam=zeros(N-1,1); delta=zeros(N-2,1); bet=zeros(N,1); c=zeros(N,1); z=zeros(N,1); alpha(1)=d(1); gam(1)=e(1)/alpha(1); delta(1)=f(1)/alpha(1); bet(2)=h(2); alpha(2)=d(2)-bet(2)*gam(1); gam(2)=( e(2)-bet(2)*delta(1) )/alpha(2); delta(2)=f(2)/alpha(2); for k=3:N-2 bet(k)=h(k)-g(k)*gam(k-2); alpha(k)=d(k)-g(k)*delta(k-2)-bet(k)*gam(k-1); gam(k)=( e(k)-bet(k)*delta(k-1) )/alpha(k); delta(k)=f(k)/alpha(k); end bet(N-1)=h(N-1)-g(N-1)*gam(N-3); alpha(N-1)=d(N-1)-g(N-1)*delta(N-3)-bet(N-1)*gam(N-2); gam(N-1)=( e(N-1)-bet(N-1)*delta(N-2) )/alpha(N-1); bet(N)=h(N)-g(N)*gam(N-2); alpha(N)=d(N)-g(N)*delta(N-2)-bet(N)*gam(N-1); % Update b=Lc c(1)=b(1)/alpha(1); c(2)=(b(2)-bet(2)*c(1))/alpha(2); for k=3:N c(k)=( b(k)-g(k)*c(k-2)-bet(k)*c(k-1) )/alpha(k); end function x=pentsolve(A,b) % Solve a pentadiagonal system Ax=b where A is a strongly nonsingular matrix % Reference: G. Engeln-Muellges, F. Uhlig, "Numerical Algorithms with C" % Chapter 4. Springer-Verlag Berlin (1996)% % Written by Greg von Winckel 3/15/04 % Contact: gregvw@chtm.unm.edu % [M,N]=size(A); x=zeros(N,1); % Check for symmetry if A==A' % Symmetric Matrix Scheme % Extract bands d=diag(A); f=diag(A,1); e=diag(A,2); alpha=zeros(N,1); gamma=zeros(N-1,1); delta=zeros(N-2,1); c=zeros(N,1); z=zeros(N,1); % Factor A=LDL' alpha(1)=d(1); gamma(1)=f(1)/alpha(1); delta(1)=e(1)/alpha(1); alpha(2)=d(2)-f(1)*gamma(1); gamma(2)=(f(2)-e(1)*gamma(1))/alpha(2); delta(2)=e(2)/alpha(2); for k=3:N-2 alpha(k)=d(k)-e(k-2)*delta(k-2)-alpha(k-1)*gamma(k-1)^2; gamma(k)=(f(k)-e(k-1)*gamma(k-1))/alpha(k); delta(k)=e(k)/alpha(k); end alpha(N-1)=d(N-1)-e(N-3)*delta(N-3)-alpha(N-2)*gamma(N-2)^2; gamma(N-1)=(f(N-1)-e(N-2)*gamma(N-2))/alpha(N-1); alpha(N)=d(N)-e(N-2)*delta(N-2)-alpha(N-1)*gamma(N-1)^2; % Update Lx=b, Dc=z z(1)=b(1); z(2)=b(2)-gamma(1)*z(1); for k=3:N z(k)=b(k)-gamma(k-1)*z(k-1)-delta(k-2)*z(k-2); end c=z./alpha; % Back substitution Rx=c x(N)=c(N); x(N-1)=c(N-1)-gam(N-1)*x(N); for k=N-2:-1:1 x(k)=c(k)-gam(k)*x(k+1)-delta(k)*x(k+2); end end

  45. Solver CGM conjugated gradient GNU CFD7 Solution of linear algebraic equation system Ax=b Minimisation of quadratic function function [x] = conjgrad(A,b,x) r=b-A*x; p=r; rsold=r'*r; for i=1:size(A)(1) Ap=A*p; alpha=rsold/(p'*Ap); x=x+alpha*p; r=r-alpha*Ap; rsnew=r'*r; if sqrt(rsnew)<1e-10 break; end p=r+rsnew/rsold*p; rsold=rsnew; end end Residual vector in k-th iteration Vector of increment conjugated with previous increments

  46. Solver MULTIGRID CFD7 Solution on a rough grid takes into account very quickly long waves (distant boundaries etc), that is refined on a finer grid. Rough grid (small wave numbers) Fine grid (large wave numbers details) Interpolation from rough to fine grid Averaging from fine to rough grid

  47. n+1 n+1 n+1 ∆t ∆t ∆t n n n ∆x ∆x ∆x n-1 n-1 n-1 Unsteady flows CFD7 Discretisation like in the finite difference methods discussed previously Example: Temperature field EXPLICIT scheme IMPLICIT scheme CRANK NICHOLSON scheme First order accuracy in time First order accuracy in time Second order accuracy in time Stable only if Unconditionally stable and bounded Unconditionally stable, but bounded only if

  48. PRESSURE PRESSURE OUTLET PRESSURE INLET INLET PRESSURE PRESSURE OUTLET OUTLET PRESSURE PRESSURE FVM Boundary conditions CFD7 • Boundary conditions are specified at faces of cells (not at grid points) • INLET specified u,v,w,T,k, (but not pressure!) • OUTLET nothing is specified (p is calculated from continuity eq.) • PRESSURE only pressure is specified (not velocities) • WALL zero velocities, kP, P calculated from the law of wall P yP Recommended combinations for several outlets Forbiddencombinations for several outlets there is no unique solution because no flowrate is specified

  49. Stream function-vorticity CFD7 Introducing stream function and vorticity instead of primitive variables (velocities and pressure) eliminates the problem with the checkerboard pattern. Continuity equation is exactly satisfied. However the technique is used mostly for 2D problems (it is sufficient to solve only 2 equations), because in 3D problems 3 components of vorticity and 3 components of vector potential must be solved (comparing with only 4 equations when using primitive variable formulation of NS equations). Ghirlandaio

  50. Stream function-vorticity CFD7 The best method for solution of 2D problems of incompressible flows Pressure elimination Introduction vorticity (z-component of vorticity vector) Velocities expressed in terms of scalar stream function Vorticity expressed in terms of stream function

More Related