PISO algorithm

Last updated

PISO algorithm (Pressure-Implicit with Splitting of Operators) was proposed by Issa in 1986 without iterations and with large time steps and a lesser computing effort. It is an extension of the SIMPLE algorithm used in computational fluid dynamics to solve the Navier-Stokes equations. PISO is a pressure-velocity calculation procedure for the Navier-Stokes equations developed originally for non-iterative computation of unsteady compressible flow, but it has been adapted successfully to steady-state problems.

Contents

PISO involves one predictor step and two corrector steps and is designed to satisfy mass conservation using predictor-corrector steps.

Algorithm steps

Flow chart of PISO algorithm Flow chart of PISO algorithm.png
Flow chart of PISO algorithm

The algorithm can be summed up as follows:

  1. Set the boundary conditions.
  2. Solve the discretized momentum equation to compute an intermediate velocity field.
  3. Compute the mass fluxes at the cells faces.
  4. Solve the pressure equation.
  5. Correct the mass fluxes at the cell faces.
  6. Correct the velocities on the basis of the new pressure field.
  7. Update the boundary conditions.
  8. Repeat from 3 for the prescribed number of times.
  9. Increase the time step and repeat from 1.

Steps 4 and 5 can be repeated for a prescribed number of times to correct for non-orthogonality.

Predictor step

Guess the pressure field and get velocity field components and using discretized momentum equation. The initial guess for the pressure may or may not be correct.
Corrector step 1
Velocity component obtained from predictor step may not satisfy the continuity equation, so we define correction factors p',v',u' for the pressure field and velocity field. Solve the momentum equation by inserting correct pressure field and get the corresponding correct velocity components and .



where ;
:correct pressure field and velocity component
:correction in pressure field and correction in velocity components
:guessed pressure field and velocity component
We define as above. By putting the correct pressure field into the discretized momentum equation we get the correct velocity components and . Once the pressure correction is known we can find the correction components for the velocity: and .

Corrector step 2 In piso another corrector step can be used.
 ;
 ;
 ;
where : are the correct pressure field and the correct velocity components, respectively
and are second corrections to the pressure and velocity field.
Set where; are correct pressure and velocity field

Advantages and disadvantages

  1. Generally gives more stable results and takes less CPU time but not suitable for all processes.
  2. Suitable numerical schemes for solving the pressure-velocity linked equation.
  3. For laminar backward facing step PISO is faster than SIMPLE but it is slower concerning flow through heated fin.
  4. If momentum and scalar equation have weak or no coupling then PISO is better than SIMPLEC.
  5. PISO is most time effective method

See also

Related Research Articles

<span class="mw-page-title-main">Fluid dynamics</span> Aspects of fluid mechanics involving flow

In physics, physical chemistry and engineering, fluid dynamics is a subdiscipline of fluid mechanics that describes the flow of fluids—liquids and gases. It has several subdisciplines, including aerodynamics and hydrodynamics. Fluid dynamics has a wide range of applications, including calculating forces and moments on aircraft, determining the mass flow rate of petroleum through pipelines, predicting weather patterns, understanding nebulae in interstellar space and modelling fission weapon detonation.

<span class="mw-page-title-main">Navier–Stokes equations</span> Equations describing the motion of viscous fluid substances

The Navier–Stokes equations are partial differential equations which describe the motion of viscous fluid substances. They were named after French engineer and physicist Claude-Louis Navier and the Irish physicist and mathematician George Gabriel Stokes. They were developed over several decades of progressively building the theories, from 1822 (Navier) to 1842–1850 (Stokes).

<span class="mw-page-title-main">Computational fluid dynamics</span> Analysis and solving of problems that involve fluid flows

Computational fluid dynamics (CFD) is a branch of fluid mechanics that uses numerical analysis and data structures to analyze and solve problems that involve fluid flows. Computers are used to perform the calculations required to simulate the free-stream flow of the fluid, and the interaction of the fluid with surfaces defined by boundary conditions. With high-speed supercomputers, better solutions can be achieved, and are often required to solve the largest and most complex problems. Ongoing research yields software that improves the accuracy and speed of complex simulation scenarios such as transonic or turbulent flows. Initial validation of such software is typically performed using experimental apparatus such as wind tunnels. In addition, previously performed analytical or empirical analysis of a particular problem can be used for comparison. A final validation is often performed using full-scale testing, such as flight tests.

