SlideShare a Scribd company logo
1 of 52
Download to read offline
Finite Element Method
2D heat conduction
1
Heat conduction in two dimensions
 All real bodies are three-dimensional (3D)
 If the heat supplies, prescribed temperatures and material characteristics
are independent of the z-coordinate, the domain can be approximated
with a 2D domain with the thickness t(x,y)
Finite Element Method
2D heat conduction
2
Discretization into two-dimensional finite elements
 The body is discretized with a number of finite elements
 They can be triangular or quadrilateral
 Straight or curved element sides
Finite Element Method
2D heat conduction
3
Today’s elements
 Melosh element
 Four nodes
 Only right angles
 Must be aligned with the
coordinate axes
Element side (edge)
Element node at the corner
(vertex)
Element interior
 Constant strain triangle (CST)
 Three nodes
 Arbitrary angles
 Arbitrary orientation
 Isoparametric four-node
element
 Four nodes
 Arbitrary angles
 Arbitrary orientation
Finite Element Method
2D heat conduction
4
Other useful elements
 Triangular six-node element with straight edges and
midside nodes (Lecture 8 + 9)
 Triangular isoparametric six-node element with curved
edges and off-midside nodes
 Isoparametric eight-noded elements with straight edges
and midside nodes
 Isoparametric eight-noded elements with curved edges
and off-midside nodes (Lecture 8 + 9)
Finite Element Method
2D heat conduction
5
The patch test
 The main exercise of today is the patch test. You will program its
main parts and use it to verify that the elements work properly.
 A patch test should include at least one
internal node
 The patch test should be as
unconstrained as possible, i.e. the
temperature should be specified
at only one node.
 Before we go into the equations of 2D
heat conduction, you must now start
MatLab and do a small exercise.
Finite Element Method
2D heat conduction
6
Exercise: Program and plot the geometry and topology of a
2D patch test for the Melosh, CST and ISO4 elements
Melosh etype = 1 CST etype = 3 Iso4 etype = 7
Coord = [ x1 y1 z1 ; x2 y2 y3 ; …. ] % Nodal coordinates in file “Coordinates.m”
Top = [ etype section etc ] % for each element in the file “Topology.m”
Plot by executing the line “visualize2D”
Finite Element Method
2D heat conduction
7
Basic steps of the finite-element method (FEM)
1. Establish strong formulation
 Partial differential equation
2. Establish weak formulation
 Multiply with arbitrary field and integrate over element
3. Discretize over space
 Mesh generation
4. Select shape and weight functions
 Galerkin method
5. Compute element stiffness matrix
 Local and global system
6. Assemble global system stiffness matrix
7. Apply nodal boundary conditions
 temperature/flux/forces/forced displacements
8. Solve global system of equations
 Solve for nodal values of the primary variables (displacements/temperature)
9. Compute temperature/stresses/strains etc. within the element
 Using nodal values and shape functions
Finite Element Method
2D heat conduction
8
Step 1: Establish strong formulation for 2D heat conduction
(OP pp. 76-84)
Heat flow (flux) vector
Boundary normal
Heat flow out of the boundary (the flux)
1D:
2D:
q =
½
qx
qy
¾ ·
J
m2s
¸
n =
½
nx
ny
¾
jnj = 1
qn = q ¢ n = qT
n
Finite Element Method
2D heat conduction
9
The constitutive relation in matrix notation:
, material isotropy leads to
Finite Element Method
2D heat conduction
10
Energy conservation and a time independent problem leads to: The amount of
heat (energy) supplied to the body per unit of time must equal the amount of
heat leaving the body per unit time:
Rearranging leads to
Q is internal
heat supply
[J/m3s]
Prescribed
quantities
Gauss’ divergence theorem (OP p. 73)
Divergence:
t is the
thickness [m]
Finite Element Method
2D heat conduction
11
Written out, the strong form for stationary 2D heat
conduction is
Insertion of the constitutive relation leads to the strong
formulation:
Prescribed
quantities
Boundary
conditions
Finite Element Method
2D heat conduction
12
Step 2: Establish weak formulation for 2D heat conduction
(Cook pp. 136-137, 151), (OP Chapter 5, pp. 84-86)
Multiply the strong formulation with a weight
function v(x,y) and integrate over the domain
Prescribed
quantities
The Green-Gauss theorem (OP p. 74)
Inserting into the first equation while replacing
yields
Finite Element Method
2D heat conduction
13
The boundary integral is split into two terms to reflect
the two different types of boundary conditions
Prescribed
quantities
Insertion into the top equation followed by
rearranging leads to the weak form of 2D heat flow
Boundary conditions Internal heat supply (heat load)
Finite Element Method
2D heat conduction
14
Basic steps of the finite-element method (FEM)
1. Establish strong formulation
 Partial differential equation
2. Establish weak formulation
 Multiply with arbitrary field and integrate over element
3. Discretize over space
 Mesh generation
4. Select shape and weight functions
 Galerkin method
5. Compute element stiffness matrix
 Local and global system
6. Assemble global system stiffness matrix
7. Apply nodal boundary conditions
 temperature/flux/forces/forced displacements
8. Solve global system of equations
 Solve for nodal values of the primary variables (displacements/temperature)
9. Compute temperature/stresses/strains etc. within the element
 Using nodal values and shape functions
Finite Element Method
2D heat conduction
15
Step 3: Discretize over space
Now the domain is discretized into a number of finite
elements. This determines the mesh coordinates and
the element topology, i.e. the matrices coord and Top in
our MatLab program.
Here it is illustrated with a single Melosh element.
Finite Element Method
2D heat conduction
16
Step 4: Weight and shape functions
The Galerkin method is chosen. This means that the
main variable (the temperature) and the weight function
v(x,y) are interpolated using the same interpolation
functions
Known shape functions
(depends only on x and y) Unknown nodal values
Examples:
Finite Element Method
2D heat conduction
17
The weak form can now be written as
Noticing that v and a are constants, rearranging yields
Because v is arbitrary the parenthesis term must vanish (equal zero)
where
Finite Element Method
2D heat conduction
18
In order to be able to write the equations in a compact form the following
terms are introduced
The equations can now be written as
Example: The Melosh heat conduction element:
The stiffness matrix
Boundary terms (boundary load vector)
Internal load vector
Degrees of
freedom, dof
Finite Element Method
2D heat conduction
19
The definition of the heat flux was
With the finite element formulation we have
This gives us the flux within the element as
Finite Element Method
2D heat conduction
20
Example: The melosh element
Notice that Ni vary linearly along element edges.
Example:
Shape and weight functions
This ensures inter-element combatibility, i.e. no gaps
and no overlapping:
Finite Element Method
2D heat conduction
21
Assumptions: D and t are constant.
Element width: 2a, height 2b
Steps:
1. Compute B-matrix
2. Carry out matrix multiplication
3. Integrate each element of the matrix product to
obtain K
4. Program K into the file KmeloshHeat.m
5. A test value with the parameters, 2a = 2, 2b = 1,
t = 1.3, kxx = 4.56, kyy = 3.8 is :
Exercise: compute and program the Melosh stiffness matrix
Finite Element Method
2D heat conduction
22
Example: constant heat supply between nodes 1 and 2
Boundary load vector
Prescribed term
Can only contain
nodal values
Remember: If heat is transferred into the domain, q is negative
Can only contain values at nodes. So uniform heat supplies
must be converted into nodal loads
Unit: J/s
Reactions
Finite Element Method
2D heat conduction
23
Exercise: Calculate fb with triangular heat load
Prescribed term
Can only contain
nodal values
Remember: If heat is transferred into the domain, q is negative
The heat load varies linearly from zero at node 2 to the
value q3 at node 3
Steps:
1. Find the expression for the heat load as a
function of the coordinates q(x,y)
2. Carry out the integration as shown on the
previous slide.
Finite Element Method
2D heat conduction
24
Example: constant internal heat supply in a Melosh element
Internal load vector
Can only contain values at nodes. So internal heat supplies
must be converted into nodal loads
Q is internal
heat supply
[J/m3s]
Element area A = 4 ab
Finite Element Method
2D heat conduction
25
 The assembling procedure is exactly the same as in the last lecture:
