CN104866695A - GPU-accelerated fluid-structure coupling simulation method through immersion boundary and lattice Boltzmann methods - Google Patents

GPU-accelerated fluid-structure coupling simulation method through immersion boundary and lattice Boltzmann methods Download PDF

Info

Publication number
CN104866695A
CN104866695A CN201510355061.4A CN201510355061A CN104866695A CN 104866695 A CN104866695 A CN 104866695A CN 201510355061 A CN201510355061 A CN 201510355061A CN 104866695 A CN104866695 A CN 104866695A
Authority
CN
China
Prior art keywords
boundary
fluid
delta
alpha
node
Prior art date
Legal status (The legal status is an assumption and is not a legal conclusion. Google has not performed a legal analysis and makes no representation as to the accuracy of the status listed.)
Granted
Application number
CN201510355061.4A
Other languages
Chinese (zh)
Other versions
CN104866695B (en
Inventor
吴家阳
程永光
张春泽
刁伟
Current Assignee (The listed assignees may be inaccurate. Google has not performed a legal analysis and makes no representation or warranty as to the accuracy of the list.)
Wuhan University WHU
Original Assignee
Wuhan University WHU
Priority date (The priority date is an assumption and is not a legal conclusion. Google has not performed a legal analysis and makes no representation as to the accuracy of the date listed.)
Filing date
Publication date
Application filed by Wuhan University WHU filed Critical Wuhan University WHU
Priority to CN201510355061.4A priority Critical patent/CN104866695B/en
Publication of CN104866695A publication Critical patent/CN104866695A/en
Application granted granted Critical
Publication of CN104866695B publication Critical patent/CN104866695B/en
Expired - Fee Related legal-status Critical Current
Anticipated expiration legal-status Critical

Links

Landscapes

  • Management, Administration, Business Operations System, And Electronic Commerce (AREA)

Abstract

The invention provides a GPU-accelerated fluid-structure coupling simulation method through immersion boundary and lattice Boltzmann methods. The GPU-accelerated fluid-structure coupling simulation method comprises the following steps: 1, establishing a structure body to be detected and an internal fluid immersion boundary body shape in professional pre-processing software, and dividing a boundary lattice for program read; reading boundary body shape data through a program, and setting a boundary condition of a point required to be measured and a program model parameter; calculating the boundary acting force applied to a fluid by using a finite element method according to a structure of the boundary at the current time and a reference structure; diffusing the boundary acting force to surrounding fluids through the Dirac function; solving a Navier-Stokes equation carrying an external force term by using the lattice Boltzmann method; interpolating the fluid speed into the boundary through the Dirac function to obtain a boundary movement speed to further update the boundary position; repeatedly performing the steps 3-6 till the updated boundary position reaches an calculated ending point. According to the GPU-accelerated fluid-structure coupling simulation method, structure bodies in any shapes can be processed, an underlying fluid lattice does not require to be reconstructed in the calculation process, and the calculation efficiency is high.

Description

A kind of immersed boundary-Lattice Boltzmann fluid structurecoupling analogy method accelerated through GPU
Technical field
The invention belongs to the crossing domain of computational fluid dynamics and Solid State Mechanics of Computation, particularly high-performance calculation is in the application in above-mentioned field.
Background technology
Interaction between fluid and deformable structure, at nature ubiquity, is seen everywhere especially especially in biological tissue and organ, and typical example comprises insect wing, fin, human heart valve and vocal cords.Although said structure belongs to and separates plane and learn or the research object in physiology field, it is most important that they complete the function of specifying in three-dimensional kinematics character and the spatial form that changes at any time to biosome.Because the inherent complicacy in the drastic deformation that structure experiences and surrounding flow field, so correctly simulate one of fluid structurecoupling problem a major challenge remaining academia under three-dimensional condition up to now.
Traditional analog stream that is used for consolidates the method for coupled problem usually based on fit grid, and typical example comprises Arbitrary Lagrangian-Euler method and finite element method.The inferior position of said method is that bottoms stream grid needs to adjust according to locations of structures, and in order to prevent the drastic deformation of grid from needing to carry out special processing.Generally speaking mess generation is process of a high price, particularly needing calculating consuming time in a large number when planform is complicated to upgrade mesh topology, making to push classic method to practical application and having difficulties.
Therefore, be necessary very much for a kind of new fluid structurecoupling analogy method of efficiency exploitation, can not with under reducing prerequisite that computational accuracy is cost, shortening computing time, for Practical Project provides reliable guiding opinion.
Immersed boundary method has obtained extensively and successfully application as the numerical algorithm of the solid coupled problem of a kind of special analog stream since proposition.In this method, fluid and structure adopt Euler method and Lagrangian method to describe respectively, and be used for the orthogonal cartesian grid of discrete fluid and structure and unstructured grid respectively and there is no need to coincide together, and this just immersed boundary method compared to a large advantage of classic method, solve the difficult point that each time step all needs to re-construct according to structure position and form grid.The interaction of fluid and structure is realized by Dirac function, utilize this function the acting force be defined on structure grid node can be diffused to peripheral fluid net point, and also fluid velocity can be interpolated on structure net point, thus upgrade the position of structure.Except above-mentioned steps, the simulation of fluid structurecoupling can be completed very compactly without the need to extra additional treatments.
In immersed boundary method, the most basic is a bit how to solve the incompressible NS equation of viscosity.The method for solving of this equation is very abundant, such as Fast Fourier Transform (FFT), projecting method or finite volume method.In addition the very welcome Lattice Boltzmann Method that newly-developed gets up also is good selection.The NS method solved with classic method is different, adopting is situated between see that the Lattice Boltzmann Method at visual angle solves be distribution function the Boltzmann equation that meets.In the past during the decade, Lattice Boltzmann Method has been confirmed to be a kind of very powerful computational fluid dynamics instrument, and all obtains successful Application in its branch field.Compare with classic method, Lattice Boltzmann Method be easy to parallel and extra physical influence the concern that advantage obtains more and more scholar such as to facilitate the introduction of.
Since 2003, the microprocessor Design of semi-conductor industry starts towards two Main way development.First multinuclear path relies on the execution efficiency of strengthening serial code and multi-core technology to improve performance.Multinuclear starts from two nuclear models, and along with the doubles of the core that updates each time, the Core i7 processor of such as Intel has four cores.In contrast, above the handling capacity that many core paths having focused on then by concern improves parallel codes execution, compare with central processing unit, but many-core processor will comprise more much smaller core, the Geforce GTX280 graphic process unit of such as NVIDIA company comprises 240 cores.As comparing, the ratio of the peak value operational performance of graphic process unit in 2009 and central processing unit is 10:1, the peak throughput that the Geforce 780Ti of NVIDIA company in 2014 provides is 5500GFLOPS, and the data of the Ivy Bridge framework of Intel Company are 700GFLOPS.So large operational performance gap has allowed increasing scientific research personnel that the computation-intensive part in their programs is transferred to Graphics Processing Unit to perform.
Because such as need directly for chip programming as OpenGL and Direct3D technology, and until programmer in 2006 must visit its core by application programming interface, so the use of graphic process unit is very difficult.These application programming interface limit the type of the application program can write for chip, utilize graphic process unit to run the necessary technology of specific program, and then limit the wide-scale distribution of this technology so only have fraction programmer to grasp.All were released CUDA technology along with NVIDIA company in 2007 and change.Because evaded traditional application programming interface, pass through CUDA, present programmers can with they the class C/C++ language be familiar with come directly for chip programming, even if thus make multiple programming technology also be very easy to left-hand seat for beginner, advance the application of this technology in scientific domain widely.
Because Lattice Boltzmann Method is the explicit scheme be defined on orthogonal grid, and only need the information exchanging adjacent node, so it is very suitable for parallelization in graphic process unit.Be developed so far, the article about Lattice Boltzmann Method parallelization delivered is very abundant, and compared to central processing unit, travelling speed generally can improve two orders of magnitude.Although the parallelization of Lattice Boltzmann Method becomes better and approaching perfection day by day, but the research it being combined the solid coupled problem of analog stream with immersed boundary method does not still start to walk, and does not more have the article of the potential data parallelism of analysis immersed boundary method of thorough to deliver.
Summary of the invention
For the deficiency that prior art exists, the present invention proposes a kind of solid coupled simulation method of efficient stream based on GPU.
In order to solve the problems of the technologies described above, the present invention adopts following technical scheme:
Concrete operation step of the present invention is as follows:
1) in professional pre-processing software, set up the immersed boundary build of structure to be measured and internal flow thereof, and divide border grid and read for program;
2) program reading boundary build data, arrange boundary condition and the procedural model parameter of zoning;
3) Finite element arithmetic border is utilized to be applied to acting force on fluid according to border current time configuration and reference configuration;
4) acting force on border is diffused to peripheral fluid via Dirac function;
5) Navier Stokes equation of external force term is utilized Lattice Boltzmann Method to solve to carry;
6) fluid velocity is interpolated into via Dirac function translational speed border obtaining border equally, and then upgrades boundary position;
7) step 3-6 is repeated, until reach calculating terminal.
Described professional pre-processing software is Gambit or ICEM or ProE.
In the present invention, detailed process is as follows:
One, the interaction between immersed boundary method process fluid and structure is adopted.
Comprise the feature of following several respects specifically:
1), under two-dimensional condition, one dimension wire grid discrete topology body is adopted.Under three-dimensional condition, adopt destructuring triangular mesh discrete topology body.
2) under two-dimensional condition, consider that structure opposing stretches and bending ability simultaneously, be defined in tension on node and resistance to bending density is calculated as follows respectively:
( F s ) l = K s ( Δα l ) 2 Σ m = 1 n f - 1 ( | X m + 1 - X m | - Δα l ) X m + 1 - X m | X m + 1 - X m | ( δ m l - δ m + 1 , l ) ·
( F b ) l = K b ( Δα l ) 4 Σ m = 2 n f - 1 ( X m + 1 + X m - 1 - 2 X m ) ( 2 δ m l - δ m + 1 , l - δ m - 1 , l ) ·
(F in above formula s) l(F b) lrepresent respectively to be defined in and be numbered tension on the node of l and unbending lines of force density; K sand K bbe respectively tensile index and bending stiffness; Δ α lfor the former length of the node of numbering l; X m+1, X m-1and X mbe respectively the node coordinate of numbering m+1, m-1 and m; δ mlfor Kronecker symbol, as m=l, its value is 1, and in all the other situations, value is 0; n ffor being used for total nodes of discrete topology body.
Under three-dimensional condition, the stress of Elasticity method computation structure body can be used.In the present invention, we only consider the drawing-resistant function of structure.First only there is the contribution of tension in the energy of structure, and the gross energy W of structure can be expressed as W=∫ w sdA, wherein w sfor drawing of structure can density, and dA is bin area.For the material following broad sense Hooke theorem, it draws and can density can be expressed as:
w s = E 6 ( I 1 + 1 I 2 + 1 - 1 ) ,
Wherein E is elastic modulus, I 1and I 2be respectively the first and second strain invariants.Under three-dimensional condition, can prove that strain invariant can be calculated as follows:
λ 1 2 + λ 2 2 = a 2 + b 2 + c 2 , λ 1 2 λ 2 2 = a 2 c 2
Wherein λ 1and λ 2be along the draw ratio in a pair mutually perpendicular direction in normal plane, and the calculating formula of a, b, c is:
a = l l 0 ,
In above formula, accompanying drawing 1 is shown in the definition of parameter, in above formula, geometric parameter is defined as follows: after structure reference configuration and distortion, configuration chooses two pieces of corresponding Triangular patch, in above-mentioned triangle, choose arbitrarily two limits respectively, on reference configuration, its length of side is respectively l 0and l 0', and after deformation on configuration its length of side be respectively l and l ', with be respectively the angle of above-mentioned two limits after reference configuration and distortion on configuration.。
The strain energy of structure can be calculated by above-mentioned steps, is finally defined in the acting force density F be numbered on m node mthe principle of virtual work can be utilized to calculate:
F m = - ∂ W ( X m ) ∂ X m ·
3) after obtaining structure acting force density, we need to be diffused to structure peripheral fluid node, and by introducing Dirac function, said process can be described by following equation:
f ( x , t ) = Σ m F m δ ( x - X m ) Δs k
The acting force density that f (x, t) in above formula is subject to for t point x place fluid, respectively just to two and three dimensions condition, Δ s kbe defined in be numbered arc length on the structure node of k and area respectively, and δ (x-X m) be Dirac function, generally take following concrete form:
&delta; ( x - X m ) = 1 8 ( 3 - 2 | x - X m | + 1 + 4 | x - X m | - 4 ( x - X m ) 2 ) , 0 &le; | x - X m | < 1 1 8 ( 5 - 2 | x - X m | - - 7 + 12 | x - X m | - 4 ( x - X m ) 2 ) , 1 &le; | x - X m | < 2 , 0 , | x - X m | &GreaterEqual; 2.
In order to obtain the change procedure of structure shape, we need the configuration upgrading structure according to the speed of structure net point, and under known flow field velocity distribution occasion, structure speed will utilize Dirac function by obtaining from flow field interpolation equally:
dX m d t = U m = &Sigma; x u ( x , t ) &delta; ( x - X m ) &Delta; h
U in above formula mfor the speed of structure net point, u (x, t) is the speed of t point x place fluid, and Δ h is mesh spacing.
Two, the incompressible modeling flow field in Lattice Boltzmann Method is adopted.
Lattice Boltzmann Method is a kind of novel method in Fluid Mechanics Computation field.It is often used to numerical solution unsteady flo w can not press NS equation.Its advantage is the ability presenting complicated physical phenomena, and these phenomenons comprise from polyphasic flow up to the chemical reaction between fluid and ambient substance.The method stems from the description of fluid molecule level and can directly the interactional information between molecule and its simple form be embedded into inside model.
Different from the classic method of the variablees such as the velocity pressure in direct solution NS equation, the starting point of Lattice Boltzmann Method be placed on function g (x, ξ, t) on the Boltzmann equation that meets.Function g (x, ξ, t) physical significance is that t finds speed to be positioned at the probability of the molecule of unit interval near ξ near x in unit volume, according to Molecule Motion Theory, under the thin condition approximate with collision term employing BGK of gas, its equation met is Boltzmann equation:
&part; g ( x , &xi; , t ) &part; t + &xi; &CenterDot; &dtri; g ( x , &xi; , t ) + f ( x , t ) &CenterDot; &part; g ( x , &xi; , t ) &part; &xi; = - 1 &lambda; &lsqb; g ( x , &xi; , t ) - g e q ( x , &xi; , t ) &rsqb; ,
Wherein g eq(x, ξ, t) is equilibrium distribution function, for vector differential operator, λ is slack time.By above-mentioned equation discrete in the velocity space of time and space and finite dimensional, we can obtain Lattice Boltzmann equation:
g &alpha; ( x + &xi; &alpha; &delta; t , t + &delta; t ) - g &alpha; ( x , t ) = - 1 &tau; ( g &alpha; ( x , t ) - g &alpha; e q ( x , t ) ) + ( 1 - 1 2 &tau; ) { 3 &lsqb; &xi; &alpha; - u ( x , t ) &rsqb; + 9 &lsqb; &xi; &alpha; &CenterDot; u ( x , t ) &CenterDot; &xi; &alpha; &rsqb; } &CenterDot; f ( x , t ) ,
In formula, g α(x, t) represents that t x place is along discrete velocity reversal ξ αdistribution function, and g α(x+ ξ αδ t, t+ δ t) represent t+ δ tmoment x+ ξ αδ tplace is along discrete velocity reversal ξ αdistribution function. that t x place is along discrete velocity reversal ξ αequilibrium distribution function.τ is nondimensional slack time, relevant with intermolecular viscosity coefficient.δ tfor time step.The macroscopic physical quantity that we are concerned about such as density p (x, t), speed etc. can be obtained by each rank velocity moment of distribution function:
&rho; ( x , t ) = &Sigma; &alpha; g &alpha; ( x , t ) , &rho; ( x , t ) u ( x , t ) = &Sigma; &alpha; &xi; &alpha; g &alpha; ( x , t ) + f ( x , t ) / 2.
Pressure is then determined by state equation.
Distribution function Evolution represented by Lattice Boltzmann equation can be decomposed into collision and transition process, is shown below.
g &alpha; ( x , t ) = - 1 &tau; ( g &alpha; ( x , t ) - g &alpha; e q ( x , t ) ) ,
g α(x+ξ αδ t,t+δ t)=g α(x,t),
First distribution function will be relaxed to its equilibrium state by collision on node, move thereafter along discrete velocity reversal to adjacent node again.On the whole, if the value of a known upper moment full-field distribution function and macroscopic physical quantity, the step developed to subsequent time is:
1) collision of distribution function, is carried out according to formula.
2), the process of boundary condition.
3), according to formula complete the transition process of distribution function, the distribution function of subsequent time can be obtained.
4), calculated the macroscopic physical quantity of subsequent time according to formula by the distribution function after moving.
Three, the parallel algorithm speed-up computation of graphic based processing unit is adopted.
In the present invention, the CUDA language that NIVIDIA company releases is used to develop the code being adapted at executed in parallel in graphic process unit.When research object can show abundant data parallelism, we just can consider workload partition to become much non-interfering detached process, and these processes are carried out simultaneously thus increased work efficiency, shorten man-hour.In CUDA, the concept relevant to said process is above thread, and thread is responsible for the process of independent a certain item process, and task can be divided into how many processes, just has how many threads corresponding with it.According to the actual demand of problem, thread can be organized into one dimension, two dimension or three-dimensional thread block, and thread block can be organized into the thread grid of one dimension or two dimension.Once thread is organized into orderly structure, so also just provides the mechanism distinguishing thread, thus different work can be distributed to different threads by thread number in a program.
Storage space and the Installed System Memory of modern GPU are separate, so all needed data to transfer to video memory from Installed System Memory before carrying out any calculating with GPU.Access efficiency due to video memory depends on the mode that video memory is accessed significantly, when our access be continuous print a slice data in video memory time, the peak bandwidth of video memory access can be reached, so we need the standardization as far as possible ensureing video memory access when programming.
CUDA paralleling tactic of the present invention has following characteristics specifically:
1), thread structure aspect, thread block is divided into one-dimentional structure, and thread grid is divided into a peacekeeping two-dimensional structure respectively under two and three dimensions condition, and each thread is responsible for the calculating of a net point specially.
2), data structure aspect, adopt one-dimension array storage and distribution function and macroscopic physical quantity, the distribution function along different directions is stored by different arrays.
3), in transition process in order to avoid graphic process unit video memory access non-alignment behavior, utilize shared storage that transition process is divided into two steps, first step distribution function will utilize shared storage along the migration of direction, thread block place, and distribution function edge is moved perpendicular to direction, thread block place by video memory by second step again.Because shared storage size is limited, so need extra kernel function to exchange the distribution function exceeding thread block border in first step migration.
4), under three-dimensional condition, the topological relation storage policy of structure surface triangles grid is: provide all Triangular patch numberings of this node as one of summit according to grid node.Embodiment is in a program definition structure body array, is used for preserving the triangle number information corresponding to node.
Compared with prior art, the present invention has following advantage and beneficial effect:
1, the present invention can process the structure of arbitrary shape, and do not need reconstruct bottoms stream grid in computation process, counting yield is high.
2, in the present invention, structure and fluid interaction implementation procedure are simply direct, and need not arrange boundary condition at interface place, the globality of flow field calculation is better.
3, the Lattice Boltzmann Method algorithm that the present invention is used is simple, can well simulate NS equation when close can not pressure with certain precision.
4, traditional method for numerical simulation energy that needs to cost a lot of money goes to separate Poisson equation and just can obtain pressure, and the pressure state equation in Lattice Boltzmann Method is tried to achieve, more directly and convenient.
5, the present invention has very high concurrency, its evolution mainly local computing that synchronously performs of some classes, and these computings all can show and carry out, and it can directly be realized on parallel machine, and the communication industry between multiprocessing is very easily optimized.Therefore the present invention is less by the restriction of computer capacity and speed, can simulate fairly large high-order flow field.
6, algorithm stability of the present invention is better, to the less-restrictive of structure physical parameter span, is suitable for simulating practical problems.
Accompanying drawing explanation
Fig. 1 is the parametrization method for expressing of structure grid of the invention process.Triangular element when Fig. 1 (a) is structure beinthebalancestate, Fig. 1 (b) is the triangular element after structure distortion, and Fig. 1 (c) utilizes translation to make the above two certain situation be located on the same line.Namely the stress of structure solve by the displacement of distortion front-rear triangular shape unit corresponding vertex.
Fig. 2 is the film center pressure change procedure curve of embodiment 1 Elastic film when reverting to circular state from oval state.
Fig. 3 is the time-varying process that embodiment 2 Elastic film fixes 2 a, b distance thin film center length when petal state reverts to circular state;
Fig. 4 is the time-varying process of round and elastic film spheroid central authorities' pressure and spheroid volume when stretching recovering state is nature circular state outward from entirety in embodiment 3;
The time-varying process of Fig. 5 is embodiment 4 Elastic film when being spheroidal state from spheroid recovering state semi-major axis;
Fig. 6 be in embodiment 5 spheroid elastic film from entirety outward stretching recovering state be nature spheroidal state process, balloon is provided with a cut, in motion process after balloon breaks, the ordinate time-varying process curve of a, b, c that spheroid is arranged 3.
Fig. 7 inflates in embodiment 6 in the spheroid elastic film of initial equilibrium state, make it expand, and in expansion process, balloon is provided with a cut, the time-varying process of a, b, d of structurally arranging 3 distance initial equilibrium state spheroid thin film center point length obtained and the time-varying process of the fluid velocity size at film cut center.
Embodiment
Below by embodiment, illustrate outstanding feature of the present invention and marked improvement further, be only the present invention is described and never limits the present invention.
Step of the present invention is as follows:
1) in professional pre-processing software, set up the immersed boundary build of structure to be measured and internal flow thereof, and divide border grid and read for program;
2) program reading boundary build data, arrange boundary condition and the procedural model parameter of zoning;
3) Finite element arithmetic border is utilized to be applied to acting force on fluid according to border current time configuration and reference configuration;
4) acting force on border is diffused to peripheral fluid via Dirac function;
5) Navier Stokes equation of external force term is utilized Lattice Boltzmann Method to solve to carry;
6) fluid velocity is interpolated into via Dirac function translational speed border obtaining border equally, and then upgrades boundary position;
7) step 3-6 is repeated, until reach calculating terminal.
Described professional pre-processing software is Gambit or ICEM or ProE.
In described step 3:
(1) when immersed boundary build is two dimension, adopt one dimension wire grid discrete topology body, consider that structure opposing stretches and bending ability simultaneously, be defined in tension on node and resistance to bending density is calculated as follows respectively:
( F s ) l = K s ( &Delta;&alpha; l ) 2 &Sigma; m = 1 n f - 1 ( | X m - 1 - X m | - &Delta;&alpha; l ) X m + 1 - X m | X m + 1 - X m | ( &delta; m l - &delta; m + 1 , l ) .
( F b ) l = K b ( &Delta;&alpha; l ) 4 &Sigma; m = 2 n f - 1 ( X m + 1 + X m - 1 - 2 X m ) ( 2 &delta; m l - &delta; m + 1 , l - &delta; m - 1 , l ) &CenterDot;
(F in above formula s) l(F b) lrepresent respectively to be defined in and be numbered tension on l node and unbending lines of force density, K sand K bbe respectively tensile index and bending stiffness, Δ α lfor the former length of the node of numbering l, X m+1, X m-1and X mbe respectively the node coordinate of numbering m+1, m-1 and m, and δ mlfor Kronecker symbol, as m=l, its value is 1, and in all the other situations, value is 0; n ffor being used for total nodes of discrete topology body;
(2) when immersed boundary is three-dimensional, destructuring triangular mesh discrete topology body is adopted.Construction is numbered the acting force density F on m node mcomputing formula as follows:
F m = - &part; W ( X m ) &part; X m
In above formula: W is the gross energy of structure, for partial differential symbol, X mfor the coordinate of node m; W=∫ w sdA, w sfor drawing of structure can density, and dA is bin area, wherein E is elastic modulus, I 1and I 2be respectively the first and second strain invariants.Can prove that strain invariant can be calculated as follows:
&lambda; 1 2 + &lambda; 2 2 = a 2 + b 2 + c 2 , &lambda; 1 2 &lambda; 2 2 = a 2 c 2
Wherein λ 1and λ 2be the draw ratio along a pair vertical direction in normal plane respectively, and the calculating formula of a, b, c is: a = l l 0 ,
In described step 4 and step 6, acting force diffusion equation is:
f ( x , t ) = &Sigma; m F m &delta; ( x - X m ) &Delta;s k
The acting force density that f (x, t) in above formula is subject to for t point x place fluid, respectively for two and three dimensions condition, Δ s kbe defined in be numbered arc length on the structure node of k and area respectively, and δ (x-X m) be Dirac function, generally take following concrete form:
&delta; ( x - X m ) = 1 8 ( 3 - 2 | x - X m | + 1 + 4 | x - X m | - 4 ( x - X m ) 2 ) , 0 &le; | x - X m | < 1 1 8 ( 5 - 2 | x - X m | - - 7 + 12 | x - X m | - 4 ( x - X m ) 2 ) , 1 &le; | x - X m | < 2 , 0 , | x - X m | &GreaterEqual; 2.
In order to obtain the change procedure of structure shape, we need the configuration upgrading structure according to the speed of structure net point, and under known flow field velocity distribution occasion, structure speed will utilize Dirac function by obtaining from flow field interpolation equally:
dX m d t = U m = &Sigma; x u ( x , t ) &delta; ( x - X m ) &Delta; h
U in above formula mfor the speed of structure net point, u (x, t) is the speed of t point x place fluid, and Δ h is mesh spacing.
In described step 5, Lattice Boltzmann equation is:
g &alpha; ( x + &xi; &alpha; &delta; t , t + &delta; t ) - g &alpha; ( x , t ) = - 1 &tau; ( g &alpha; ( x , t ) - g &alpha; e q ( x , t ) ) + ( 1 - 1 2 &tau; ) { 3 &lsqb; &xi; &alpha; - u ( x , t ) &rsqb; + 9 &lsqb; &xi; &alpha; &CenterDot; u ( x , t ) &CenterDot; &xi; &alpha; &rsqb; } &CenterDot; f ( x , t ) ,
In formula, g α(x, t) represents that t x place is along discrete velocity reversal ξ αdistribution function, and g α(x+ ξ αδ t, t+ δ t) be then t+ δ tmoment x+ ξ αδ tplace is along discrete velocity reversal ξ αdistribution function. that t x place is along discrete velocity reversal ξ αequilibrium distribution function.τ is nondimensional slack time, relevant with intermolecular viscosity coefficient.δ tfor time step.
Embodiment 1
Experimental subjects is the film center pressure change procedure of elastic film when reverting to circular state from oval state;
(1) zoning is chosen for the square that the length of side is 1.0m, discrete be 200 × 200 orthogonal cartesian grid.Structure is that semi-major axis is respectively r a=0.75m and r bthe ellipse of=0.5m.The circle of the equilibrium state of structure to be radius be 0.5149m, the number of nodes of discrete topology is 1200.
(2) structure elastic modulus is set to 0.55Gpa, and fluid density is 1.0g/cm 3, kinematic viscosity is 1.0 × 10 -6m 2/ s, fluid original state is static, and border is first kind pressure boundary condition.
(3) setting exports once result every specific time period, working procedure, till flow field and structure finally settle out, can obtain the interaction process of flow field and structure.
Fig. 2 is the film center pressure change procedure curve of elastic film when reverting to circular state from oval state.As seen from the figure circular membrane to the relaxation of its equilibrium state by the variation of the ripple that causes its central fluid pressure to be decayed gradually with an amplitude, and central pressure convergence one fixed value the most at last;
Embodiment 2
Experimental subjects is the time-varying process that elastic film fixes 2 a, b distance thin film center length when petal state reverts to circular state;
(1) zoning is chosen for the square that the length of side is 2.0m, discrete be 200 × 200 orthogonal cartesian grid.The six lobe films of structure for being described by polar equation ρ=0.5 [1+0.4cos (6 θ)], the number of nodes of discrete topology is 2200.The circle of the equilibrium state of structure to be radius be 0.518m.
(2) structure elastic modulus is set to 0.55Gpa, and fluid density is 1.0g/cm 3, kinematic viscosity is 1.0 × 10 -6m 2/ s, fluid original state is static, and border is first kind pressure boundary condition.
(3) setting exports once result every specific time period, working procedure, till flow field and structure finally settle out, can obtain the interaction process of flow field and structure.
Embodiment 3
Experimental subjects is the time-varying process of round and elastic film spheroid central authorities' pressure and spheroid volume when stretching recovering state is nature circular state outward from entirety;
(1) zoning is chosen for the cube that the length of side is 1.0m, discrete be 64 × 64 × 64 orthogonal cartesian grid.In pre-processing software Gambit, set up spheroid build, its radius is 0.2m, and divides gore grid on its surface, exports grid file, reads for master routine.
(2) master routine reads the structure grid file that pre-processing software exports, and structure elastic modulus is set to 0.55Gpa, and fluid density is 1.0g/cm 3, kinematic viscosity is 1.0 × 10 -6m 2/ s, fluid original state is static, and border is first kind pressure boundary condition.
(3) setting exports once result every specific time period, working procedure, till flow field and structure finally settle out, can obtain the interaction process of flow field and structure.
Embodiment 4
The time-varying process of experimental subjects is elastic film when being spheroidal state from spheroid recovering state semi-major axis;
(1) zoning is chosen for the cube that the length of side is 1.0m, discrete be 64 × 64 × 64 orthogonal cartesian grid.In pre-processing software Gambit, set up ellipsoid build, its semi-major axis is respectively r a=0.3m, r b=0.24m, r c=0.18m, and divide gore grid on its surface, export grid file, read for master routine.
(2) master routine reads the structure grid file that pre-processing software exports, and structure elastic modulus is set to 0.15Gpa, and fluid density is 1.0g/cm 3, kinematic viscosity is 1.0 × 10 -6m 2/ s, fluid original state is static, and border is first kind pressure boundary condition.
(3) setting exports once result every specific time period, working procedure, till flow field and structure finally settle out, can obtain the interaction process of flow field and structure.
As seen from the figure, the semi-major axis of spheroid alternately rises and declines, and the amplitude of its fluctuation is also constantly decaying.Because under surface tension effects, any film all will level off to perfectly spherical, so can see the fixed value that semi-major axis is tending towards identical the most at last.
Embodiment 5
Experimental subjects be spheroid elastic film from entirety outward stretching recovering state be nature spheroidal state process; Wherein measuring point c is arranged near film cut, and a point, b point are respectively 2 end points diametrically, and b point is arranged in balloon far right end, and a point is arranged in the low side of balloon.
(1) zoning is chosen for the cube that the length of side is 1.0m, discrete be 200 × 200 × 200 orthogonal cartesian grid.In pre-processing software Gambit, set up the spheroid build that radius is r=0.156m, and divide gore grid on its surface, export grid file, read for master routine.
(2) master routine reads the structure grid file that pre-processing software exports, and structure elastic modulus is set to 0.15Gpa, and fluid density is 1.0g/cm 3, kinematic viscosity is 1.0 × 10 -6m 2/ s, fluid original state is static, and border is first kind pressure boundary condition.Add prestress to film before calculating starts, make the surface tension of film and film inside and outside differential pressure meet laplace's theorem.Open on the top of film the minor break that Radius is 0.034m afterwards, fluid will be gushed out from spout under the effect of film inside and outside differential pressure.
(3) setting exports once result every specific time period, working procedure, till flow field and structure finally settle out, can obtain the interaction process of flow field and structure.
As shown in Figure 6, the motion of balloon different piece is nonsynchronous in fact, and its repercussion effect of part the closer to cut embodies more early, and therefore balloon will be pressed into elliptical shape in the early stage.
Embodiment 6
Experimental subjects is inflate in the spheroid elastic film of initial equilibrium state, make it expand, and in expansion process, balloon is provided with a cut, the time-varying process of the time-varying process of a, b, d that spheroid elastic film is arranged 3 distance initial equilibrium state ball centre length and the fluid velocity size at film cut center, wherein a point is arranged near film cut, and b point is arranged in the far right end of balloon, and d point is arranged near balloon nozzle.
(1) zoning is chosen for the cube that the length of side is 1.0m, discrete be 264 × 264 × 264 orthogonal cartesian grid.In pre-processing software Gambit, set up structural style, structure is the assembly of cylindrical nozzle and spheroid balloon, and wherein nozzle is rigid body, and balloon is fexible film.Wherein the radius of balloon film is 0.24m, and the radius of nozzle cross-section is 0.15m, and long is 0.086m.Utilize Gambit to divide gore grid at body structure surface, export grid file, read for master routine.
(2) master routine reads the structure grid file that pre-processing software exports, and structure elastic modulus is set to 0.15Gpa, and fluid density is 1.0g/cm 3, kinematic viscosity is 1.0 × 10 -6m 2/ s, fluid original state is static, and border is first kind pressure boundary condition.During beginning from nozzle with 0.02m 3the flow of/s injects liquid to balloon, and removes balloon front end one small pieces of material to a certain extent afterwards at ballooning.
(3) setting exports once result every specific time period, working procedure, till flow field and structure finally settle out, can obtain the interaction process of flow field and structure.
As shown in Figure 7, balloon at cut in a flash by back seat process of short duration for experience one, afterwards in order to be drained via cut by balloon interior fluid as early as possible, balloon longitudinally will be drawn as strip, and final balloon is returned to again original equilibrium configuration after inside and outside pressure tends to balance.