In plasma physics, the particle-in-cell (PIC) method refers to a technique used to solve a certain class of partial differential equations. In this method, individual particles in a Lagrangian frame are tracked in continuous phase space, whereas moments of the distribution such as densities and currents are computed simultaneously on Eulerian (stationary) mesh points.

<span class="mw-page-title-main">Smoothed-particle hydrodynamics</span> Method of hydrodynamics simulation

Smoothed-particle hydrodynamics (SPH) is a computational method used for simulating the mechanics of continuum media, such as solid mechanics and fluid flows. It was developed by Gingold and Monaghan and Lucy in 1977, initially for astrophysical problems. It has been used in many fields of research, including astrophysics, ballistics, volcanology, and oceanography. It is a meshfree Lagrangian method, and the resolution of the method can easily be adjusted with respect to variables such as density.

Fluid mechanics is the branch of physics concerned with the mechanics of fluids and the forces on them. It has applications in a wide range of disciplines, including mechanical, aerospace, civil, chemical, and biomedical engineering, as well as geophysics, oceanography, meteorology, astrophysics, and biology.

<span class="mw-page-title-main">Lattice Boltzmann methods</span> Class of computational fluid dynamics methods

The lattice Boltzmann methods (LBM), originated from the lattice gas automata (LGA) method (Hardy-Pomeau-Pazzis and Frisch-Hasslacher-Pomeau models), is a class of computational fluid dynamics (CFD) methods for fluid simulation. Instead of solving the Navier–Stokes equations directly, a fluid density on a lattice is simulated with streaming and collision (relaxation) processes. The method is versatile as the model fluid can straightforwardly be made to mimic common fluid behaviour like vapour/liquid coexistence, and so fluid systems such as liquid droplets can be simulated. Also, fluids in complex environments such as porous media can be straightforwardly simulated, whereas with complex boundaries other CFD methods can be hard to work with.

The MEMO model is a Eulerian non-hydrostatic prognostic mesoscale model for wind-flow simulation. It was developed by the Aristotle University of Thessaloniki in collaboration with the Universität Karlsruhe. The MEMO Model together with the photochemical dispersion model MARS are the two core models of the European zooming model (EZM). This model belongs to the family of models designed for describing atmospheric transport phenomena in the local-to-regional scale, frequently referred to as mesoscale air pollution models.

Pressure-correction method is a class of methods used in computational fluid dynamics for numerically solving the Navier-Stokes equations normally for incompressible flows.

In computational fluid dynamics, the MacCormack method is a widely used discretization scheme for the numerical solution of hyperbolic partial differential equations. This second-order finite difference method was introduced by Robert W. MacCormack in 1969. The MacCormack method is elegant and easy to understand and program.

<span class="mw-page-title-main">Volume of fluid method</span> Free-surface modelling technique

In computational fluid dynamics, the volume of fluid (VOF) method is a free-surface modelling technique, i.e. a numerical technique for tracking and locating the free surface. It belongs to the class of Eulerian methods which are characterized by a mesh that is either stationary or is moving in a certain prescribed manner to accommodate the evolving shape of the interface. As such, VOF is an advection scheme—a numerical recipe that allows the programmer to track the shape and position of the interface, but it is not a standalone flow solving algorithm. The Navier–Stokes equations describing the motion of the flow have to be solved separately. The same applies for all other advection algorithms.

In computational fluid dynamics (CFD), the SIMPLE algorithm is a widely used numerical procedure to solve the Navier–Stokes equations. SIMPLE is an acronym for Semi-Implicit Method for Pressure Linked Equations.

In fluid dynamics, The projection method is an effective means of numerically solving time-dependent incompressible fluid-flow problems. It was originally introduced by Alexandre Chorin in 1967 as an efficient means of solving the incompressible Navier-Stokes equations. The key advantage of the projection method is that the computations of the velocity and the pressure fields are decoupled.