1. Determine the local stiffness matrix
2. determine the global number of dof corresponding to the local dof for the element
3. add the components of the local stiffness matrix to the rows and columns of the
global stiffness matrix corresponding to the global dof numbers
4. repeat 1-3 until all contributions from all elements have been added.
 In MatLab this is done in assemblering.m
K(gDof,gDof) = K(gDof,gDof) + Ke;
Step 6: Assembling
Finite Element Method
2D heat conduction
26
 In order to be able to create a global system matrix we need to give
information about
 Material for each element
 Section dimensions for each element
 Coordinates for each node (and a numbering)
 Topology for each element (which nodes are in the element)
 dof numbering is given from the node numbering and number of dofs per node (one
in this case)
 See calc_globdof.m for numbering of global dof
 ElemDof = [neDof1 GDof1 GDof2 ...]
 dof numbering of each element
 GlobDof = [Gnode1 GDof1 GDof2 ...]
 dof numbering of each node (used for plotting)
 nDof = total number of Dof
Finite Element Method
2D heat conduction
27
Example of assembling the load vector
Total heat load vector
The global matrices are assembled in exactly the same way as with the bar elements of the previous
lecture. Here an example of the assembly of the load vector of a two element system is shown
The thicknesses of the two
elements are identical
Remember: If heat is
transferred into the
domain, q is negative
Finite Element Method
2D heat conduction
28
Exercise: Program and plot the results of a 2D patch test for
the Melosh element
t = 1.2 m, kxx = kyy = 3 J/Cms
Steps
1. Program the geometry (done earlier today)
2. Determine nodal heat supplies q3, q6, and q9
3. Determine nodal heat supply q4 and q7 (We
want T = 0 on the left boundary, x = 0)
4. Make the appropriate programming in
Topology.m and BoundaryConditions.m
5. Plot by executing the line “visualizeD2
Compare with the analytical solution:
Hint: on the colorplot the temperatures can be found by
activating the figure and typing “colorbar” at the command line
Finite Element Method
2D heat conduction
29
Why use other elements than the Melosh element?
• The Melosh element must be rectangular and
positioned along the coordinate axes
• It is therefore not very good at approximating
boundaries not aligned with the coordinate axes
• Conclusion: The Melosh element is not very flexible
Why use triangular elements?
• Triangular elements can be rotated arbitrarily
• They can therefore approximate boundaries not aligned
with coordinate axes well.
• It is relatively simple to make a computer code that
meshes an arbitrary area with triangles.
Next: The constant strain triangle (CST)
• The name stems from its original development within structural mechanics
• In heat conduction analysis the name “constrant flux triangle” would be
appropriate
Finite Element Method
2D heat conduction
30
Preliminary: Natural coordinates (Area coordinates)
• For general triangular elements it has proven useful
to derive the stiffness matrix using the so-called
“natural coordinates” also referred to as “area
coordinates
Point P defines three areas. These define the
natural coordinate of the point
The following constraint applies
Examples:
Element centroid:
Node 1
Node 3
Finite Element Method
2D heat conduction
31
The relation between natural and cartesian
coordinates is
In matrix notation
With the coordinate transformation matrix A
here
The element area can be found by
Finite Element Method
2D heat conduction
32
Differentiation in natural coordinates
A function N (e.g. a shape function) is expressed in
natural coordinates, N(1, 2, 3). The chain rule
then gives us
With the coordinate transformation
we get
Finite Element Method
2D heat conduction
33
Integration in natural coordinates
A polynomial function expressed in natural
coordinates, f(1, 2, 3) can easily be integrated over
the element area using the formula
Example:
Finite Element Method
2D heat conduction
34
Shape functions for the CST-element
The shape functions for the CST-element in natural coordinates
are very simple:
The temperature in the element interior is then given by
The stiffness matrix is again given by
with
Finite Element Method
2D heat conduction
35
Exercise: Calculate and program the stiffness matrix
of the heat conduction CST-element
Steps
1. Determine the derivatives in the B-matrix
2. Setup the B-matrix. Think about and explain why the element
name “constant flux element” is appropriate (hint on slide 18)
3. Carry out the matrix multiplication indicated on the previous
slide.
4. Integrate over the element area to obtain the stiffness matrix
K
5. Program the stiffness matrix into the file K_CST_Heat.m
6. A test value with the parameters (x1, x2, x3) = (1, 3, -1), (y1,
y2, y3) = (0, 2, 1), t = 1.3, kxx = 4.7 and kyy = 5.1 is
Finite Element Method
2D heat conduction
36
Exercise: Program and plot the results of a 2D patch test for
the CST element
t = 1.2 m, kxx = kyy = 3 W/ Cm
Steps
1. Program the geometry (done earlier today)
2. Determine nodal heat supplies q3, q6, and q9
3. Determine nodal heat supply q4 and q7 (We
want T = 0 on the left boundary, x = 0)
4. Make the appropriate programming in
Topology.m and BoundaryConditions.m
5. Plot by executing the line “visualizeD2
Compare with the analytical solution:
Hint: on the colorplot the temperatures can be found by
activating the figure and typing “colorbar” at the command line
Finite Element Method
2D heat conduction
37
The isoparametric four node element (Iso4)
• A quadrilateral element which can be distorted from
the rectangular shape and rotated arbitrarily in the
plane
• Introduces several important concepts in finite element
theory, such as
• Isoparametric coordinates
• Parent and global domain
• The Jacobian matrix and the Jacobian
• Numerical integration by Gauss quadrature
• The isoparametric formulation forms the basis for
nearly all the elements in practical use
Finite Element Method
2D heat conduction
38
Parent and global domain
• For general quadrilateral elements is has proven
useful to formulate the stiffness matrix using the
isoparametric formulation.
• In the parent domain the element is always a
square element with the side length 2.
• The isoparametric coordinates  and  have their
origin at the element centroid. This means that the
vertex (corner) nodes have the coordinates (,):
1: (-1,-1), 2: (1,-1), 3: (1,1) and 4: (-1,1)
• In the global domain the nodes of the four node
element have the coordinates: (x,y): 1: (x1,y1), 2:
(x2,y2), 3: (x3,y3), and 4: (x4,y4).
• The question is “how do we connect these two
sets of coordinates?” (much in a similar way as we
did with the triangle.)
Note: with the natural coordinates of the triangle the coordinate
limits were 0  1, 2, 3  1. For the isoparametric coordinates
they are -1  ,   1
Parent
domain
Global
domain
Finite Element Method
2D heat conduction
39
The isoparametric coordinate transformation
• The idea is that we use the shape functions to
interpolate the coordinates between the nodes Parent
domain
Global
domain
e.g.
With the shape functions:
Notice that these are the shape functions of the
Melosh element with a = b = 1
Finite Element Method
2D heat conduction
40
Temperature and flux interpolation
As usual the temperature within the element is inter-
polated from the nodal values Parent
domain
Global
domain
The heat flux is also still given by
with
Problem: we have to find the derivatives of the
shape functions with respect to the global (x,y)
coordinates, but the shape functions are expressed
in the isoparametric (,) coordinates. To overcome
this problem we will define B as a product of two
matrices:
Finite Element Method
2D heat conduction
41
Parent
domain
Global
domain
The matrix DN contains the derivatives of the shape
functions with respect to the isoparametric coordinates
With DN the temperature derivatives within the element can
be found by
If we wanted the temperature derivatives the (,)-
coordinates we were done now. But we need them in the
(x,y) system in order to determine the heat flux. The
transformation of derivatives from the (,) system into
the (x,y) system is carried out by the inverse of the so-
called “Jacobian matrix”, J-1
Finite Element Method
2D heat conduction
42
Parent
domain
Global
domain
The matrix J is called “the Jacobian matrix” and it relates
the temperature derivatives in the two coordinate
systems
The elements of J can be found by differentiating the temperature
with respect to (, ) by invoking the chain rule:
The Jacobian matrix
This gives us the elements of J
Finite Element Method
2D heat conduction
43
Parent
domain
Global
domain
The inverse of J, which was needed in the expression for B,
, can now be found by
where the determinant of J, which is often called “the
Jacobian”, is given by
The Jacobian
The Jacobian can be regarded as a scale factor that relates
infinitesimal areas in the parent domain and the global
domain, see (Cook pp. 206 – 207), (OP pp. 376 – 380)
Finite Element Method
2D heat conduction
44
Parent
domain
Global
domain
The definition of the stiffness matrix was
Stiffness matrix for the Iso4 element
With the Jacobian matrix and its determinant we now have
the tools to calculate the stiffness matrix of a
isoparametric quadrilateral element.
The integral is non-linear and can, in general, not be
solved analytically. Therefore we must use numerical
integration.
As a remark it should be mentioned that the shape
functions are still linear along the element sides. This
means that boundary loads are distributed to the nodes
in the same way as it was done with the Melosh element.
Finite Element Method
2D heat conduction
45
Our concern is to find the following integral numerically
Numerical integration
One way of doing this is to divide the domain in n equal
intervals of equal width W, and sum up the contribution
from n rectangular areas with the height given by the
function value in the centre of the intervals
A second method is analogous to the above but with
varying interval widths Wi
Both methods will converge towards the exact integral
when the number of intervals, n, increases.
Finite Element Method
2D heat conduction
46
The position of the evaluation points xi and the size of the
widths (also called weight factors) can be optimized with
respect to the function that is integrated. For integrals of
polynomials in the interval [-1 ; 1] this in known as the so-
called Gauss quadrature. Notice that this is the interval we
are interested in with isoparametric elements as the
isoparametric coordinates -1  ,  1. With Gauss
quadrature we can evaluate integrals as
Gauss quadrature
with the following positions and weights
Finite Element Method
2D heat conduction
47
Gauss points and weights
A polynomium of degree 2n – 1 is integrated exact with a
Gauss quadrature of degree n.
Finite Element Method
2D heat conduction
48
Gauss quadrature in two dimensions
For the calculation of the stiffness matrix we need the
Gauss quadrature in two dimensions. This is obtained as
follows
Example: Numerical integration of (,) with Gauss
order n = 2, which gives 22 = 4 points:
Finite Element Method
2D heat conduction
49
Exercise: Numerical integration of two functions in 2D
Steps
1. Open NumIntExc_Lec34_student.m
2. In the loop calculate the function value Φ at each Gauss point
3. Sum the integral in the variable “numint”. Remember the weight functions (see the previous slide)
4. Save the exact solution in the variable “int_exact”.
5. Start with one Gausspoint, then two, and so on..
6. Run the program by pressing F5.
What is different about the two functions?
1
1
2 3