Claims (5)

1., through immersed boundary-Lattice Boltzmann fluid structurecoupling analogy method that GPU accelerates, it is characterized in that: step is as follows:
(1) in professional pre-processing software, set up the immersed boundary build of structure to be measured and internal flow thereof, and divide border grid and read for program;
(2) program reading boundary build data, arrange boundary condition and the procedural model parameter of zoning;
(3) Finite element arithmetic border is utilized to be applied to acting force on fluid according to border current time configuration and reference configuration;
(4) acting force on border is diffused to peripheral fluid via Dirac function;
(5) Navier Stokes equation of external force term is utilized Lattice Boltzmann Method to solve to carry;
(6) fluid velocity is interpolated into via Dirac function translational speed border obtaining border equally, and then upgrades boundary position;
(7) step 3-6 is repeated, until reach calculating terminal.
2., as claimed in claim 1 through immersed boundary-Lattice Boltzmann fluid structurecoupling analogy method that GPU accelerates, it is characterized in that: described professional pre-processing software is Gambit or ICEM or ProE.
3., as claimed in claim 1 through immersed boundary-Lattice Boltzmann fluid structurecoupling analogy method that GPU accelerates, it is characterized in that: in described step 3:
(1) when immersed boundary build is two dimension, adopt one dimension wire grid discrete topology body, consider that structure opposing stretches and bending ability simultaneously, be defined in tension on node and resistance to bending density is calculated as follows respectively:
( F s ) l = K s ( &Delta;&alpha; l ) 2 &Sigma; m = 1 n f - 1 ( | X m + 1 - X m | - &Delta;&alpha; l ) X m + 1 - X m | X m + 1 - X m | ( &delta; m l - &delta; m + 1 , l ) . ( F b ) l = K b ( &Delta;&alpha; l ) 2 &Sigma; m = 2 n f - 1 ( X m + 1 + X m - 1 - 2 X m ) ( 2 &delta; m l - &delta; m + 1 , l - &delta; m - 1 , l ) .
(F in above formula s) l(F b) lrepresent respectively to be defined in and be numbered tension on l node and unbending lines of force density; K sand K bbe respectively tensile index and bending stiffness; Δ α lfor the original arc length of the node of numbering l; X m+1, X m-1and X mbe respectively the node coordinate of numbering m+1, m-1 and m; δ mlfor Kronecker symbol, as m=l, its value is 1, and in all the other situations, value is 0; n ffor being used for total nodes of discrete topology body;
(2) when immersed boundary build is three-dimensional, destructuring triangular mesh discrete topology body is adopted,
Construction is numbered the acting force density F on m node mcomputing formula as follows:
F m = - &part; W ( X m ) &part; X m . ;
Wherein: W is the gross energy of structure, for partial differential symbol, X mfor the coordinate of node m; The calculating formula of structure gross energy is:
W=∫w sdA
DA in formula is bin area, and w sfor drawing of structure can density, its calculating formula is:
wherein E is elastic modulus, I 1and I 2be respectively the first and second strain invariants, can prove that strain invariant can be calculated as follows:
&lambda; 1 2 + &lambda; 2 2 = a 2 + b 2 + c 2 , &lambda; 1 2 &lambda; 2 2 = a 2 c 2
Wherein λ 1and λ 2be the draw ratio along a pair vertical direction in normal plane, and the calculating formula of a, b, c is:
In above formula, geometric parameter is defined as follows: after structure reference configuration and distortion, configuration chooses two pieces of corresponding Triangular patch, in above-mentioned triangle, choose arbitrarily two limits respectively, on reference configuration, its length of side is respectively l 0with l ' 0, and after deformation on configuration its length of side be respectively l and l ', with be respectively the angle of above-mentioned two limits after reference configuration and distortion on configuration.
4. as claimed in claim 1 through immersed boundary-Lattice Boltzmann fluid structurecoupling analogy method that GPU accelerates, it is characterized in that: the acting force diffusion equation in described step 4 and step 6 is:
f ( x , t ) = &Sigma; m F m &delta; ( x - X m ) &Delta;s k
The acting force density that f (x, t) in above formula is subject to for t point x place fluid, F mfor being numbered the acting force density on m node, respectively for two and three dimensions condition, Δ s kbe defined in be numbered arc length on the structure node of k and area respectively, and δ (x-X m) be Dirac function, generally take following concrete form:
&delta; ( x - X m ) = 1 8 ( 3 - 2 | x - X m | + 1 + 4 | x - X m | - 4 ( x - X m ) 2 ) , 0 &le; | x - X m | < 1 1 8 ( 5 - 2 | x - X m | - - 7 + 12 | x - X m | - 4 ( x - X m ) 2 ) , 1 &le; | x - X m | < 2 , 0 , | x - X m | &GreaterEqual; 2.
In order to obtain the change procedure of structure shape, we need the configuration upgrading structure according to the speed of structure net point, and under known flow field velocity distribution occasion, structure speed will utilize Dirac function by obtaining from flow field interpolation equally:
dX m d t = U m = &Sigma; x u ( x , t ) &delta; ( x - X m ) &Delta; h
X in above formula mand U mbe respectively coordinate and the speed of structure net point, u (x, t) is the speed of t point x place fluid, and Δ h is mesh spacing.
5., as claimed in claim 1 through immersed boundary-Lattice Boltzmann fluid structurecoupling analogy method that GPU accelerates, it is characterized in that: in described step 5, Lattice Boltzmann equation is:
g &alpha; ( x + &xi; &alpha; &delta; t , t + &delta; t ) - g &alpha; ( x , t ) - 1 &tau; ( g &alpha; ( x , t ) - g &alpha; e q ( x , t ) ) + ( 1 - 1 2 &tau; ) { 3 &lsqb; &xi; &alpha; - u ( x , t ) &rsqb; + 9 &lsqb; &xi; &alpha; &CenterDot; u ( x , t ) &rsqb; &CenterDot; &xi; &alpha; } &CenterDot; f ( x , t ) ,
In formula, g α(x, t) represents that t x place is along discrete velocity reversal ξ αdistribution function, and g α(x+ ξ αδ t, t+ δ t) be then t+ δ tmoment x+ ξ αδ tplace is along discrete velocity reversal ξ αdistribution function, that t x place is along discrete velocity reversal ξ αequilibrium distribution function, τ is nondimensional slack time, relevant with intermolecular viscosity coefficient, δ tfor time step.
CN201510355061.4A 2015-06-24 2015-06-24 A kind of immersed boundary Lattice Boltzmann fluid structurecoupling analogy method accelerated through GPU Expired - Fee Related CN104866695B (en)

