Computational Reality XV. Rotary viscometer. Determining material coefficients I. B. Emek Abali, Wilhelm LKM - TU Berlin

Size: px
Start display at page:

Download "Computational Reality XV. Rotary viscometer. Determining material coefficients I. B. Emek Abali, Wilhelm LKM - TU Berlin"

Transcription

1 Computational Reality XV Rotary viscometer Determining material coefficients I B. Emek Abali, Wilhelm LKM - TU Berlin Abstract A non-newtonian fluid can be modeled with three-parameter-constitutive relations. We have shown one model already in Comp.Real.VII, the arctan-model of Ziegler. Another model is the Herschel-Bulkley model and probably the most famous model among the rheological models for non-newtonian fluids. We will first give the equations and their coefficients physical meaning and then try to answer this important question: How can we determine the material coefficients in these models via experiments in a rotational viscometer? 1 Experimental setup and constitutive relations A three-parameter material model comprises three material dependent coefficients. These material coefficients change the response of the matter against the forces applied on the surface or volumetrically. In a viscometer the fluid is driven by applied forces on the surface and any volumetric forces, like gravitation or electromagnetic field, are ignored. In Fig. 1 the cone-plate viscometer used is shown. The force is brought as a torque on the shaft and the velocity gradient is measured optically again on the shaft. Since the force and the response is measured, we can determine the coefficients in the material model inversely. This is the parameter fit (regression analysis) problem where we are going to implement the knowledge from Comp.Real.XII & XIII. The material model for a fluid gives the relation between Cauchy stress tensor σ ij and (symmetric) velocitygradients d ij : σ ij = µd ij, d ij = v (i = 1 ( vi + v ) j. (1) x j) 2 x j x i Figure 1: Rotational cone-plate viscometer, on left without and right with the toothpaste 1

2 That relation looks similar to the Navier-Stokes as modeled in Comp.Real.VII but this time the pressure does not play a role, the motion is driven solely by the torque. We could easily left the pressure part pδ ij in the stress definition, however, by giving the values of the pressure on the boundaries like the outer pressure being 1 bar = 10 5 Pa in every particle of the fluid the same p = 10 5 Pa would be computed. Therefore it is not necessary and is always omitted. The machine can be controlled over stress input, this follows on an inductive rotor by controlling the input voltage and thus creating a magnetic field which creates a torque on the shaft. This force creates a stress and the stress is computed by the machine via given geometric dimensions of the sample. We can extract a surface and use a coordinate system x in horizontal and y in vertical on the outer shell. In Fig. 2 the machine and the outer shell is drawn as a sketch. Only a small part on the outer shell is chosen as the region and equipped with the Cartesian coordinate system, x on the horizontal and y on vertical. This means that we measure σ 12 and d 12 in the experiments. In the mid of 20 s Herschel and Bulkley proposed an apparent viscosity depending on the aforementioned component, d 12, given by a power law: σ 12 = µ(d 12 ) n + τ. (2) They simply have observed that type of a behavior in non-newtonian materials. The quantity τ mimics a yield stress, though the machine applies some torque there are no motion to be recorded. After this limit (to start yielding) stress τ has been reached, velocity gradient d 12 starts to build up exponentally. We need to transfer this equation to multiaxial tensor notation as follows: σ ij = (µ (II d) n/2 IId + τ IId )d ij, II d = 1 2 d ijd ij, (3) while its reduction to one-dimension is identical with Eq. (2) in case of a shear deformation in two-dimensions: ( ) 0 d12 d ij = II d 12 0 d = (d 12 ) 2, ( ) 0 σ12 = (µ (d 12) n + τ ) ( ) 0 d12, σ 12 0 d 12 d 12 d 12 0 ( ) ( ) 0 σ12 0 µ(d = 12 ) n + τ σ 12 0 µ(d 12 ) n. (4) + τ 0 Another three-parameter model is from the mid of 70 s, probably not thought for the first time, however, motivated from a theoretical point of view by Ziegler: σ ij = µ d ij + 2τ ( π II ) d arctan II d n d ij. (5) Its reduction to one-dimensional space since our experiment gives us only σ 12 and d 12, reads: σ 12 = µ d τ π arctan ( d12 n ) sign(d 12 ) = µ d τ π arctan ( d12 n ). (6) This model basically does the same as above, however, by using the sigmoid function 1 it is more smooth. Though it is not immediately obvious, both relations will turn into the Bingham material model introduced in start of 20 s reaching the limit case: n = 1, n = µ = µ, τ = τ, σ ij = µd ij + τ IId d ij. (7) In this representation the yield shear stress τ and viscosity µ are the physically meaningful rheology constants. In the aforementioned models it is neither easy nor necessary to find out the physical meaning of the material coefficients. The question is now, how can we fit the curve of the experimental data with these three parameter? 1 arctan() is a sigmoid function, cf. Comp.Real.XIV and try to plot the arctan() to see it shapes like S 2

3 Figure 2: Drawing of the experimental setup and the area for the 2D flow simulation 2 Inverse analysis Instead of calculating the response of the material by known parameters, here we measure the response and by using it obtain the parameters inversely. It is possible to find the three parameters µ, n, τ in the first model (Eq. (2)) or µ, n, τ in the second model (Eq. (6)) by measuring three different stress, velocity-gradient {σ 12, d 12 } states and then by solving the inverse problem directly. We place the matter between the cone and plate, start to increase the torque and record the d 12 many times, much more than just three! Mathematically only three would be sufficient, but we have got hundreds of data and naturally want to find the optimum fit. Hence, the inverse problem has many solutions, each of every one fits at least to three different states. The optimum solution can be determined in terms of an error prediction, i.e., cost, which is minimized numerically to obtain the best parameters. We programmed and solved in SciPy by using the Levenberg-Marquardt non-linear least squares error algorithm for a measurement using Eqs. (2) and (6). Unfortunately the optimization is non-linear since the parameters occur in multiplications. It is possible to solve after a Newton-Raphson linearization, alike the one which we use for FEM. The only difference is in the algorithm. For FEM we linearize on the partial differential equations level, so that the incremental part (we name it in the code as Gain) is found symbolically. In the optimization, however, the algorithm uses a numeric differentiation (it is already programmed in the scipy.optimization package) for it. In FEM we do not care much about the starting condition for the increments since we solve it transient, the solution from the last time step is the (correct) starting condition. Here by parameter fit, the choice is crucial and we have no idea how to find it! Therefore in a parameter-range, we randomly select starting parameters and compare the cost. Additionally, we compute the parameters by using the part of the data, known as training set and the cost with a different part of the data, known as test set. Having different training and test sets is known as generalization performance in graphical models. First we set the minimum cost artificially high and select a set of parameters to determine the cost. We save it if it is less than the artificially high set cost. Secondly, we select another set of parameters and solve and compare. If the cost is reduced than the minimum cost is updated. This procedure is looped subsequently, in the code shown below times. This is known as Monte Carlo method since the starting parameters are chosen randomly. The best solution is never guaranteed but the possibility of getting the optimum solution raises upon every new trial. At the end of the optimization the following results are obtained: σ 12 = µ(d 12 ) n + τ µ = Pa s, n = 0.599, τ = Pa, (8) σ ij = µ d τ π arctan ( d12 n ) µ = Pa s, n = 0.267, τ = Pa. (9) Here we clearly see that the physical relevance of the coefficients is rather not to question. They are just some values to model the material response. Though they look alike in the models, different models yield to quite different values. 3