function 1:
exact solution
1 1
1
1 1
2 2 ln5
3
d d
  
 

 
  
3 2
1 1 2 3
    
   
function 2:
exact solution
1 1
2
1 1
28
3
d d
  
 
 
 
Finite Element Method
2D heat conduction
50
Exercise: Calculate and program the stiffness matrix of the heat
conduction Iso4-element
Steps
1. Open the file K_QuadIso_Heat.m
2. Setup a loop over the Gauss points
3. Initiate the stiffness matrix as zeros
4. Perform steps 5 to 9 inside a loop over the Gauss points
5. Calculate the and setup the DN-matrix
6. Calculate the Jacobian matrix
7. Calculate the determinant of the Jacobian matrix
8. Calculate the inverse Jacobian matrix
9. Calculate the integral at the current Gauss point and add it to the current value of
the stiffness matrix, Ke
10. A test value with the parameters (x1, x2, x3, x4) = (1, 3, 3.5, -1), (y1, y2, y3, y4)
= (0, -1, 1 1), t = 1.3, kxx = 4.7 and kyy = 5.1 n = 2 (Gauss order)
Finite Element Method
2D heat conduction
51
Exercise: Program and plot the results of a 2D patch test for
the Iso4 element
t = 1.2 m, kxx = kyy = 3 J/Cms
Steps
1. Program the geometry (done earlier today)
2. Determine nodal heat supplies q3, q6, and q9
3. Determine nodal heat supply q4 and q7 (We
want T = 0 on the left boundary, x = 0)
4. Make the appropriate programming in
Topology.m and BoundaryConditions.m
5. Plot by executing the line “visualizeD2
Compare with the analytical solution:
Hint: on the colorplot the temperatures can be found by
activating the figure and typing “colorbar” at the command line
Finite Element Method
2D heat conduction
52
Exercise: Get familiar with the program and test the
different elements
We will now try to carry out a calculation of the temperature in the tapered beam
from the last lecture. This time we will use 2D elements.
• Set the variable atype = 2 in main.m
• Try to run the program
• The number of elements can be controlled by changing the variable nelem_y in
Coordinates.m
• Does the three elements of todays lecture give the same result?
• Does it make any difference what order of Gauss quadrature you use in the Iso4-element?
(this is controlled in the file K_QuadIso_Heat.m)
• Try to take a look at how the coordinates and the topology is calculated. This might give
you inspiration for your own program in the semester project.

More Related Content

What's hot

SIMULATION AND STUDY OF MULTILEVEL INVERTER (ppt)
SIMULATION AND STUDY OF MULTILEVEL INVERTER (ppt)SIMULATION AND STUDY OF MULTILEVEL INVERTER (ppt)
SIMULATION AND STUDY OF MULTILEVEL INVERTER (ppt)Arpit Kurel
 
Three phase semi converter
Three phase semi converterThree phase semi converter
Three phase semi converterArpit Raval
 
Jeju Island Smart Grid Project
Jeju Island Smart Grid ProjectJeju Island Smart Grid Project
Jeju Island Smart Grid ProjectLeonardo ENERGY
 
General fuel cell
General fuel cellGeneral fuel cell
General fuel cellUsman Shah
 
Photovoltaic Devices: Life Cycle Considerations
Photovoltaic Devices: Life Cycle ConsiderationsPhotovoltaic Devices: Life Cycle Considerations
Photovoltaic Devices: Life Cycle ConsiderationsGavin Harper
 
The power generation by using piezoelectric effect
The power generation by using piezoelectric effectThe power generation by using piezoelectric effect
The power generation by using piezoelectric effectImunique123
 
Smart Grid - Future Electric Grid
Smart Grid - Future Electric GridSmart Grid - Future Electric Grid
Smart Grid - Future Electric Gridsatya prakash meena
 
Single Electron Transistor
Single Electron Transistor Single Electron Transistor
Single Electron Transistor Khemendra shukla
 

What's hot (20)

SIMULATION AND STUDY OF MULTILEVEL INVERTER (ppt)
SIMULATION AND STUDY OF MULTILEVEL INVERTER (ppt)SIMULATION AND STUDY OF MULTILEVEL INVERTER (ppt)
SIMULATION AND STUDY OF MULTILEVEL INVERTER (ppt)
 
Three phase semi converter
Three phase semi converterThree phase semi converter
Three phase semi converter
 
SOFC perovskite- DFT work
SOFC perovskite- DFT workSOFC perovskite- DFT work
SOFC perovskite- DFT work
 
Load forecasting
Load forecastingLoad forecasting
Load forecasting
 
Jeju Island Smart Grid Project
Jeju Island Smart Grid ProjectJeju Island Smart Grid Project
Jeju Island Smart Grid Project
 
Energy Storage
Energy StorageEnergy Storage
Energy Storage
 
General fuel cell
General fuel cellGeneral fuel cell
General fuel cell
 
Grid Integration of PV
Grid Integration of PVGrid Integration of PV
Grid Integration of PV
 
Report on inverters
Report on invertersReport on inverters
Report on inverters
 
Photovoltaic Devices: Life Cycle Considerations
Photovoltaic Devices: Life Cycle ConsiderationsPhotovoltaic Devices: Life Cycle Considerations
Photovoltaic Devices: Life Cycle Considerations
 
Workshop problems solving
Workshop problems solvingWorkshop problems solving
Workshop problems solving
 
The power generation by using piezoelectric effect
The power generation by using piezoelectric effectThe power generation by using piezoelectric effect
The power generation by using piezoelectric effect
 
Smart Grid - Future Electric Grid
Smart Grid - Future Electric GridSmart Grid - Future Electric Grid
Smart Grid - Future Electric Grid
 
Microgrid
MicrogridMicrogrid
Microgrid
 
Anti-islanding
Anti-islandingAnti-islanding
Anti-islanding
 