Priority Applications (1)

Application Number Priority Date Filing Date Title
CN201510355061.4A CN104866695B (en) 2015-06-24 2015-06-24 A kind of immersed boundary Lattice Boltzmann fluid structurecoupling analogy method accelerated through GPU

Applications Claiming Priority (1)

Application Number Priority Date Filing Date Title
CN201510355061.4A CN104866695B (en) 2015-06-24 2015-06-24 A kind of immersed boundary Lattice Boltzmann fluid structurecoupling analogy method accelerated through GPU

Publications (2)

Publication Number Publication Date
CN104866695A true CN104866695A (en) 2015-08-26
CN104866695B CN104866695B (en) 2017-10-24

Family

ID=53912520

Family Applications (1)

Application Number Title Priority Date Filing Date
CN201510355061.4A Expired - Fee Related CN104866695B (en) 2015-06-24 2015-06-24 A kind of immersed boundary Lattice Boltzmann fluid structurecoupling analogy method accelerated through GPU

Country Status (1)

Country Link
CN (1) CN104866695B (en)

Cited By (8)

* Cited by examiner, † Cited by third party
Publication number Priority date Publication date Assignee Title
CN107403060A (en) * 2017-06-20 2017-11-28 四川省人民医院 A kind of heart bicuspid valve flow field domain method for numerical simulation
CN108304633A (en) * 2018-01-22 2018-07-20 武汉大学 Hydraulic Transient method for numerical simulation
CN108345964A (en) * 2018-02-10 2018-07-31 北京师范大学 A kind of water quality prediction method and system based on water quality model
CN108446422A (en) * 2018-01-29 2018-08-24 广东工业大学 A kind of multi-scale coupling emulation mode towards complicated micro-fluidic chip
CN111209657A (en) * 2019-12-30 2020-05-29 南京航空航天大学 Solid deformation interface calculation method considering liquid surface tension
CN111339714A (en) * 2020-02-17 2020-06-26 珠江水利委员会珠江水利科学研究院 Multi-scale hydrodynamic coupling method based on FVCOM and OpenFOAM models
CN112156467A (en) * 2020-10-15 2021-01-01 网易(杭州)网络有限公司 Control method and system of virtual camera, storage medium and terminal equipment
CN115526091A (en) * 2022-11-22 2022-12-27 中国人民解放军国防科技大学 Separated coupling numerical simulation method and device for multi-physical-field application