4 Figure 3: Experiment, fit curve and simulation, Herschel-Bulkley on left and Ziegler on right 3 Variational form The numerical solution is achieved with the variational form exactly as been done in Comp.Real.VII. For an open system Ω filled with the fluid the balance of mass and linear momentum have to be satisfied: dρ dt + ρ v i x i = 0, ρ dv i dt σ ji x j = ρf i. (10) We contract them with the test functions from the same rank, i.e., the balance of mass with a scalar function and the balance of momentum with a tensor of rank one function. Since we do not compute the pressure, we use the mass balance to compute the mass density. We start with resting fluid and assume the mass is distributed equivalently, i.e., homogeneous. Though we do not show in here, the mass density stays quite homogeneous in the whole simulation. This is indeed the incompressibility of the fluid which is also an experimentally known fact. The form to be minimized reads after finding the residuals and contracting with appropriate test functions in the so-called Hilbert configuration space: ( dρ dt + ρ v ) (( i δρ + ρ dv i x i dt σ ) ) ji δv i dx = 0. (11) x j We discretize in time with a finite difference method: Ω d ( ) = ( ) + dx i ( ) ( ) ( )0 ( ) = dt t dt x i t t 0 + v i, dt = t t 0, v i = dx i x i dt, (12) and in space with a finite element method: ( ρ ρ 0 t t 0 δρ + v ρ i δρ + ρ v i δρ + ρ v i vi 0 x i x i t t 0 δv i+ elements Ω ele. ) v i δv i +ρv j δv i + σ ji dx σ ji δv i n j ds, (13) x j x j Ω where integration by parts have been used to get only first-order differentials in velocities v i. This form is nonlinear in velocities, hence the solution is incremental by using the abstract class NonlinearProblem of FEniCS project. All the boundaries except the top are set to traction-free, so that the last term vanishes. The rectangular cavity with periodic boundaries on right and left boundaries is mathematically the same as the outer cylindrical shell in Fig. 2. The periodic boundaries map the nodes on the right to the left such as the solution is the same on the right and left boundary, in every time. The rectangular cavity is driven on top with a linearly 4

5 raising traction and hold on bottom. On top the velocity gradient is computed and written out as a list. We have in Fig. 3 black plus symbols for the experimental data, red circle annotated line as the one from the one-dimensional parameter fit and blue lines with squares from the simulation. C o m p u t a t i o n a l r e a l i t y XIV, i n v e r s e a n a l y s i s a n d o b t a i n i n g t h e o p t i m u m p a r a m e t e r s f o r a non l i n e a r v i s c o u s f l u i d, w h i c h i s s i m u l a t e d a s d r i v e n l i d c a v i t y w i t h p e r i o d i c b o u n d a r i e s a u t h o r = B. Emek Abali ( abali@tu b e r l i n. de ) d a t e = c o p y r i g h t = Copyright (C) 2012, B. Emek Abali l i c e n s e = GNU GPL Version 3 or any l a t e r v e r s i o n # # r u n l i k e : p y t h o n f i t c o m p u t e p l o t. py # f r o m s h e l l a f t e r i n s t a l l i n g FEniCS a n d S c i P y ( m a t p l o t l i b ), s u c h t h a t : #s u d o a p t g e t i n s t a l l p y t h o n s c i p y p y t h o n m a t p l o t l i b #u n d e r U b u n t u # p l e a s e r e f e r t o : # www. f e n i c s p r o j e c t. o r g # www. s c i p y. o r g # from d o l f i n import import numpy # r e a d i n g t h e d a t a f r o m e x p e r i m e n t # t h e d a t a S i g n a l d a t a. py i s t o b e f o u n d u n d e r Comp. R e a l. w e b s i t e s h e a r s t r e s s, shear ratenew, s h e a r r a t e, v i s c o s i t y, t, temperature, n o r m a l s t r e s s = \ numpy. l o a d t x t ( S i g n a l d a t a. py, d e l i m i t e r=,, unpack=true ) import s c i p y import s c i p y. i n t e r p o l a t e import s c i p y. optimize s t r e s s = s c i p y. i n t e r p o l a t e. i n t e r p 1 d ( s h e a r r a t e, s h e a r s t r e s s, b o u n d s e r r o r=false, \ f i l l v a l u e =0.0) # p a r a m e t e r i d e n t i f i c a t i o n o f t h e f i t e q u a t i o n def f i t 2 f i n d p a r a m ( c o n s t i t u t i v e m o d e l ) : # m o d e l i n 1D t o b e u s e d def f i t ( d12,mu, n, tau ) : i f c o n s t i t u t i v e m o d e l== h e r s c h e l b u l k l e y : sigma = mu d12 n + tau i f c o n s t i t u t i v e m o d e l== arctan : sigma = mu d12 + \ 2. tau /numpy. p i numpy. arctan ( d12/n ) return sigma def r e s i d u a l ( param, h, G, h y p o t h e s i s ) : return h (G) h y p o t h e s i s (G, param ) def c o s t ( param, h, G, h y p o t h e s i s ) : return numpy. sum( r e s i d u a l ( param, h, G, h y p o t h e s i s ) 2, a x i s =0) # n u m b e r o f e x p e r i m e n t s m=s h e a r r a t e. s i z e # n u m b e r o f t h e m t o b e t a k e n f o r f i t m=round (m 0. 7 ) # i n i t i a l g u e s s #a s a r a n g e, p a r a m = [ mu, n, t a u ] d u e t o t h e d e f f i t ( d12, mu, n, t a u ) prange =[numpy. arange ( 0, , 1 ), numpy. arange ( 0, 1, 0. 1 ), numpy. arange ( 0, 1 0, 0. 5 ) ] numpy. s e t e r r ( a l l= i g n o r e ) # f i t t i n g o n a r a n d o m s e t a n d t e s t i n g w i t h a n o t h e r s e t 5

6 montecarlo = 6 n u m b e r o f t r i a l s = 0 e r r o r m i n = 10 e10 penalty = 10 e6 from copy import deepcopy r a t e s=deepcopy ( s h e a r r a t e ) while n u m b e r o f t r i a l s < : i f montecarlo >5: p1 = prange [ 0 ] [ numpy. random. random integers ( 0, l e n ( prange [ 0 ] ) 1 ) ] p2 = prange [ 0 ] [ numpy. random. random integers ( 0, l e n ( prange [ 0 ] ) 1 ) ] p3 = prange [ 0 ] [ numpy. random. random integers ( 0, l e n ( prange [ 0 ] ) 1 ) ] param0 = [ p1, p2, p3 ] montecarlo = 0 numpy. random. s h u f f l e ( r a t e s ) param lsq = s c i p y. optimize. l e a s t s q ( r e s i d u a l, param0, \ a r g s =( s t r e s s, r a t e s [ :m], f i t ) ) param=param lsq [ 0 ] montecarlo +=1 e r r o r=c o s t ( param, s t r e s s, r a t e s [ :m], f i t ) i f param [ 0 ] < 0 : e r r o r += penalty #we f o r c e t p g e t k >0 i f param [ 2 ] < 0 : e r r o r += penalty #we f o r c e t p g e t mu>0 i f e r r o r <e r r o r m i n : chosen param = param e r r o r m i n = e r r o r print parameters :, param, e r r o r on t e s t s e t :, e r r o r, n u m b e r o f t r i a l s n u m b e r o f t r i a l s +=1 return chosen param # p a r a m e t e r i d e n t i f i c a t i o n o f t h e f i t e q u a t i o n # n u m e r i c a l parameters [ form compiler ] [ cpp optimize ]=True parameters [ form compiler ] [ l o g l e v e l ] = ERROR+10 # s o l v e r f o r i n c r e m e n t a l n o n l i n e a r s c h e m e class i t e r a t e ( NonlinearProblem ) : def i n i t ( s e l f, a, L, bc, exter B ) : NonlinearProblem. i n i t ( s e l f ) s e l f. L = L s e l f. a = a s e l f. bc = bc s e l f. e x t e r = exter B def F( s e l f, b, x ) : assemble ( s e l f. L, t e n s o r=b, e x t e r i o r f a c e t d o m a i n s=s e l f. e x t e r ) for c o n d i t i o n in s e l f. bc : c o n d i t i o n. apply (b, x ) def J ( s e l f, A, x ) : assemble ( s e l f. a, t e n s o r=a, e x t e r i o r f a c e t d o m a i n s=s e l f. e x t e r ) for c o n d i t i o n in s e l f. bc : c o n d i t i o n. apply (A) c o m p u t a t i o n # i n i t i a l v a l u e s class i n i t v a l u e s ( Expression ) : def e v a l ( s e l f, vec, x ) : vec [ 0 ] = 0. 0 vec [ 1 ] = 0. 0 vec [ 2 ] = e 6 #g /mm3 def v a l u e s h a p e ( s e l f ) : return ( 3, ) # u n i t s # m a s s i n g # f o r c e i n mun # l e n g t h i n mm 6