Electric Energy Generation, Utilization and Conservation PROBLEMS
Electric Energy Generation, Utilization and Conservation PROBLEMSElectric Energy Generation, Utilization and Conservation PROBLEMS
Electric Energy Generation, Utilization and Conservation PROBLEMS
 
Ni-Cd cell or Nicad battery
Ni-Cd cell or Nicad batteryNi-Cd cell or Nicad battery
Ni-Cd cell or Nicad battery
 
Tidal energy
Tidal energyTidal energy
Tidal energy
 
Electrical materials
Electrical materialsElectrical materials
Electrical materials
 
Single Electron Transistor
Single Electron Transistor Single Electron Transistor
Single Electron Transistor
 

Similar to 2d hear conduction.pdf

Heat flow through concrete floor
Heat flow through concrete floorHeat flow through concrete floor
Heat flow through concrete floorAmy Do
 
IntroductionThis experiment uses the computer program Tracer.docx
IntroductionThis experiment uses the computer program Tracer.docxIntroductionThis experiment uses the computer program Tracer.docx
IntroductionThis experiment uses the computer program Tracer.docxnormanibarber20063
 
Graphical methods for 2 d heat transfer
Graphical methods for 2 d heat transfer Graphical methods for 2 d heat transfer
Graphical methods for 2 d heat transfer Arun Sarasan
 
Numerical methods for 2 d heat transfer
Numerical methods for 2 d heat transferNumerical methods for 2 d heat transfer
Numerical methods for 2 d heat transferArun Sarasan
 
Chapter 5 NUMERICAL METHODS IN HEAT CONDUCTION
Chapter 5NUMERICAL METHODS IN HEAT CONDUCTIONChapter 5NUMERICAL METHODS IN HEAT CONDUCTION
Chapter 5 NUMERICAL METHODS IN HEAT CONDUCTIONAbdul Moiz Dota
 
FINITE DIFFERENCE MODELLING FOR HEAT TRANSFER PROBLEMS
FINITE DIFFERENCE MODELLING FOR HEAT TRANSFER PROBLEMSFINITE DIFFERENCE MODELLING FOR HEAT TRANSFER PROBLEMS
FINITE DIFFERENCE MODELLING FOR HEAT TRANSFER PROBLEMSroymeister007
 
Cfd simulation of telecommunications cabinet
Cfd simulation of telecommunications cabinetCfd simulation of telecommunications cabinet
Cfd simulation of telecommunications cabinetmahdi Mokrane
 
Mathematical modeling-of-gas-turbine-blade-cooling
Mathematical modeling-of-gas-turbine-blade-coolingMathematical modeling-of-gas-turbine-blade-cooling
Mathematical modeling-of-gas-turbine-blade-coolingCemal Ardil
 
Modeling and-simulating-of-gas-turbine-cooled-blades
Modeling and-simulating-of-gas-turbine-cooled-bladesModeling and-simulating-of-gas-turbine-cooled-blades
Modeling and-simulating-of-gas-turbine-cooled-bladesCemal Ardil
 
Numerical modeling-of-gas-turbine-engines
Numerical modeling-of-gas-turbine-enginesNumerical modeling-of-gas-turbine-engines
Numerical modeling-of-gas-turbine-enginesCemal Ardil
 
Finite Element Analysis Rajendra M.pdf
Finite Element Analysis Rajendra M.pdfFinite Element Analysis Rajendra M.pdf
Finite Element Analysis Rajendra M.pdfRaviSekhar35
 
Estimation of hottest spot temperature
Estimation of hottest spot temperatureEstimation of hottest spot temperature
Estimation of hottest spot temperatureRana Ateeq ur Rehman
 
An Introduction to the Finite Element Method
An Introduction to the Finite Element MethodAn Introduction to the Finite Element Method
An Introduction to the Finite Element MethodMohammad Tawfik
 
Alternating direction-implicit-finite-difference-method-for-transient-2 d-hea...
Alternating direction-implicit-finite-difference-method-for-transient-2 d-hea...Alternating direction-implicit-finite-difference-method-for-transient-2 d-hea...
Alternating direction-implicit-finite-difference-method-for-transient-2 d-hea...Abimbola Ashaju
 

Similar to 2d hear conduction.pdf (20)

Lecture22
Lecture22Lecture22
Lecture22
 
Heat flow through concrete floor
Heat flow through concrete floorHeat flow through concrete floor
Heat flow through concrete floor
 
IntroductionThis experiment uses the computer program Tracer.docx
IntroductionThis experiment uses the computer program Tracer.docxIntroductionThis experiment uses the computer program Tracer.docx
IntroductionThis experiment uses the computer program Tracer.docx
 
Lecture 1 2
Lecture 1 2Lecture 1 2
Lecture 1 2
 
Graphical methods for 2 d heat transfer
Graphical methods for 2 d heat transfer Graphical methods for 2 d heat transfer
Graphical methods for 2 d heat transfer
 
Numerical methods for 2 d heat transfer
Numerical methods for 2 d heat transferNumerical methods for 2 d heat transfer
Numerical methods for 2 d heat transfer
 
Chapter 5 NUMERICAL METHODS IN HEAT CONDUCTION
Chapter 5NUMERICAL METHODS IN HEAT CONDUCTIONChapter 5NUMERICAL METHODS IN HEAT CONDUCTION
Chapter 5 NUMERICAL METHODS IN HEAT CONDUCTION
 
FINITE DIFFERENCE MODELLING FOR HEAT TRANSFER PROBLEMS
FINITE DIFFERENCE MODELLING FOR HEAT TRANSFER PROBLEMSFINITE DIFFERENCE MODELLING FOR HEAT TRANSFER PROBLEMS
FINITE DIFFERENCE MODELLING FOR HEAT TRANSFER PROBLEMS
 
Introduction to Finite Elements
Introduction to Finite ElementsIntroduction to Finite Elements
Introduction to Finite Elements
 
Cfd simulation of telecommunications cabinet
Cfd simulation of telecommunications cabinetCfd simulation of telecommunications cabinet
Cfd simulation of telecommunications cabinet
 
Mathematical modeling-of-gas-turbine-blade-cooling
Mathematical modeling-of-gas-turbine-blade-coolingMathematical modeling-of-gas-turbine-blade-cooling
Mathematical modeling-of-gas-turbine-blade-cooling
 
Modeling and-simulating-of-gas-turbine-cooled-blades
Modeling and-simulating-of-gas-turbine-cooled-bladesModeling and-simulating-of-gas-turbine-cooled-blades
Modeling and-simulating-of-gas-turbine-cooled-blades
 
Transient heat conduction
Transient heat conductionTransient heat conduction
Transient heat conduction
 
2000symp16
2000symp162000symp16
2000symp16
 
Numerical modeling-of-gas-turbine-engines
Numerical modeling-of-gas-turbine-enginesNumerical modeling-of-gas-turbine-engines
Numerical modeling-of-gas-turbine-engines
 
Finite Element Analysis Rajendra M.pdf
Finite Element Analysis Rajendra M.pdfFinite Element Analysis Rajendra M.pdf
Finite Element Analysis Rajendra M.pdf
 
Estimation of hottest spot temperature
Estimation of hottest spot temperatureEstimation of hottest spot temperature
Estimation of hottest spot temperature
 
SPIE-9150-72
SPIE-9150-72SPIE-9150-72
SPIE-9150-72
 
An Introduction to the Finite Element Method
An Introduction to the Finite Element MethodAn Introduction to the Finite Element Method
An Introduction to the Finite Element Method
 
Alternating direction-implicit-finite-difference-method-for-transient-2 d-hea...
Alternating direction-implicit-finite-difference-method-for-transient-2 d-hea...Alternating direction-implicit-finite-difference-method-for-transient-2 d-hea...
Alternating direction-implicit-finite-difference-method-for-transient-2 d-hea...
 

Recently uploaded

University management System project report..pdf
University management System project report..pdfUniversity management System project report..pdf
University management System project report..pdfKamal Acharya
 
Intze Overhead Water Tank Design by Working Stress - IS Method.pdf
Intze Overhead Water Tank  Design by Working Stress - IS Method.pdfIntze Overhead Water Tank  Design by Working Stress - IS Method.pdf
Intze Overhead Water Tank Design by Working Stress - IS Method.pdfSuman Jyoti
 