Citations (3)

* Cited by examiner, † Cited by third party
Publication number Priority date Publication date Assignee Title
JP2003132108A (en) * 2001-10-29 2003-05-09 Matsushita Electric Ind Co Ltd Simulation method of system design and its device
CN102681972A (en) * 2012-04-28 2012-09-19 浪潮电子信息产业股份有限公司 Method for accelerating lattice-Boltzmann by utilizing graphic processing units (GPUs)
CN103425833A (en) * 2013-08-07 2013-12-04 湖南大学 Implement method of parallel fluid calculation based on entropy lattice Boltzmann model

Patent Citations (3)

* Cited by examiner, † Cited by third party
Publication number Priority date Publication date Assignee Title
JP2003132108A (en) * 2001-10-29 2003-05-09 Matsushita Electric Ind Co Ltd Simulation method of system design and its device
CN102681972A (en) * 2012-04-28 2012-09-19 浪潮电子信息产业股份有限公司 Method for accelerating lattice-Boltzmann by utilizing graphic processing units (GPUs)
CN103425833A (en) * 2013-08-07 2013-12-04 湖南大学 Implement method of parallel fluid calculation based on entropy lattice Boltzmann model

Non-Patent Citations (1)

* Cited by examiner, † Cited by third party
Title
李秀文: ""用格子Boltzmann方法模拟电磁力作用下的流动问题"", 《中国博士学位论文全文数据库 基础科学辑》 *