7 # t i m e i n s e c # mun / mmˆ 2 = Pa # g e o m e t r y xlength = ylength = 4. 2 mesh=rectangle ( 0., 0., xlength, ylength, 40, 4) # f u n c t i o n a l s p a c e s V e l o c i t y = VectorFunctionSpace ( mesh, CG, 1) Massdensity = FunctionSpace ( mesh, CG, 1) Dim = mesh. topology ( ). dim ( ) space = MixedFunctionSpace ( [ Velocity, Massdensity ] ) # b o u n d a r i e s a n d t h e i r v a l u e s top = compile subdomains ( x [ 1 ] == l e n g t h ) top. l e n g t h = ylength bottom = compile subdomains ( x [ 1 ] == 0. 0 ) subdomains = MeshFunction ( u i n t, mesh, Dim 1) subdomains. s e t a l l ( 0 ) top. mark ( subdomains, 1 ) d r i v e = Expression ( ( amp, 0. 0 ),amp=0.) n u l l = Expression ( ( 0. 0, 0. 0 ) ) class PeriodicBoundary ( SubDomain ) : def i n s i d e ( s e l f, x, on boundary ) : # l e f t s i d e i s x [ 0 ] = x l e n g t h / 2 return x [ 0 ] < +1. e 5 and x [ 0 ] > 1. e 5 and on boundary def map( s e l f, y, x ) : # t h i s maps r i g h t s i d e x [ 0 ] = x l e n g t h t o t h e l e f t x [ 0 ] = y [0] xlength x [ 1 ] = y [ 1 ] bc = [ DirichletBC ( space. sub ( 0 ), n u l l, bottom ), \ PeriodicBC ( space. sub ( 0 ), PeriodicBoundary ( ) ) ] # how and w h e r e t o s a v e def compute ( c o n s t i t u t i v e m o d e l,mu, n, tau ) : pwd = / c a l c u l / t e l c / f i l e v = F i l e (pwd+c o n s t i t u t i v e m o d e l+ v e l o c i t y. pvd ) f i l e r = F i l e (pwd+c o n s t i t u t i v e m o d e l+ massdensity. pvd ) i, j, k, l =i n d i c e s ( 4 ) t, t end = 0., dt = 1 0. # s e t u p t e s t = TestFunction ( space ) dprimary = T rialfunction ( space ) Primary0 = Function ( space ) Primary = Function ( space ) P r i m a r y i n i t = i n i t v a l u e s ( ) Primary0. i n t e r p o l a t e ( P r i m a r y i n i t ) Primary. a s s i g n ( Primary0 ) v0, rho0 = s p l i t ( Primary0 ) v, rho = s p l i t ( Primary ) delv, d e l r h o = s p l i t ( t e s t ) d e l t a = I d e n t i t y (Dim) # m a t e r i a l def d ( v ) : return a s t e n s o r ( 1. 0 / 2. 0 ( v [ i ]. dx ( j )+v [ j ]. dx ( i ) ), ( i, j ) ) I I d = a s t e n s o r ( 1. 0 / 2. 0 d ( v ) [ k, l ] d ( v ) [ k, l ] , ( ) ) i f c o n s t i t u t i v e m o d e l== arctan : def sigma ( v ) : return a s t e n s o r (mu d ( v ) [ i, j ] + 2. tau / p i / I I d 0.5 \ 7

8 atan ( I I d 0.5/ n ) d ( v ) [ i, j ], ( i, j ) ) i f c o n s t i t u t i v e m o d e l== h e r s c h e l b u l k l e y : def sigma ( v ) : return a s t e n s o r (mu I I d ( ( n 1. ) / 2. ) d ( v ) [ i, j ] \ + tau / I I d 0.5 d ( v ) [ i, j ], ( i, j ) ) # v a r i a t i o n a l s t r u c t. Form = ( rho rho0 )/ dt d e l r h o dx\ + v [ i ] rho. dx ( i ) d e l r h o dx\ + rho v [ i ]. dx ( i ) d e l r h o dx\ + rho ( v v0 ) [ i ] / dt delv [ i ] dx \ + rho v [ j ] v [ i ]. dx ( j ) delv [ i ] dx \ + sigma ( v ) [ j, i ] delv [ i ]. dx ( j ) dx \ d r i v e [ i ] delv [ i ] ds ( 1 ) #+ r h o v [ j ] v [ k ]. dx ( k ) w [ j ] dx \ # l i n e a r i z a t i o n Gain = d e r i v a t i v e (Form, Primary, dprimary ) sigma values, v 1 x 2 v a l u e s = [ ], [ ] #t i m e s l i c i n g while t < t end : t = t + dt print time :, t, o f, t end d r i v e. amp = 250.0/ t end t problem = i t e r a t e ( Gain, Form, bc, subdomains ) s o l v e r = NewtonSolver ( l u ) s o l v e r. parameters [ c o n v e r g e n c e c r i t e r i o n ] = i n c r e m e n t a l s o l v e r. parameters [ r e l a t i v e t o l e r a n c e ] = 1. 0 e 1 s o l v e r. s o l v e ( problem, Primary. v e c t o r ( ) ) f i l e v << ( Primary. s p l i t ( ) [ 0 ], t ) f i l e r << ( Primary. s p l i t ( ) [ 1 ], t ) v e l=primary. s p l i t ( deepcopy=true ) [ 0 ] S=p r o j e c t ( sigma ( v e l ), TensorFunctionSpace ( mesh, CG, 1 ) ) velgrad=p r o j e c t ( d ( v e l ), TensorFunctionSpace ( mesh, CG, 1 ) ) P=(xlength, ylength / 2. ) # we m e a s u r e o n t o p s i g 1 2=S (P ) [ 1 ] velgrad12=velgrad (P ) [ 1 ] s i g m a v a l u e s. append ( s i g 1 2 ) v 1 x 2 v a l u e s. append ( velgrad12 ) # u p d a t e Primary0. a s s i g n ( Primary ) # e n d o f w h i l e return v1x2 values, s i g m a v a l u e s # n u m e r i c a l c o m p u t a t i o n # v i s u a l i z a t i o n import m a t p l o t l i b as mpl mpl. use ( Agg ) import m a t p l o t l i b. pyplot as pylab def v i s u a l i z e ( c o n s t i t u t i v e m o d e l, chosen param, f e m s h e a r r a t e, f e m s t r e s s ) : def f i t ( d12,mu, n, tau ) : i f c o n s t i t u t i v e m o d e l== h e r s c h e l b u l k l e y : sigma = mu d12 n + tau i f c o n s t i t u t i v e m o d e l== arctan : sigma = mu d tau /numpy. p i numpy. arctan ( d12/n ) return sigma pylab. c l a ( ) pylab. p l o t ( s h e a r r a t e, s h e a r s t r e s s, c o l o r= black, marker= +, \ m a r k e r s i z e =13, l a b e l= data ) pylab. p l o t ( s h e a r r a t e, f i t ( s h e a r r a t e, chosen param [ 0 ], chosen param [ 1 ], \ chosen param [ 2 ] ), c o l o r= red, marker= o, m a r k e r s i z e =5, l a b e l= f i t ) pylab. p l o t ( f e m s h e a r r a t e, f e m s t r e s s, c o l o r= blue, l i n e s t y l e=, l i n e w i d t h =6,\ l a b e l= s i m u l a t i o n ) pylab. y l a b e l ( s t r e s s $\ sigma {12} $ [ Pa ] ) pylab. x l a b e l ( v e l o c i t y g r a d i e n t $d {12} $ [ 1 / s ] ) 8