Call for Papers - International Journal of Intelligent Systems and Applicatio...
Call for Papers - International Journal of Intelligent Systems and Applicatio...Call for Papers - International Journal of Intelligent Systems and Applicatio...
Call for Papers - International Journal of Intelligent Systems and Applicatio...Christo Ananth
 
FULL ENJOY Call Girls In Mahipalpur Delhi Contact Us 8377877756
FULL ENJOY Call Girls In Mahipalpur Delhi Contact Us 8377877756FULL ENJOY Call Girls In Mahipalpur Delhi Contact Us 8377877756
FULL ENJOY Call Girls In Mahipalpur Delhi Contact Us 8377877756dollysharma2066
 
PVC VS. FIBERGLASS (FRP) GRAVITY SEWER - UNI BELL
PVC VS. FIBERGLASS (FRP) GRAVITY SEWER - UNI BELLPVC VS. FIBERGLASS (FRP) GRAVITY SEWER - UNI BELL
PVC VS. FIBERGLASS (FRP) GRAVITY SEWER - UNI BELLManishPatel169454
 
Booking open Available Pune Call Girls Koregaon Park 6297143586 Call Hot Ind...
Booking open Available Pune Call Girls Koregaon Park  6297143586 Call Hot Ind...Booking open Available Pune Call Girls Koregaon Park  6297143586 Call Hot Ind...
Booking open Available Pune Call Girls Koregaon Park 6297143586 Call Hot Ind...Call Girls in Nagpur High Profile
 
BSides Seattle 2024 - Stopping Ethan Hunt From Taking Your Data.pptx
BSides Seattle 2024 - Stopping Ethan Hunt From Taking Your Data.pptxBSides Seattle 2024 - Stopping Ethan Hunt From Taking Your Data.pptx
BSides Seattle 2024 - Stopping Ethan Hunt From Taking Your Data.pptxfenichawla
 
Call Girls Pimpri Chinchwad Call Me 7737669865 Budget Friendly No Advance Boo...
Call Girls Pimpri Chinchwad Call Me 7737669865 Budget Friendly No Advance Boo...Call Girls Pimpri Chinchwad Call Me 7737669865 Budget Friendly No Advance Boo...
Call Girls Pimpri Chinchwad Call Me 7737669865 Budget Friendly No Advance Boo...roncy bisnoi
 
chapter 5.pptx: drainage and irrigation engineering
chapter 5.pptx: drainage and irrigation engineeringchapter 5.pptx: drainage and irrigation engineering
chapter 5.pptx: drainage and irrigation engineeringmulugeta48
 
VIP Call Girls Palanpur 7001035870 Whatsapp Number, 24/07 Booking
VIP Call Girls Palanpur 7001035870 Whatsapp Number, 24/07 BookingVIP Call Girls Palanpur 7001035870 Whatsapp Number, 24/07 Booking
VIP Call Girls Palanpur 7001035870 Whatsapp Number, 24/07 Bookingdharasingh5698
 
Double Revolving field theory-how the rotor develops torque
Double Revolving field theory-how the rotor develops torqueDouble Revolving field theory-how the rotor develops torque
Double Revolving field theory-how the rotor develops torqueBhangaleSonal
 
Top Rated Pune Call Girls Budhwar Peth ⟟ 6297143586 ⟟ Call Me For Genuine Se...
Top Rated  Pune Call Girls Budhwar Peth ⟟ 6297143586 ⟟ Call Me For Genuine Se...Top Rated  Pune Call Girls Budhwar Peth ⟟ 6297143586 ⟟ Call Me For Genuine Se...
Top Rated Pune Call Girls Budhwar Peth ⟟ 6297143586 ⟟ Call Me For Genuine Se...Call Girls in Nagpur High Profile
 
ONLINE FOOD ORDER SYSTEM PROJECT REPORT.pdf
ONLINE FOOD ORDER SYSTEM PROJECT REPORT.pdfONLINE FOOD ORDER SYSTEM PROJECT REPORT.pdf
ONLINE FOOD ORDER SYSTEM PROJECT REPORT.pdfKamal Acharya
 
Generative AI or GenAI technology based PPT
Generative AI or GenAI technology based PPTGenerative AI or GenAI technology based PPT
Generative AI or GenAI technology based PPTbhaskargani46
 
CCS335 _ Neural Networks and Deep Learning Laboratory_Lab Complete Record
CCS335 _ Neural Networks and Deep Learning Laboratory_Lab Complete RecordCCS335 _ Neural Networks and Deep Learning Laboratory_Lab Complete Record
CCS335 _ Neural Networks and Deep Learning Laboratory_Lab Complete RecordAsst.prof M.Gokilavani
 
VIP Call Girls Ankleshwar 7001035870 Whatsapp Number, 24/07 Booking
VIP Call Girls Ankleshwar 7001035870 Whatsapp Number, 24/07 BookingVIP Call Girls Ankleshwar 7001035870 Whatsapp Number, 24/07 Booking
VIP Call Girls Ankleshwar 7001035870 Whatsapp Number, 24/07 Bookingdharasingh5698
 
Thermal Engineering-R & A / C - unit - V
Thermal Engineering-R & A / C - unit - VThermal Engineering-R & A / C - unit - V
Thermal Engineering-R & A / C - unit - VDineshKumar4165
 
The Most Attractive Pune Call Girls Manchar 8250192130 Will You Miss This Cha...
The Most Attractive Pune Call Girls Manchar 8250192130 Will You Miss This Cha...The Most Attractive Pune Call Girls Manchar 8250192130 Will You Miss This Cha...
The Most Attractive Pune Call Girls Manchar 8250192130 Will You Miss This Cha...ranjana rawat
 
KubeKraft presentation @CloudNativeHooghly
KubeKraft presentation @CloudNativeHooghlyKubeKraft presentation @CloudNativeHooghly
KubeKraft presentation @CloudNativeHooghlysanyuktamishra911
 

Recently uploaded (20)

University management System project report..pdf
University management System project report..pdfUniversity management System project report..pdf
University management System project report..pdf
 
Intze Overhead Water Tank Design by Working Stress - IS Method.pdf
Intze Overhead Water Tank  Design by Working Stress - IS Method.pdfIntze Overhead Water Tank  Design by Working Stress - IS Method.pdf
Intze Overhead Water Tank Design by Working Stress - IS Method.pdf
 
Call for Papers - International Journal of Intelligent Systems and Applicatio...
Call for Papers - International Journal of Intelligent Systems and Applicatio...Call for Papers - International Journal of Intelligent Systems and Applicatio...
Call for Papers - International Journal of Intelligent Systems and Applicatio...
 
FULL ENJOY Call Girls In Mahipalpur Delhi Contact Us 8377877756
FULL ENJOY Call Girls In Mahipalpur Delhi Contact Us 8377877756FULL ENJOY Call Girls In Mahipalpur Delhi Contact Us 8377877756
FULL ENJOY Call Girls In Mahipalpur Delhi Contact Us 8377877756
 
PVC VS. FIBERGLASS (FRP) GRAVITY SEWER - UNI BELL
PVC VS. FIBERGLASS (FRP) GRAVITY SEWER - UNI BELLPVC VS. FIBERGLASS (FRP) GRAVITY SEWER - UNI BELL
PVC VS. FIBERGLASS (FRP) GRAVITY SEWER - UNI BELL
 
Booking open Available Pune Call Girls Koregaon Park 6297143586 Call Hot Ind...
Booking open Available Pune Call Girls Koregaon Park  6297143586 Call Hot Ind...Booking open Available Pune Call Girls Koregaon Park  6297143586 Call Hot Ind...
Booking open Available Pune Call Girls Koregaon Park 6297143586 Call Hot Ind...
 
BSides Seattle 2024 - Stopping Ethan Hunt From Taking Your Data.pptx
BSides Seattle 2024 - Stopping Ethan Hunt From Taking Your Data.pptxBSides Seattle 2024 - Stopping Ethan Hunt From Taking Your Data.pptx
BSides Seattle 2024 - Stopping Ethan Hunt From Taking Your Data.pptx
 