<span class="mw-page-title-main">Wind-turbine aerodynamics</span> Physical property

The primary application of wind turbines is to generate energy using the wind. Hence, the aerodynamics is a very important aspect of wind turbines. Like most machines, wind turbines come in many different types, all of them based on different energy extraction concepts.

<span class="mw-page-title-main">Linear seismic inversion</span> Interpretation of seismic data using linear model

Inverse modeling is a mathematical technique where the objective is to determine the physical properties of the subsurface of an earth region that has produced a given seismogram. Cooke and Schneider (1983) defined it as calculation of the earth's structure and physical parameters from some set of observed seismic data. The underlying assumption in this method is that the collected seismic data are from an earth structure that matches the cross-section computed from the inversion algorithm. Some common earth properties that are inverted for include acoustic velocity, formation and fluid densities, acoustic impedance, Poisson's ratio, formation compressibility, shear rigidity, porosity, and fluid saturation.

Equation-free modeling is a method for multiscale computation and computer-aided analysis. It is designed for a class of complicated systems in which one observes evolution at a macroscopic, coarse scale of interest, while accurate models are only given at a finely detailed, microscopic, level of description. The framework empowers one to perform macroscopic computational tasks using only appropriately initialized microscopic simulation on short time and small length scales. The methodology eliminates the derivation of explicit macroscopic evolution equations when these equations conceptually exist but are not available in closed form; hence the term equation-free.

Fluid motion is governed by the Navier–Stokes equations, a set of coupled and nonlinear partial differential equations derived from the basic laws of conservation of mass, momentum and energy. The unknowns are usually the flow velocity, the pressure and density and temperature. The analytical solution of this equation is impossible hence scientists resort to laboratory experiments in such situations. The answers delivered are, however, usually qualitatively different since dynamical and geometric similitude are difficult to enforce simultaneously between the lab experiment and the prototype. Furthermore, the design and construction of these experiments can be difficult, particularly for stratified rotating flows. Computational fluid dynamics (CFD) is an additional tool in the arsenal of scientists. In its early days CFD was often controversial, as it involved additional approximation to the governing equations and raised additional (legitimate) issues. Nowadays CFD is an established discipline alongside theoretical and experimental methods. This position is in large part due to the exponential growth of computer power which has allowed us to tackle ever larger and more complex problems.

The SIMPLEC algorithm; a modified form of SIMPLE algorithm; is a commonly used numerical procedure in the field of computational fluid dynamics to solve the Navier–Stokes equations.

In physics, a free surface flow is the surface of a fluid flowing that is subjected to both zero perpendicular normal stress and parallel shear stress. This can be the boundary between two homogeneous fluids, like water in an open container and the air in the Earth's atmosphere that form a boundary at the open face of the container.

<span class="mw-page-title-main">Parareal</span> Parallel algorithm from numerical analysis

Parareal is a parallel algorithm from numerical analysis and used for the solution of initial value problems. It was introduced in 2001 by Lions, Maday and Turinici. Since then, it has become one of the most widely studied parallel-in-time integration methods.

References

  1. An Introduction to Computational Fluid Dynamics The Finite Volume Method, 2/e By Versteeg ISBN   978-0131274983
  2. Computational Fluid Dynamics for Engineers by Bengt Andersson, Ronnie Andersson, Love Håkansson, Mikael Mortensen, Rahman Sudiyo, Berend van Wachem ISBN   978-1-107-01895-2
  3. Computational Fluid Dynamics in Fire Engineering: Theory, Modelling and Practice by Guan Heng Yeoh, Kwok Kit Yuen ISBN   978-0750685894
  4. http://openfoamwiki.net/index.php/OpenFOAM_guide/The_PISO_algorithm_in_OpenFOAM
  5. Computational fluid dynamics by T. J. Chung, University of Alabama in Huntsville ISBN   0 521 59416 2
  6. Computational method for fluid dynamics by Joel H.Ferziger, Milovan Peric ISBN   3-540-42074-6
  7. Solution of the implicitly discretized fluid flow equations by operator-splitting, Journal of Computational Physics 62 by R. Issa