9 pylab. t i t l e ( Experiment vs. f i t vs. s i m u l a t i o n ) pylab. legend ( l o c= b e s t ) pylab. g r i d ( True ) return pylab # v i s u a l i z a t i o n # f i t & c o m p u t e & p l o t f i t a = f i t 2 f i n d p a r a m ( arctan ) f e m s h e a r r a t e a, f e m s t r e s s a = compute ( arctan, f i t a [ 0 ], f i t a [ 1 ], f i t a [ 2 ] ) f i g a = v i s u a l i z e ( arctan, f i t a, f e m s h e a r r a t e a, f e m s t r e s s a ) f i g a. s a v e f i g ( f i t a r c t a n. ps ) f i t h b = f i t 2 f i n d p a r a m ( h e r s c h e l b u l k l e y ) fem shearrate hb, f e m s t r e s s h b = compute ( h e r s c h e l b u l k l e y, f i t h b [ 0 ], f i t h b [ 1 ], f i t h b [ 2 ] ) f i g h b = v i s u a l i z e ( h e r s c h e l b u l k l e y, f i t h b, fem shearrate hb, f e m s t r e s s h b ) f i g h b. s a v e f i g ( f i t h e r s c h e l b u l k l e y. ps ) print For arctan model, mu:, f i t a [ 0 ], n :, f i t a [ 1 ], tau :, f i t a [ 2 ] print For H e r s c h e l Bulkley model, mu:, f i t h b [ 0 ], n :, f i t h b [ 1 ], tau :, f i t h b [ 2 ] # e n d o f f i l e 9

Chapter 2: Fluid Dynamics Review

Chapter 2: Fluid Dynamics Review 7 Chapter 2: Fluid Dynamics Review This chapter serves as a short review of basic fluid mechanics. We derive the relevant transport equations (or conservation equations), state Newton s viscosity law leading

More information

Chapter 2. General concepts. 2.1 The Navier-Stokes equations

Chapter 2. General concepts. 2.1 The Navier-Stokes equations Chapter 2 General concepts 2.1 The Navier-Stokes equations The Navier-Stokes equations model the fluid mechanics. This set of differential equations describes the motion of a fluid. In the present work

More information

Chapter 3: Newtonian Fluids

Chapter 3: Newtonian Fluids Chapter 3: Newtonian Fluids CM4650 Michigan Tech Navier-Stokes Equation v vv p t 2 v g 1 Chapter 3: Newtonian Fluid TWO GOALS Derive governing equations (mass and momentum balances Solve governing equations

More information

Computational Fluid Dynamics Prof. Dr. Suman Chakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur

Computational Fluid Dynamics Prof. Dr. Suman Chakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur Computational Fluid Dynamics Prof. Dr. Suman Chakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur Lecture No. # 02 Conservation of Mass and Momentum: Continuity and

More information

Chapter 9: Differential Analysis

Chapter 9: Differential Analysis 9-1 Introduction 9-2 Conservation of Mass 9-3 The Stream Function 9-4 Conservation of Linear Momentum 9-5 Navier Stokes Equation 9-6 Differential Analysis Problems Recall 9-1 Introduction (1) Chap 5: Control

More information

Chapter 9: Differential Analysis of Fluid Flow

Chapter 9: Differential Analysis of Fluid Flow of Fluid Flow Objectives 1. Understand how the differential equations of mass and momentum conservation are derived. 2. Calculate the stream function and pressure field, and plot streamlines for a known

More information

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t)

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t) IV. DIFFERENTIAL RELATIONS FOR A FLUID PARTICLE This chapter presents the development and application of the basic differential equations of fluid motion. Simplifications in the general equations and common

More information

Fundamentals of Fluid Dynamics: Elementary Viscous Flow

Fundamentals of Fluid Dynamics: Elementary Viscous Flow Fundamentals of Fluid Dynamics: Elementary Viscous Flow Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Institute of Fundamental Technological Research

More information

BSL Transport Phenomena 2e Revised: Chapter 2 - Problem 2B.11 Page 1 of 5

BSL Transport Phenomena 2e Revised: Chapter 2 - Problem 2B.11 Page 1 of 5 BS Transport Phenomena 2e Revised: Chapter 2 - Problem 2B11 Page 1 of 5 Problem 2B11 The cone-and-plate viscometer (see Fig 2B11 A cone-and-plate viscometer consists of a flat plate and an inverted cone,

More information

Modelling of dispersed, multicomponent, multiphase flows in resource industries Section 4: Non-Newtonian fluids and rheometry (PART 1)

Modelling of dispersed, multicomponent, multiphase flows in resource industries Section 4: Non-Newtonian fluids and rheometry (PART 1) Modelling of dispersed, multicomponent, multiphase flows in resource industries Section 4: Non-Newtonian fluids and rheometry (PART 1) Globex Julmester 2017 Lecture #3 05 July 2017 Agenda Lecture #3 Section

More information

Exercise: concepts from chapter 10

Exercise: concepts from chapter 10 Reading:, Ch 10 1) The flow of magma with a viscosity as great as 10 10 Pa s, let alone that of rock with a viscosity of 10 20 Pa s, is difficult to comprehend because our common eperience is with s like

More information

Modelling the Rheology of Semi-Concentrated Polymeric Composites

Modelling the Rheology of Semi-Concentrated Polymeric Composites THALES Project No 1188 Modelling the Rheology of Semi-Concentrated Polymeric Composites Research Team Evan Mitsoulis (PI), Professor, NTUA, Greece Costas Papoulias (Research Student), NTUA, Greece Souzanna

More information

Chapter 1. Continuum mechanics review. 1.1 Definitions and nomenclature

Chapter 1. Continuum mechanics review. 1.1 Definitions and nomenclature Chapter 1 Continuum mechanics review We will assume some familiarity with continuum mechanics as discussed in the context of an introductory geodynamics course; a good reference for such problems is Turcotte

More information

Getting started: CFD notation

Getting started: CFD notation PDE of p-th order Getting started: CFD notation f ( u,x, t, u x 1,..., u x n, u, 2 u x 1 x 2,..., p u p ) = 0 scalar unknowns u = u(x, t), x R n, t R, n = 1,2,3 vector unknowns v = v(x, t), v R m, m =

More information

FEniCS Course. Lecture 0: Introduction to FEM. Contributors Anders Logg, Kent-Andre Mardal

FEniCS Course. Lecture 0: Introduction to FEM. Contributors Anders Logg, Kent-Andre Mardal FEniCS Course Lecture 0: Introduction to FEM Contributors Anders Logg, Kent-Andre Mardal 1 / 46 What is FEM? The finite element method is a framework and a recipe for discretization of mathematical problems

More information

Computational Astrophysics

Computational Astrophysics Computational Astrophysics Lecture 1: Introduction to numerical methods Lecture 2:The SPH formulation Lecture 3: Construction of SPH smoothing functions Lecture 4: SPH for general dynamic flow Lecture