Call Girls Pimpri Chinchwad Call Me 7737669865 Budget Friendly No Advance Boo...
Call Girls Pimpri Chinchwad Call Me 7737669865 Budget Friendly No Advance Boo...Call Girls Pimpri Chinchwad Call Me 7737669865 Budget Friendly No Advance Boo...
Call Girls Pimpri Chinchwad Call Me 7737669865 Budget Friendly No Advance Boo...
 
chapter 5.pptx: drainage and irrigation engineering
chapter 5.pptx: drainage and irrigation engineeringchapter 5.pptx: drainage and irrigation engineering
chapter 5.pptx: drainage and irrigation engineering
 
VIP Call Girls Palanpur 7001035870 Whatsapp Number, 24/07 Booking
VIP Call Girls Palanpur 7001035870 Whatsapp Number, 24/07 BookingVIP Call Girls Palanpur 7001035870 Whatsapp Number, 24/07 Booking
VIP Call Girls Palanpur 7001035870 Whatsapp Number, 24/07 Booking
 
Double Revolving field theory-how the rotor develops torque
Double Revolving field theory-how the rotor develops torqueDouble Revolving field theory-how the rotor develops torque
Double Revolving field theory-how the rotor develops torque
 
Top Rated Pune Call Girls Budhwar Peth ⟟ 6297143586 ⟟ Call Me For Genuine Se...
Top Rated  Pune Call Girls Budhwar Peth ⟟ 6297143586 ⟟ Call Me For Genuine Se...Top Rated  Pune Call Girls Budhwar Peth ⟟ 6297143586 ⟟ Call Me For Genuine Se...
Top Rated Pune Call Girls Budhwar Peth ⟟ 6297143586 ⟟ Call Me For Genuine Se...
 
ONLINE FOOD ORDER SYSTEM PROJECT REPORT.pdf
ONLINE FOOD ORDER SYSTEM PROJECT REPORT.pdfONLINE FOOD ORDER SYSTEM PROJECT REPORT.pdf
ONLINE FOOD ORDER SYSTEM PROJECT REPORT.pdf
 
Generative AI or GenAI technology based PPT
Generative AI or GenAI technology based PPTGenerative AI or GenAI technology based PPT
Generative AI or GenAI technology based PPT
 
CCS335 _ Neural Networks and Deep Learning Laboratory_Lab Complete Record
CCS335 _ Neural Networks and Deep Learning Laboratory_Lab Complete RecordCCS335 _ Neural Networks and Deep Learning Laboratory_Lab Complete Record
CCS335 _ Neural Networks and Deep Learning Laboratory_Lab Complete Record
 
VIP Call Girls Ankleshwar 7001035870 Whatsapp Number, 24/07 Booking
VIP Call Girls Ankleshwar 7001035870 Whatsapp Number, 24/07 BookingVIP Call Girls Ankleshwar 7001035870 Whatsapp Number, 24/07 Booking
VIP Call Girls Ankleshwar 7001035870 Whatsapp Number, 24/07 Booking
 
Thermal Engineering-R & A / C - unit - V
Thermal Engineering-R & A / C - unit - VThermal Engineering-R & A / C - unit - V
Thermal Engineering-R & A / C - unit - V
 
The Most Attractive Pune Call Girls Manchar 8250192130 Will You Miss This Cha...
The Most Attractive Pune Call Girls Manchar 8250192130 Will You Miss This Cha...The Most Attractive Pune Call Girls Manchar 8250192130 Will You Miss This Cha...
The Most Attractive Pune Call Girls Manchar 8250192130 Will You Miss This Cha...
 
KubeKraft presentation @CloudNativeHooghly
KubeKraft presentation @CloudNativeHooghlyKubeKraft presentation @CloudNativeHooghly
KubeKraft presentation @CloudNativeHooghly
 
(INDIRA) Call Girl Aurangabad Call Now 8617697112 Aurangabad Escorts 24x7
(INDIRA) Call Girl Aurangabad Call Now 8617697112 Aurangabad Escorts 24x7(INDIRA) Call Girl Aurangabad Call Now 8617697112 Aurangabad Escorts 24x7
(INDIRA) Call Girl Aurangabad Call Now 8617697112 Aurangabad Escorts 24x7
 