Cited By (12)

* Cited by examiner, † Cited by third party
Publication number Priority date Publication date Assignee Title
CN107403060A (en) * 2017-06-20 2017-11-28 四川省人民医院 A kind of heart bicuspid valve flow field domain method for numerical simulation
CN108304633A (en) * 2018-01-22 2018-07-20 武汉大学 Hydraulic Transient method for numerical simulation
CN108446422A (en) * 2018-01-29 2018-08-24 广东工业大学 A kind of multi-scale coupling emulation mode towards complicated micro-fluidic chip
CN108446422B (en) * 2018-01-29 2021-09-07 广东工业大学 Multi-scale coupling simulation method for complex microfluidic chip
CN108345964A (en) * 2018-02-10 2018-07-31 北京师范大学 A kind of water quality prediction method and system based on water quality model
CN108345964B (en) * 2018-02-10 2021-09-21 北京师范大学 Water quality prediction method and system based on water quality model
CN111209657A (en) * 2019-12-30 2020-05-29 南京航空航天大学 Solid deformation interface calculation method considering liquid surface tension
CN111209657B (en) * 2019-12-30 2022-04-22 南京航空航天大学 Solid deformation interface calculation method considering liquid surface tension
CN111339714A (en) * 2020-02-17 2020-06-26 珠江水利委员会珠江水利科学研究院 Multi-scale hydrodynamic coupling method based on FVCOM and OpenFOAM models
CN111339714B (en) * 2020-02-17 2021-10-26 珠江水利委员会珠江水利科学研究院 Multi-scale hydrodynamic coupling method based on FVCOM and OpenFOAM models
CN112156467A (en) * 2020-10-15 2021-01-01 网易(杭州)网络有限公司 Control method and system of virtual camera, storage medium and terminal equipment
CN115526091A (en) * 2022-11-22 2022-12-27 中国人民解放军国防科技大学 Separated coupling numerical simulation method and device for multi-physical-field application