More information

Shell Balances in Fluid Mechanics

Shell Balances in Fluid Mechanics Shell Balances in Fluid Mechanics R. Shankar Subramanian Department of Chemical and Biomolecular Engineering Clarkson University When fluid flow occurs in a single direction everywhere in a system, shell

More information

Computer Fluid Dynamics E181107

Computer Fluid Dynamics E181107 Computer Fluid Dynamics E181107 2181106 Transport equations, Navier Stokes equations Remark: foils with black background could be skipped, they are aimed to the more advanced courses Rudolf Žitný, Ústav

More information

Chapter 2: Basic Governing Equations

Chapter 2: Basic Governing Equations -1 Reynolds Transport Theorem (RTT) - Continuity Equation -3 The Linear Momentum Equation -4 The First Law of Thermodynamics -5 General Equation in Conservative Form -6 General Equation in Non-Conservative

More information

Navier-Stokes Equation: Principle of Conservation of Momentum

Navier-Stokes Equation: Principle of Conservation of Momentum Navier-tokes Equation: Principle of Conservation of Momentum R. hankar ubramanian Department of Chemical and Biomolecular Engineering Clarkson University Newton formulated the principle of conservation

More information

Les Houches School of Foam: Rheology of Complex Fluids

Les Houches School of Foam: Rheology of Complex Fluids Les Houches School of Foam: Rheology of Complex Fluids Andrew Belmonte The W. G. Pritchard Laboratories Department of Mathematics, Penn State University 1 Fluid Dynamics (tossing a coin) Les Houches Winter

More information

Quick Recapitulation of Fluid Mechanics

Quick Recapitulation of Fluid Mechanics Quick Recapitulation of Fluid Mechanics Amey Joshi 07-Feb-018 1 Equations of ideal fluids onsider a volume element of a fluid of density ρ. If there are no sources or sinks in, the mass in it will change

More information

Chapter 1. Governing Equations of GFD. 1.1 Mass continuity

Chapter 1. Governing Equations of GFD. 1.1 Mass continuity Chapter 1 Governing Equations of GFD The fluid dynamical governing equations consist of an equation for mass continuity, one for the momentum budget, and one or more additional equations to account for

More information

2. FLUID-FLOW EQUATIONS SPRING 2019

2. FLUID-FLOW EQUATIONS SPRING 2019 2. FLUID-FLOW EQUATIONS SPRING 2019 2.1 Introduction 2.2 Conservative differential equations 2.3 Non-conservative differential equations 2.4 Non-dimensionalisation Summary Examples 2.1 Introduction Fluid

More information

Exercise solutions: concepts from chapter 10

Exercise solutions: concepts from chapter 10 Reading: Fundamentals of Structural Geology, Ch 0 ) The flow of magma with a viscosity as great as 0 0 Pa s, let alone that of rock with a viscosity of 0 0 Pa s, is difficult to comprehend because our

More information

A Study on Numerical Solution to the Incompressible Navier-Stokes Equation

A Study on Numerical Solution to the Incompressible Navier-Stokes Equation A Study on Numerical Solution to the Incompressible Navier-Stokes Equation Zipeng Zhao May 2014 1 Introduction 1.1 Motivation One of the most important applications of finite differences lies in the field

More information

AE/ME 339. Computational Fluid Dynamics (CFD) K. M. Isaac. Momentum equation. Computational Fluid Dynamics (AE/ME 339) MAEEM Dept.

AE/ME 339. Computational Fluid Dynamics (CFD) K. M. Isaac. Momentum equation. Computational Fluid Dynamics (AE/ME 339) MAEEM Dept. AE/ME 339 Computational Fluid Dynamics (CFD) 9//005 Topic7_NS_ F0 1 Momentum equation 9//005 Topic7_NS_ F0 1 Consider the moving fluid element model shown in Figure.b Basis is Newton s nd Law which says

More information

1 Exercise: Linear, incompressible Stokes flow with FE

1 Exercise: Linear, incompressible Stokes flow with FE Figure 1: Pressure and velocity solution for a sinking, fluid slab impinging on viscosity contrast problem. 1 Exercise: Linear, incompressible Stokes flow with FE Reading Hughes (2000), sec. 4.2-4.4 Dabrowski

More information

Lecture 8: Tissue Mechanics

Lecture 8: Tissue Mechanics Computational Biology Group (CoBi), D-BSSE, ETHZ Lecture 8: Tissue Mechanics Prof Dagmar Iber, PhD DPhil MSc Computational Biology 2015/16 7. Mai 2016 2 / 57 Contents 1 Introduction to Elastic Materials

More information

Fluid Mechanics. Jim Emery 9/3/ Bernoulli s Law 2. 2 Torricelli s Law 3. 3 Time to Empty a Tank 3. 4 Viscosity 4. 5 The Acceleration 5

Fluid Mechanics. Jim Emery 9/3/ Bernoulli s Law 2. 2 Torricelli s Law 3. 3 Time to Empty a Tank 3. 4 Viscosity 4. 5 The Acceleration 5 Fluid Mechanics Jim Emery 9/3/2010 Contents 1 Bernoulli s Law 2 2 Torricelli s Law 3 3 Time to Empty a Tank 3 4 Viscosity 4 5 The Acceleration 5 6 The Equation of Motion Due to Cauchy 7 7 The Deformation

More information

By drawing Mohr s circle, the stress transformation in 2-D can be done graphically. + σ x σ y. cos 2θ + τ xy sin 2θ, (1) sin 2θ + τ xy cos 2θ.

By drawing Mohr s circle, the stress transformation in 2-D can be done graphically. + σ x σ y. cos 2θ + τ xy sin 2θ, (1) sin 2θ + τ xy cos 2θ. Mohr s Circle By drawing Mohr s circle, the stress transformation in -D can be done graphically. σ = σ x + σ y τ = σ x σ y + σ x σ y cos θ + τ xy sin θ, 1 sin θ + τ xy cos θ. Note that the angle of rotation,

More information

3 2 6 Solve the initial value problem u ( t) 3. a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1

3 2 6 Solve the initial value problem u ( t) 3. a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1 Math Problem a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1 3 6 Solve the initial value problem u ( t) = Au( t) with u (0) =. 3 1 u 1 =, u 1 3 = b- True or false and why 1. if A is

More information

CENG 501 Examination Problem: Estimation of Viscosity with a Falling - Cylinder Viscometer

CENG 501 Examination Problem: Estimation of Viscosity with a Falling - Cylinder Viscometer CENG 501 Examination Problem: Estimation of Viscosity with a Falling - Cylinder Viscometer You are assigned to design a fallingcylinder viscometer to measure the viscosity of Newtonian liquids. A schematic

More information

FEniCS Course. Lecture 1: Introduction to FEniCS. Contributors Anders Logg André Massing

FEniCS Course. Lecture 1: Introduction to FEniCS. Contributors Anders Logg André Massing FEniCS Course Lecture 1: Introduction to FEniCS Contributors Anders Logg André Massing 1 / 15 What is FEniCS? 2 / 15 FEniCS is an automated programming environment for differential equations C++/Python

More information

Review of fluid dynamics

Review of fluid dynamics Chapter 2 Review of fluid dynamics 2.1 Preliminaries ome basic concepts: A fluid is a substance that deforms continuously under stress. A Material olume is a tagged region that moves with the fluid. Hence

More information

Conservation of Mass. Computational Fluid Dynamics. The Equations Governing Fluid Motion