2d hear conduction.pdf

  • 1. Finite Element Method 2D heat conduction 1 Heat conduction in two dimensions  All real bodies are three-dimensional (3D)  If the heat supplies, prescribed temperatures and material characteristics are independent of the z-coordinate, the domain can be approximated with a 2D domain with the thickness t(x,y)
  • 2. Finite Element Method 2D heat conduction 2 Discretization into two-dimensional finite elements  The body is discretized with a number of finite elements  They can be triangular or quadrilateral  Straight or curved element sides
  • 3. Finite Element Method 2D heat conduction 3 Today’s elements  Melosh element  Four nodes  Only right angles  Must be aligned with the coordinate axes Element side (edge) Element node at the corner (vertex) Element interior  Constant strain triangle (CST)  Three nodes  Arbitrary angles  Arbitrary orientation  Isoparametric four-node element  Four nodes  Arbitrary angles  Arbitrary orientation
  • 4. Finite Element Method 2D heat conduction 4 Other useful elements  Triangular six-node element with straight edges and midside nodes (Lecture 8 + 9)  Triangular isoparametric six-node element with curved edges and off-midside nodes  Isoparametric eight-noded elements with straight edges and midside nodes  Isoparametric eight-noded elements with curved edges and off-midside nodes (Lecture 8 + 9)
  • 5. Finite Element Method 2D heat conduction 5 The patch test  The main exercise of today is the patch test. You will program its main parts and use it to verify that the elements work properly.  A patch test should include at least one internal node  The patch test should be as unconstrained as possible, i.e. the temperature should be specified at only one node.  Before we go into the equations of 2D heat conduction, you must now start MatLab and do a small exercise.
  • 6. Finite Element Method 2D heat conduction 6 Exercise: Program and plot the geometry and topology of a 2D patch test for the Melosh, CST and ISO4 elements Melosh etype = 1 CST etype = 3 Iso4 etype = 7 Coord = [ x1 y1 z1 ; x2 y2 y3 ; …. ] % Nodal coordinates in file “Coordinates.m” Top = [ etype section etc ] % for each element in the file “Topology.m” Plot by executing the line “visualize2D”
  • 7. Finite Element Method 2D heat conduction 7 Basic steps of the finite-element method (FEM) 1. Establish strong formulation  Partial differential equation 2. Establish weak formulation  Multiply with arbitrary field and integrate over element 3. Discretize over space  Mesh generation 4. Select shape and weight functions  Galerkin method 5. Compute element stiffness matrix  Local and global system 6. Assemble global system stiffness matrix 7. Apply nodal boundary conditions  temperature/flux/forces/forced displacements 8. Solve global system of equations  Solve for nodal values of the primary variables (displacements/temperature) 9. Compute temperature/stresses/strains etc. within the element  Using nodal values and shape functions
  • 8. Finite Element Method 2D heat conduction 8 Step 1: Establish strong formulation for 2D heat conduction (OP pp. 76-84) Heat flow (flux) vector Boundary normal Heat flow out of the boundary (the flux) 1D: 2D: q = ½ qx qy ¾ · J m2s ¸ n = ½ nx ny ¾ jnj = 1 qn = q ¢ n = qT n
  • 9. Finite Element Method 2D heat conduction 9 The constitutive relation in matrix notation: , material isotropy leads to
  • 10. Finite Element Method 2D heat conduction 10 Energy conservation and a time independent problem leads to: The amount of heat (energy) supplied to the body per unit of time must equal the amount of heat leaving the body per unit time: Rearranging leads to Q is internal heat supply [J/m3s] Prescribed quantities Gauss’ divergence theorem (OP p. 73) Divergence: t is the thickness [m]
  • 11. Finite Element Method 2D heat conduction 11 Written out, the strong form for stationary 2D heat conduction is Insertion of the constitutive relation leads to the strong formulation: Prescribed quantities Boundary conditions
  • 12. Finite Element Method 2D heat conduction 12 Step 2: Establish weak formulation for 2D heat conduction (Cook pp. 136-137, 151), (OP Chapter 5, pp. 84-86) Multiply the strong formulation with a weight function v(x,y) and integrate over the domain Prescribed quantities The Green-Gauss theorem (OP p. 74) Inserting into the first equation while replacing yields
  • 13. Finite Element Method 2D heat conduction 13 The boundary integral is split into two terms to reflect the two different types of boundary conditions Prescribed quantities Insertion into the top equation followed by rearranging leads to the weak form of 2D heat flow Boundary conditions Internal heat supply (heat load)
  • 14. Finite Element Method 2D heat conduction 14 Basic steps of the finite-element method (FEM) 1. Establish strong formulation  Partial differential equation 2. Establish weak formulation  Multiply with arbitrary field and integrate over element 3. Discretize over space  Mesh generation 4. Select shape and weight functions  Galerkin method 5. Compute element stiffness matrix  Local and global system 6. Assemble global system stiffness matrix 7. Apply nodal boundary conditions  temperature/flux/forces/forced displacements 8. Solve global system of equations  Solve for nodal values of the primary variables (displacements/temperature) 9. Compute temperature/stresses/strains etc. within the element  Using nodal values and shape functions
  • 15. Finite Element Method 2D heat conduction 15 Step 3: Discretize over space Now the domain is discretized into a number of finite elements. This determines the mesh coordinates and the element topology, i.e. the matrices coord and Top in our MatLab program. Here it is illustrated with a single Melosh element.
  • 16. Finite Element Method 2D heat conduction 16 Step 4: Weight and shape functions The Galerkin method is chosen. This means that the main variable (the temperature) and the weight function v(x,y) are interpolated using the same interpolation functions Known shape functions (depends only on x and y) Unknown nodal values Examples:
  • 17. Finite Element Method 2D heat conduction 17 The weak form can now be written as Noticing that v and a are constants, rearranging yields Because v is arbitrary the parenthesis term must vanish (equal zero) where
  • 18. Finite Element Method 2D heat conduction 18 In order to be able to write the equations in a compact form the following terms are introduced The equations can now be written as Example: The Melosh heat conduction element: The stiffness matrix Boundary terms (boundary load vector) Internal load vector Degrees of freedom, dof
  • 19. Finite Element Method 2D heat conduction 19 The definition of the heat flux was With the finite element formulation we have This gives us the flux within the element as
  • 20. Finite Element Method 2D heat conduction 20 Example: The melosh element Notice that Ni vary linearly along element edges. Example: Shape and weight functions This ensures inter-element combatibility, i.e. no gaps and no overlapping:
  • 21. Finite Element Method 2D heat conduction 21 Assumptions: D and t are constant. Element width: 2a, height 2b Steps: 1. Compute B-matrix 2. Carry out matrix multiplication 3. Integrate each element of the matrix product to obtain K 4. Program K into the file KmeloshHeat.m 5. A test value with the parameters, 2a = 2, 2b = 1, t = 1.3, kxx = 4.56, kyy = 3.8 is : Exercise: compute and program the Melosh stiffness matrix
  • 22. Finite Element Method 2D heat conduction 22 Example: constant heat supply between nodes 1 and 2 Boundary load vector Prescribed term Can only contain nodal values Remember: If heat is transferred into the domain, q is negative Can only contain values at nodes. So uniform heat supplies must be converted into nodal loads Unit: J/s Reactions
  • 23. Finite Element Method 2D heat conduction 23 Exercise: Calculate fb with triangular heat load Prescribed term Can only contain nodal values Remember: If heat is transferred into the domain, q is negative The heat load varies linearly from zero at node 2 to the value q3 at node 3 Steps: 1. Find the expression for the heat load as a function of the coordinates q(x,y) 2. Carry out the integration as shown on the previous slide.
  • 24. Finite Element Method 2D heat conduction 24 Example: constant internal heat supply in a Melosh element Internal load vector Can only contain values at nodes. So internal heat supplies must be converted into nodal loads Q is internal heat supply [J/m3s] Element area A = 4 ab
  • 25. Finite Element Method 2D heat conduction 25  The assembling procedure is exactly the same as in the last lecture: 1. Determine the local stiffness matrix 2. determine the global number of dof corresponding to the local dof for the element 3. add the components of the local stiffness matrix to the rows and columns of the global stiffness matrix corresponding to the global dof numbers 4. repeat 1-3 until all contributions from all elements have been added.  In MatLab this is done in assemblering.m K(gDof,gDof) = K(gDof,gDof) + Ke; Step 6: Assembling
  • 26. Finite Element Method 2D heat conduction 26  In order to be able to create a global system matrix we need to give information about  Material for each element  Section dimensions for each element  Coordinates for each node (and a numbering)  Topology for each element (which nodes are in the element)  dof numbering is given from the node numbering and number of dofs per node (one in this case)  See calc_globdof.m for numbering of global dof  ElemDof = [neDof1 GDof1 GDof2 ...]  dof numbering of each element  GlobDof = [Gnode1 GDof1 GDof2 ...]  dof numbering of each node (used for plotting)  nDof = total number of Dof
  • 27. Finite Element Method 2D heat conduction 27 Example of assembling the load vector Total heat load vector The global matrices are assembled in exactly the same way as with the bar elements of the previous lecture. Here an example of the assembly of the load vector of a two element system is shown The thicknesses of the two elements are identical Remember: If heat is transferred into the domain, q is negative
  • 28. Finite Element Method 2D heat conduction 28 Exercise: Program and plot the results of a 2D patch test for the Melosh element t = 1.2 m, kxx = kyy = 3 J/Cms Steps 1. Program the geometry (done earlier today) 2. Determine nodal heat supplies q3, q6, and q9 3. Determine nodal heat supply q4 and q7 (We want T = 0 on the left boundary, x = 0) 4. Make the appropriate programming in Topology.m and BoundaryConditions.m 5. Plot by executing the line “visualizeD2 Compare with the analytical solution: Hint: on the colorplot the temperatures can be found by activating the figure and typing “colorbar” at the command line
  • 29. Finite Element Method 2D heat conduction 29 Why use other elements than the Melosh element? • The Melosh element must be rectangular and positioned along the coordinate axes • It is therefore not very good at approximating boundaries not aligned with the coordinate axes • Conclusion: The Melosh element is not very flexible Why use triangular elements? • Triangular elements can be rotated arbitrarily • They can therefore approximate boundaries not aligned with coordinate axes well. • It is relatively simple to make a computer code that meshes an arbitrary area with triangles. Next: The constant strain triangle (CST) • The name stems from its original development within structural mechanics • In heat conduction analysis the name “constrant flux triangle” would be appropriate
  • 30. Finite Element Method 2D heat conduction 30 Preliminary: Natural coordinates (Area coordinates) • For general triangular elements it has proven useful to derive the stiffness matrix using the so-called “natural coordinates” also referred to as “area coordinates Point P defines three areas. These define the natural coordinate of the point The following constraint applies Examples: Element centroid: Node 1 Node 3
  • 31. Finite Element Method 2D heat conduction 31 The relation between natural and cartesian coordinates is In matrix notation With the coordinate transformation matrix A here The element area can be found by
  • 32. Finite Element Method 2D heat conduction 32 Differentiation in natural coordinates A function N (e.g. a shape function) is expressed in natural coordinates, N(1, 2, 3). The chain rule then gives us With the coordinate transformation we get
  • 33. Finite Element Method 2D heat conduction 33 Integration in natural coordinates A polynomial function expressed in natural coordinates, f(1, 2, 3) can easily be integrated over the element area using the formula Example:
  • 34. Finite Element Method 2D heat conduction 34 Shape functions for the CST-element The shape functions for the CST-element in natural coordinates are very simple: The temperature in the element interior is then given by The stiffness matrix is again given by with
  • 35. Finite Element Method 2D heat conduction 35 Exercise: Calculate and program the stiffness matrix of the heat conduction CST-element Steps 1. Determine the derivatives in the B-matrix 2. Setup the B-matrix. Think about and explain why the element name “constant flux element” is appropriate (hint on slide 18) 3. Carry out the matrix multiplication indicated on the previous slide. 4. Integrate over the element area to obtain the stiffness matrix K 5. Program the stiffness matrix into the file K_CST_Heat.m 6. A test value with the parameters (x1, x2, x3) = (1, 3, -1), (y1, y2, y3) = (0, 2, 1), t = 1.3, kxx = 4.7 and kyy = 5.1 is
  • 36. Finite Element Method 2D heat conduction 36 Exercise: Program and plot the results of a 2D patch test for the CST element t = 1.2 m, kxx = kyy = 3 W/ Cm Steps 1. Program the geometry (done earlier today) 2. Determine nodal heat supplies q3, q6, and q9 3. Determine nodal heat supply q4 and q7 (We want T = 0 on the left boundary, x = 0) 4. Make the appropriate programming in Topology.m and BoundaryConditions.m 5. Plot by executing the line “visualizeD2 Compare with the analytical solution: Hint: on the colorplot the temperatures can be found by activating the figure and typing “colorbar” at the command line
  • 37. Finite Element Method 2D heat conduction 37 The isoparametric four node element (Iso4) • A quadrilateral element which can be distorted from the rectangular shape and rotated arbitrarily in the plane • Introduces several important concepts in finite element theory, such as • Isoparametric coordinates • Parent and global domain • The Jacobian matrix and the Jacobian • Numerical integration by Gauss quadrature • The isoparametric formulation forms the basis for nearly all the elements in practical use
  • 38. Finite Element Method 2D heat conduction 38 Parent and global domain • For general quadrilateral elements is has proven useful to formulate the stiffness matrix using the isoparametric formulation. • In the parent domain the element is always a square element with the side length 2. • The isoparametric coordinates  and  have their origin at the element centroid. This means that the vertex (corner) nodes have the coordinates (,): 1: (-1,-1), 2: (1,-1), 3: (1,1) and 4: (-1,1) • In the global domain the nodes of the four node element have the coordinates: (x,y): 1: (x1,y1), 2: (x2,y2), 3: (x3,y3), and 4: (x4,y4). • The question is “how do we connect these two sets of coordinates?” (much in a similar way as we did with the triangle.) Note: with the natural coordinates of the triangle the coordinate limits were 0  1, 2, 3  1. For the isoparametric coordinates they are -1  ,   1 Parent domain Global domain
  • 39. Finite Element Method 2D heat conduction 39 The isoparametric coordinate transformation • The idea is that we use the shape functions to interpolate the coordinates between the nodes Parent domain Global domain e.g. With the shape functions: Notice that these are the shape functions of the Melosh element with a = b = 1
  • 40. Finite Element Method 2D heat conduction 40 Temperature and flux interpolation As usual the temperature within the element is inter- polated from the nodal values Parent domain Global domain The heat flux is also still given by with Problem: we have to find the derivatives of the shape functions with respect to the global (x,y) coordinates, but the shape functions are expressed in the isoparametric (,) coordinates. To overcome this problem we will define B as a product of two matrices:
  • 41. Finite Element Method 2D heat conduction 41 Parent domain Global domain The matrix DN contains the derivatives of the shape functions with respect to the isoparametric coordinates With DN the temperature derivatives within the element can be found by If we wanted the temperature derivatives the (,)- coordinates we were done now. But we need them in the (x,y) system in order to determine the heat flux. The transformation of derivatives from the (,) system into the (x,y) system is carried out by the inverse of the so- called “Jacobian matrix”, J-1
  • 42. Finite Element Method 2D heat conduction 42 Parent domain Global domain The matrix J is called “the Jacobian matrix” and it relates the temperature derivatives in the two coordinate systems The elements of J can be found by differentiating the temperature with respect to (, ) by invoking the chain rule: The Jacobian matrix This gives us the elements of J
  • 43. Finite Element Method 2D heat conduction 43 Parent domain Global domain The inverse of J, which was needed in the expression for B, , can now be found by where the determinant of J, which is often called “the Jacobian”, is given by The Jacobian The Jacobian can be regarded as a scale factor that relates infinitesimal areas in the parent domain and the global domain, see (Cook pp. 206 – 207), (OP pp. 376 – 380)
  • 44. Finite Element Method 2D heat conduction 44 Parent domain Global domain The definition of the stiffness matrix was Stiffness matrix for the Iso4 element With the Jacobian matrix and its determinant we now have the tools to calculate the stiffness matrix of a isoparametric quadrilateral element. The integral is non-linear and can, in general, not be solved analytically. Therefore we must use numerical integration. As a remark it should be mentioned that the shape functions are still linear along the element sides. This means that boundary loads are distributed to the nodes in the same way as it was done with the Melosh element.
  • 45. Finite Element Method 2D heat conduction 45 Our concern is to find the following integral numerically Numerical integration One way of doing this is to divide the domain in n equal intervals of equal width W, and sum up the contribution from n rectangular areas with the height given by the function value in the centre of the intervals A second method is analogous to the above but with varying interval widths Wi Both methods will converge towards the exact integral when the number of intervals, n, increases.
  • 46. Finite Element Method 2D heat conduction 46 The position of the evaluation points xi and the size of the widths (also called weight factors) can be optimized with respect to the function that is integrated. For integrals of polynomials in the interval [-1 ; 1] this in known as the so- called Gauss quadrature. Notice that this is the interval we are interested in with isoparametric elements as the isoparametric coordinates -1  ,  1. With Gauss quadrature we can evaluate integrals as Gauss quadrature with the following positions and weights
  • 47. Finite Element Method 2D heat conduction 47 Gauss points and weights A polynomium of degree 2n – 1 is integrated exact with a Gauss quadrature of degree n.
  • 48. Finite Element Method 2D heat conduction 48 Gauss quadrature in two dimensions For the calculation of the stiffness matrix we need the Gauss quadrature in two dimensions. This is obtained as follows Example: Numerical integration of (,) with Gauss order n = 2, which gives 22 = 4 points:
  • 49. Finite Element Method 2D heat conduction 49 Exercise: Numerical integration of two functions in 2D Steps 1. Open NumIntExc_Lec34_student.m 2. In the loop calculate the function value Φ at each Gauss point 3. Sum the integral in the variable “numint”. Remember the weight functions (see the previous slide) 4. Save the exact solution in the variable “int_exact”. 5. Start with one Gausspoint, then two, and so on.. 6. Run the program by pressing F5. What is different about the two functions? 1 1 2 3       function 1: exact solution 1 1 1 1 1 2 2 ln5 3 d d            3 2 1 1 2 3          function 2: exact solution 1 1 2 1 1 28 3 d d         
  • 50. Finite Element Method 2D heat conduction 50 Exercise: Calculate and program the stiffness matrix of the heat conduction Iso4-element Steps 1. Open the file K_QuadIso_Heat.m 2. Setup a loop over the Gauss points 3. Initiate the stiffness matrix as zeros 4. Perform steps 5 to 9 inside a loop over the Gauss points 5. Calculate the and setup the DN-matrix 6. Calculate the Jacobian matrix 7. Calculate the determinant of the Jacobian matrix 8. Calculate the inverse Jacobian matrix 9. Calculate the integral at the current Gauss point and add it to the current value of the stiffness matrix, Ke 10. A test value with the parameters (x1, x2, x3, x4) = (1, 3, 3.5, -1), (y1, y2, y3, y4) = (0, -1, 1 1), t = 1.3, kxx = 4.7 and kyy = 5.1 n = 2 (Gauss order)
  • 51. Finite Element Method 2D heat conduction 51 Exercise: Program and plot the results of a 2D patch test for the Iso4 element t = 1.2 m, kxx = kyy = 3 J/Cms Steps 1. Program the geometry (done earlier today) 2. Determine nodal heat supplies q3, q6, and q9 3. Determine nodal heat supply q4 and q7 (We want T = 0 on the left boundary, x = 0) 4. Make the appropriate programming in Topology.m and BoundaryConditions.m 5. Plot by executing the line “visualizeD2 Compare with the analytical solution: Hint: on the colorplot the temperatures can be found by activating the figure and typing “colorbar” at the command line
  • 52. Finite Element Method 2D heat conduction 52 Exercise: Get familiar with the program and test the different elements We will now try to carry out a calculation of the temperature in the tapered beam from the last lecture. This time we will use 2D elements. • Set the variable atype = 2 in main.m • Try to run the program • The number of elements can be controlled by changing the variable nelem_y in Coordinates.m • Does the three elements of todays lecture give the same result? • Does it make any difference what order of Gauss quadrature you use in the Iso4-element? (this is controlled in the file K_QuadIso_Heat.m) • Try to take a look at how the coordinates and the topology is calculated. This might give you inspiration for your own program in the semester project.