Also Published As

Publication number Publication date
CN104866695B (en) 2017-10-24

Similar Documents

Publication Publication Date Title
CN104866695A (en) GPU-accelerated fluid-structure coupling simulation method through immersion boundary and lattice Boltzmann methods
Komatitsch et al. Porting a high-order finite-element earthquake modeling application to NVIDIA graphics cards using CUDA
Allard et al. Implicit FEM solver on GPU for interactive deformation simulation
McIntosh-Smith et al. On the performance portability of structured grid codes on many-core computer architectures
Wu et al. GPU acceleration of FSI simulations by the immersed boundary-lattice Boltzmann coupling scheme
Huang et al. Implementation of multi-GPU based lattice Boltzmann method for flow through porous media
Astorino et al. A modular lattice Boltzmann solver for GPU computing processors
Boroni et al. FULL GPU implementation of lattice-Boltzmann methods with immersed boundary conditions for fast fluid simulations
Meyer et al. Improving Barnes-Hut t-SNE scalability in GPU with efficient memory access strategies
Lou et al. Openacc-based gpu acceleration of ap-multigrid discontinuous galerkin method for compressible flows on 3d unstructured grids
Xia et al. OpenACC-based GPU acceleration of a 3-D unstructured discontinuous galerkin method
Zimmerman et al. High-order spectral difference: verification and acceleration using GPU computing
Kasmi et al. Performance evaluation of sparse matrix-vector product (SpMV) computation on GPU architecture
He et al. A GPU-accelerated TLSPH algorithm for 3D geometrical nonlinear structural analysis
Huang et al. Parallel Performance and Optimization of the Lattice Boltzmann Method Software Palabos Using CUDA
Sikdokur et al. Image Classification on Accelerated Neural Networks
Kumar et al. A parallel 3D unsteady incompressible flow solver on VPP700
Wiens An efficient parallel immersed boundary algorithm, with application to the suspension of flexible fibers
Ma et al. Parallelization of an unsteady ALE solver with deforming mesh using OpenACC
Januszewski Transport in complex systems: a lattice Boltzmann approach
Gurgel et al. Parallel implementation of feedforward neural networks on gpus
Rathi Optimizing sorting algorithms using ubiquitous multi-core massively parallel GPGPU processors
Chelliah The ntnu hpc snow simulator on the fermi gpu
Itu et al. GPU accelerated simulation of the human arterial circulation
Röhm Lattice boltzmann simulations on gpus

Legal Events

Date Code Title Description
C06 Publication
PB01 Publication
EXSB Decision made by sipo to initiate substantive examination
SE01 Entry into force of request for substantive examination
GR01 Patent grant
GR01 Patent grant
CF01 Termination of patent right due to non-payment of annual fee
CF01 Termination of patent right due to non-payment of annual fee

Granted publication date: 20171024

Termination date: 20200624