Conservation of Mass. Computational Fluid Dynamics. The Equations Governing Fluid Motion http://www.nd.edu/~gtryggva/cfd-course/ http://www.nd.edu/~gtryggva/cfd-course/ Computational Fluid Dynamics Lecture 4 January 30, 2017 The Equations Governing Fluid Motion Grétar Tryggvason Outline Derivation

More information

7 The Navier-Stokes Equations

7 The Navier-Stokes Equations 18.354/12.27 Spring 214 7 The Navier-Stokes Equations In the previous section, we have seen how one can deduce the general structure of hydrodynamic equations from purely macroscopic considerations and

More information

Fluid Mechanics II Viscosity and shear stresses

Fluid Mechanics II Viscosity and shear stresses Fluid Mechanics II Viscosity and shear stresses Shear stresses in a Newtonian fluid A fluid at rest can not resist shearing forces. Under the action of such forces it deforms continuously, however small

More information

Variable Definition Notes & comments

Variable Definition Notes & comments Extended base dimension system Pi-theorem (also definition of physical quantities, ) Physical similarity Physical similarity means that all Pi-parameters are equal Galileo-number (solid mechanics) Reynolds

More information

2 Law of conservation of energy

2 Law of conservation of energy 1 Newtonian viscous Fluid 1 Newtonian fluid For a Newtonian we already have shown that σ ij = pδ ij + λd k,k δ ij + 2µD ij where λ and µ are called viscosity coefficient. For a fluid under rigid body motion

More information

Numerical methods for the Navier- Stokes equations

Numerical methods for the Navier- Stokes equations Numerical methods for the Navier- Stokes equations Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Dec 6, 2012 Note:

More information

Duality methods for variational inequalities and Non-Newtonian fluid mechanics

Duality methods for variational inequalities and Non-Newtonian fluid mechanics Duality methods for variational inequalities and Non-Newtonian fluid mechanics Enrique Fernández-Nieto, Paul Vigneaux Dpto. Matemática Aplicada I, Universidad de Sevilla UMPA, Ecole Normale Supérieure

More information

Mathematical Theory of Non-Newtonian Fluid

Mathematical Theory of Non-Newtonian Fluid Mathematical Theory of Non-Newtonian Fluid 1. Derivation of the Incompressible Fluid Dynamics 2. Existence of Non-Newtonian Flow and its Dynamics 3. Existence in the Domain with Boundary Hyeong Ohk Bae

More information

Rheology and Constitutive Equations. Rheology = Greek verb to flow. Rheology is the study of the flow and deformation of materials.

Rheology and Constitutive Equations. Rheology = Greek verb to flow. Rheology is the study of the flow and deformation of materials. Rheology and Constitutive Equations Rheology = Greek verb to flow Rheology is the study of the flow and deformation of materials. The focus of rheology is primarily on the study of fundamental, or constitutive,

More information

6.2 Governing Equations for Natural Convection

6.2 Governing Equations for Natural Convection 6. Governing Equations for Natural Convection 6..1 Generalized Governing Equations The governing equations for natural convection are special cases of the generalized governing equations that were discussed

More information

Lecture 3: 1. Lecture 3.

Lecture 3: 1. Lecture 3. Lecture 3: 1 Lecture 3. Lecture 3: 2 Plan for today Summary of the key points of the last lecture. Review of vector and tensor products : the dot product (or inner product ) and the cross product (or vector

More information

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 5

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 5 .9 Numerical Fluid Mechanics Fall 011 Lecture 5 REVIEW Lecture 4 Roots of nonlinear equations: Open Methods Fixed-point Iteration (General method or Picard Iteration), with examples Iteration rule: x g(

More information

CHAPTER 9. Microscopic Approach: from Boltzmann to Navier-Stokes. In the previous chapter we derived the closed Boltzmann equation:

CHAPTER 9. Microscopic Approach: from Boltzmann to Navier-Stokes. In the previous chapter we derived the closed Boltzmann equation: CHAPTER 9 Microscopic Approach: from Boltzmann to Navier-Stokes In the previous chapter we derived the closed Boltzmann equation: df dt = f +{f,h} = I[f] where I[f] is the collision integral, and we have

More information

4.3 Momentum Balance Principles

4.3 Momentum Balance Principles 4.3 Momentum Balance Principles 4.3.1 Balance of linear angular momentum in spatial material description Consider a continuum body B with a set of particles occupying an arbitrary region Ω with boundary

More information

A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation

A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation S. Bordère a and J.-P. Caltagirone b a. CNRS, Univ. Bordeaux, ICMCB,

More information

Differential relations for fluid flow

Differential relations for fluid flow Differential relations for fluid flow In this approach, we apply basic conservation laws to an infinitesimally small control volume. The differential approach provides point by point details of a flow

More information

FEniCS Course. Lecture 1: Introduction to FEniCS. Contributors Anders Logg André Massing

FEniCS Course. Lecture 1: Introduction to FEniCS. Contributors Anders Logg André Massing FEniCS Course Lecture 1: Introduction to FEniCS Contributors Anders Logg André Massing 1 / 30 What is FEniCS? 2 / 30 FEniCS is an automated programming environment for differential equations C++/Python

More information

Polymerization Technology Laboratory Course

Polymerization Technology Laboratory Course Polymerization Technology Laboratory Course Viscometry/Rheometry Tasks 1. Comparison of the flow behavior of polystyrene- solution and dispersion systems 2. Determination of the flow behaviour of polyvinylalcohol

More information

Professor George C. Johnson. ME185 - Introduction to Continuum Mechanics. Midterm Exam II. ) (1) x

Professor George C. Johnson. ME185 - Introduction to Continuum Mechanics. Midterm Exam II. ) (1) x Spring, 997 ME85 - Introduction to Continuum Mechanics Midterm Exam II roblem. (+ points) (a) Let ρ be the mass density, v be the velocity vector, be the Cauchy stress tensor, and b be the body force per

More information

Faraday Instability on Elastic Interfaces

Faraday Instability on Elastic Interfaces Faraday Instability on Elastic Interfaces A Project Report Submitted to the Faculty of the WORCESTER POLYTECHNIC INSTITUTE In partial fulfillment of the requirements for the Degree of Master of Science

More information

LEAST-SQUARES FINITE ELEMENT MODELS

LEAST-SQUARES FINITE ELEMENT MODELS LEAST-SQUARES FINITE ELEMENT MODELS General idea of the least-squares formulation applied to an abstract boundary-value problem Works of our group Application to Poisson s equation Application to flows

More information

16.20 Techniques of Structural Analysis and Design Spring Instructor: Raúl Radovitzky Aeronautics & Astronautics M.I.T

16.20 Techniques of Structural Analysis and Design Spring Instructor: Raúl Radovitzky Aeronautics & Astronautics M.I.T 16.20 Techniques of Structural Analysis and Design Spring 2013 Instructor: Raúl Radovitzky Aeronautics & Astronautics M.I.T February 15, 2013 2 Contents 1 Stress and equilibrium 5 1.1 Internal forces and

More information

Conservation of mass. Continuum Mechanics. Conservation of Momentum. Cauchy s Fundamental Postulate. # f body

Conservation of mass. Continuum Mechanics. Conservation of Momentum. Cauchy s Fundamental Postulate. # f body Continuum Mechanics We ll stick with the Lagrangian viewpoint for now Let s look at a deformable object World space: points x in the object as we see it Object space (or rest pose): points p in some reference

More information

- Marine Hydrodynamics. Lecture 4. Knowns Equations # Unknowns # (conservation of mass) (conservation of momentum)

- Marine Hydrodynamics. Lecture 4. Knowns Equations # Unknowns # (conservation of mass) (conservation of momentum) 2.20 - Marine Hydrodynamics, Spring 2005 Lecture 4 2.20 - Marine Hydrodynamics Lecture 4 Introduction Governing Equations so far: Knowns Equations # Unknowns # density ρ( x, t) Continuity 1 velocities

More information

CH.9. CONSTITUTIVE EQUATIONS IN FLUIDS. Multimedia Course on Continuum Mechanics

CH.9. CONSTITUTIVE EQUATIONS IN FLUIDS. Multimedia Course on Continuum Mechanics CH.9. CONSTITUTIVE EQUATIONS IN FLUIDS Multimedia Course on Continuum Mechanics Overview Introduction Fluid Mechanics What is a Fluid? Pressure and Pascal s Law Constitutive Equations in Fluids Fluid Models

More information

DUE: WEDS MARCH 26TH 2018

DUE: WEDS MARCH 26TH 2018 HOMEWORK # 2: FINITE DIFFERENCES MAPPING AND TWO DIMENSIONAL PROBLEMS DUE: WEDS MARCH 26TH 2018 NOTE: In this homework, you will choose ONE of the following three questions to perform and hand-in. Each

More information

Viscous Fluids. Amanda Meier. December 14th, 2011

Viscous Fluids. Amanda Meier. December 14th, 2011 Viscous Fluids Amanda Meier December 14th, 2011 Abstract Fluids are represented by continuous media described by mass density, velocity and pressure. An Eulerian description of uids focuses on the transport

More information

FOUR-WAY COUPLED SIMULATIONS OF TURBULENT

FOUR-WAY COUPLED SIMULATIONS OF TURBULENT FOUR-WAY COUPLED SIMULATIONS OF TURBULENT FLOWS WITH NON-SPHERICAL PARTICLES Berend van Wachem Thermofluids Division, Department of Mechanical Engineering Imperial College London Exhibition Road, London,

More information

Exercise 5: Exact Solutions to the Navier-Stokes Equations I

Exercise 5: Exact Solutions to the Navier-Stokes Equations I Fluid Mechanics, SG4, HT009 September 5, 009 Exercise 5: Exact Solutions to the Navier-Stokes Equations I Example : Plane Couette Flow Consider the flow of a viscous Newtonian fluid between two parallel

More information

Continuum Mechanics Examination exercises

Continuum Mechanics Examination exercises Continuum Mechanics Examination exercises Name:... Result: 1:1... 1:... 1:3... :1... :... :3... :4... 3:1... 3:... 3:3... 4:1... 4:... 5:1... 5:... LTH, Box 118, S-1 00 LUND Sweden Tel: +46 (0)46 3039

More information

CHAPTER 3. CONVENTIONAL RHEOMETRY: STATE-OF-THE-ART. briefly introduces conventional rheometers. In sections 3.2 and 3.

CHAPTER 3. CONVENTIONAL RHEOMETRY: STATE-OF-THE-ART. briefly introduces conventional rheometers. In sections 3.2 and 3. 30 CHAPTER 3. CONVENTIONAL RHEOMETRY: STATE-OF-THE-ART This chapter reviews literature on conventional rheometries. Section 3.1 briefly introduces conventional rheometers. In sections 3.2 and 3.3, viscometers

More information

2.20 Fall 2018 Math Review

2.20 Fall 2018 Math Review 2.20 Fall 2018 Math Review September 10, 2018 These notes are to help you through the math used in this class. This is just a refresher, so if you never learned one of these topics you should look more

More information

Chapter 3. Forces, Momentum & Stress. 3.1 Newtonian mechanics: a very brief résumé

Chapter 3. Forces, Momentum & Stress. 3.1 Newtonian mechanics: a very brief résumé Chapter 3 Forces, Momentum & Stress 3.1 Newtonian mechanics: a very brief résumé In classical Newtonian particle mechanics, particles (lumps of matter) only experience acceleration when acted on by external

More information

L8. Basic concepts of stress and equilibrium

L8. Basic concepts of stress and equilibrium L8. Basic concepts of stress and equilibrium Duggafrågor 1) Show that the stress (considered as a second order tensor) can be represented in terms of the eigenbases m i n i n i. Make the geometrical representation

More information

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

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

More information

CHAPTER 8 CONSERVATION LAWS

CHAPTER 8 CONSERVATION LAWS CHAPTER 8 CONSERVATION LAWS Outlines 1. Charge and Energy 2. The Poynting s Theorem 3. Momentum 4. Angular Momentum 2 Conservation of charge and energy The net amount of charges in a volume V is given

More information

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Soft-Body Physics Soft Bodies Realistic objects are not purely rigid. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Deformed

More information

Numerical Heat and Mass Transfer

Numerical Heat and Mass Transfer Master Degree in Mechanical Engineering Numerical Heat and Mass Transfer 15-Convective Heat Transfer Fausto Arpino f.arpino@unicas.it Introduction In conduction problems the convection entered the analysis

More information

Fluid Mechanics Abdusselam Altunkaynak

Fluid Mechanics Abdusselam Altunkaynak Fluid Mechanics Abdusselam Altunkaynak 1. Unit systems 1.1 Introduction Natural events are independent on units. The unit to be used in a certain variable is related to the advantage that we get from it.

More information

Chapter 5. The Differential Forms of the Fundamental Laws

Chapter 5. The Differential Forms of the Fundamental Laws Chapter 5 The Differential Forms of the Fundamental Laws 1 5.1 Introduction Two primary methods in deriving the differential forms of fundamental laws: Gauss s Theorem: Allows area integrals of the equations

More information

Microscopic Momentum Balance Equation (Navier-Stokes)

Microscopic Momentum Balance Equation (Navier-Stokes) CM3110 Transport I Part I: Fluid Mechanics Microscopic Momentum Balance Equation (Navier-Stokes) Professor Faith Morrison Department of Chemical Engineering Michigan Technological University 1 Microscopic

More information

CESSATION OF VISCOPLASTIC POISEUILLE FLOW IN A RECTANGULAR DUCT WITH WALL SLIP

CESSATION OF VISCOPLASTIC POISEUILLE FLOW IN A RECTANGULAR DUCT WITH WALL SLIP 8 th GRACM International Congress on Computational Mechanics Volos, 2 July 5 July 205 CESSATION OF VISCOPLASTIC POISEUILLE FLOW IN A RECTANGULAR DUCT WITH WALL SLIP Yiolanda Damianou, George Kaoullas,

More information

Summary of the Equations of Fluid Dynamics

Summary of the Equations of Fluid Dynamics Reference: Summary of the Equations of Fluid Dynamics Fluid Mechanics, L.D. Landau & E.M. Lifshitz 1 Introduction Emission processes give us diagnostics with which to estimate important parameters, such

More information

REE Internal Fluid Flow Sheet 2 - Solution Fundamentals of Fluid Mechanics

REE Internal Fluid Flow Sheet 2 - Solution Fundamentals of Fluid Mechanics REE 307 - Internal Fluid Flow Sheet 2 - Solution Fundamentals of Fluid Mechanics 1. Is the following flows physically possible, that is, satisfy the continuity equation? Substitute the expressions for

More information

Fluid Dynamics: Theory, Computation, and Numerical Simulation Second Edition

Fluid Dynamics: Theory, Computation, and Numerical Simulation Second Edition Fluid Dynamics: Theory, Computation, and Numerical Simulation Second Edition C. Pozrikidis m Springer Contents Preface v 1 Introduction to Kinematics 1 1.1 Fluids and solids 1 1.2 Fluid parcels and flow

More information

Homework 4 in 5C1212; Part A: Incompressible Navier- Stokes, Finite Volume Methods

Homework 4 in 5C1212; Part A: Incompressible Navier- Stokes, Finite Volume Methods Homework 4 in 5C11; Part A: Incompressible Navier- Stokes, Finite Volume Methods Consider the incompressible Navier Stokes in two dimensions u x + v y = 0 u t + (u ) x + (uv) y + p x = 1 Re u + f (1) v

More information

Hydrodynamic Lubrication

Hydrodynamic Lubrication ME 383S Bryant February 15, 2005 1 Hydrodynamic Lubrication Fluid Lubricant: liquid or gas (gas bearing) Mechanism: Pressures separate surfaces o Normal loads on bodies o Convergent profile between surfaces

More information

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost Game and Media Technology Master Program - Utrecht University Dr. Nicolas Pronost Soft body physics Soft bodies In reality, objects are not purely rigid for some it is a good approximation but if you hit

More information

Smooth Particle Hydrodynamic (SPH) Presented by: Omid Ghasemi Fare Nina Zabihi XU Zhao Miao Zhang Sheng Zhi EGEE 520

Smooth Particle Hydrodynamic (SPH) Presented by: Omid Ghasemi Fare Nina Zabihi XU Zhao Miao Zhang Sheng Zhi EGEE 520 Smooth Particle Hydrodynamic (SPH) Presented by: Omid Ghasemi Fare Nina Zabihi XU Zhao Miao Zhang Sheng Zhi EGEE 520 OUTLINE Ø Introduction and Historical Perspective: Ø General Principles: Ø Governing

More information

Rheometer: Procedure: Part A: Viscosity v Time

Rheometer: Procedure: Part A: Viscosity v Time Rheometer A fluid is defined as a substance that deforms continuously under the action of a shear stress, no matter how small the shear stress may be. Without shear stress, there will be no deformation.

More information

Modelling of dispersed, multicomponent, multiphase flows in resource industries. Section 3: Examples of analyses conducted for Newtonian fluids

Modelling of dispersed, multicomponent, multiphase flows in resource industries. Section 3: Examples of analyses conducted for Newtonian fluids Modelling of dispersed, multicomponent, multiphase flows in resource industries Section 3: Examples of analyses conducted for Newtonian fluids Globex Julmester 017 Lecture # 04 July 017 Agenda Lecture

More information

CHARACTERISTIC OF FLUIDS. A fluid is defined as a substance that deforms continuously when acted on by a shearing stress at any magnitude.

CHARACTERISTIC OF FLUIDS. A fluid is defined as a substance that deforms continuously when acted on by a shearing stress at any magnitude. CHARACTERISTIC OF FLUIDS A fluid is defined as a substance that deforms continuously when acted on by a shearing stress at any magnitude. In a fluid at rest, normal stress is called pressure. 1 Dimensions,

More information

NONLINEAR CONTINUUM FORMULATIONS CONTENTS

NONLINEAR CONTINUUM FORMULATIONS CONTENTS NONLINEAR CONTINUUM FORMULATIONS CONTENTS Introduction to nonlinear continuum mechanics Descriptions of motion Measures of stresses and strains Updated and Total Lagrangian formulations Continuum shell

More information

SPH for the Modeling of non-newtonian Fluids with Thermal-Dependent Rheology

SPH for the Modeling of non-newtonian Fluids with Thermal-Dependent Rheology SPH for the Modeling of non-newtonian Fluids with Thermal-Dependent Rheology G. Bilotta 1,2 1 Dipartimento di Matematica e Informatica, Università di Catania, Italy 2 Istituto Nazionale Geofisica e Vulcanologia,

More information

Viscosity and Polymer Melt Flow. Rheology-Processing / Chapter 2 1

Viscosity and Polymer Melt Flow. Rheology-Processing / Chapter 2 1 Viscosity and Polymer Melt Flow Rheology-Processing / Chapter 2 1 Viscosity: a fluid property resistance to flow (a more technical definition resistance to shearing) Remember that: τ μ du dy shear stress

More information

( ) Notes. Fluid mechanics. Inviscid Euler model. Lagrangian viewpoint. " = " x,t,#, #

( ) Notes. Fluid mechanics. Inviscid Euler model. Lagrangian viewpoint.  =  x,t,#, # Notes Assignment 4 due today (when I check email tomorrow morning) Don t be afraid to make assumptions, approximate quantities, In particular, method for computing time step bound (look at max eigenvalue

More information

Level Set Tumor Growth Model

Level Set Tumor Growth Model Level Set Tumor Growth Model Andrew Nordquist and Rakesh Ranjan, PhD University of Texas, San Antonio July 29, 2013 Andrew Nordquist and Rakesh Ranjan, PhD (University Level Set of Texas, TumorSan Growth

More information

This chapter is a study of the shear stress as a function of the shear rate for Newtonian and non-newtonian biological materials.

This chapter is a study of the shear stress as a function of the shear rate for Newtonian and non-newtonian biological materials. Lecture 10 and Flow (Ch. 6) This chapter is a study of the shear stress as a function of the shear rate for Newtonian and non-newtonian biological materials. 1 Lecture 10 and Flow (Ch. 6) When a fluid

More information

Stress, Strain, Mohr s Circle

Stress, Strain, Mohr s Circle Stress, Strain, Mohr s Circle The fundamental quantities in solid mechanics are stresses and strains. In accordance with the continuum mechanics assumption, the molecular structure of materials is neglected

More information

An Extended Finite Element Method for a Two-Phase Stokes problem

An Extended Finite Element Method for a Two-Phase Stokes problem XFEM project An Extended Finite Element Method for a Two-Phase Stokes problem P. Lederer, C. Pfeiler, C. Wintersteiger Advisor: Dr. C. Lehrenfeld August 5, 2015 Contents 1 Problem description 2 1.1 Physics.........................................

More information

Viscoelasticity. Basic Notions & Examples. Formalism for Linear Viscoelasticity. Simple Models & Mechanical Analogies. Non-linear behavior

Viscoelasticity. Basic Notions & Examples. Formalism for Linear Viscoelasticity. Simple Models & Mechanical Analogies. Non-linear behavior Viscoelasticity Basic Notions & Examples Formalism for Linear Viscoelasticity Simple Models & Mechanical Analogies Non-linear behavior Viscoelastic Behavior Generic Viscoelasticity: exhibition of both

More information

Physics 209 Fall 2002 Notes 5 Thomas Precession

Physics 209 Fall 2002 Notes 5 Thomas Precession Physics 209 Fall 2002 Notes 5 Thomas Precession Jackson s discussion of Thomas precession is based on Thomas s original treatment, and on the later paper by Bargmann, Michel, and Telegdi. The alternative

More information

EKC314: TRANSPORT PHENOMENA Core Course for B.Eng.(Chemical Engineering) Semester II (2008/2009)

EKC314: TRANSPORT PHENOMENA Core Course for B.Eng.(Chemical Engineering) Semester II (2008/2009) EKC314: TRANSPORT PHENOMENA Core Course for B.Eng.(Chemical Engineering) Semester II (2008/2009) Dr. Mohamad Hekarl Uzir-chhekarl@eng.usm.my School of Chemical Engineering Engineering Campus, Universiti

More information

CONSERVATION OF MASS AND BALANCE OF LINEAR MOMENTUM

CONSERVATION OF MASS AND BALANCE OF LINEAR MOMENTUM CONSERVATION OF MASS AND BALANCE OF LINEAR MOMENTUM Summary of integral theorems Material time derivative Reynolds transport theorem Principle of conservation of mass Principle of balance of linear momentum

More information

Second Year Electromagnetism Summer 2018 Caroline Terquem. Vacation work: Problem set 0. Revisions

Second Year Electromagnetism Summer 2018 Caroline Terquem. Vacation work: Problem set 0. Revisions Second Year Electromagnetism Summer 2018 Caroline Terquem Vacation work: Problem set 0 Revisions At the start of the second year, you will receive the second part of the Electromagnetism course. This vacation

More information