This blog post presents some of the finite element theory used in the section properties program in a simplified and easy to understand manner. It is worth noting that the notions used in the section properties program are the same that are applied in commercial finite element solvers. For a more in-depth overview of the section properties program, check out the paper I wrote here.

Building on the preliminaries covered in the previous blog post [finite element preliminaries], we can now quite easily calculate the area related section properties. This blog post will cover the computation of the following properties: cross-section area, first moments of area, second moments of area, area centroids, radii of gyration, elastic section moduli and principal axis properties. A code extract will follow each explanation, showing the implementation of the theory.

The most important formula to remember from the previous post is shown below:

This expression starts with the integration of a function over the domain of the cross section and converts it to a discrete sum which can be evaluated at each Gauss point within each element . We’ll be using this formula in the calculation of most section properties.

Cross-section Area

The area of a cross-section is given by:

Because the Jacobian for our quadratic triangular element is constant, only one Guass point needs to be used for each element. The above formula can be implemented in python with the following code:

# Initialise area variable
area = 0

# Loop through all the elements in the mesh
for el in elements:
  # Determine the Gauss points for 1pt Gaussian quadrature
  gp = gauss_points(1)
  # Determine the shape functions, partial derivatives and Jacobian for the
  # current Gauss point and element described by coordinates xy
  (N, B, j) = shape_function(xy, gp)

  # Evaluate the integral at the current Gauss point and add to the total. Note:
  # gp[0] is the Gauss point weight, and j is the determinant of the Jacobian
  area += gp[0] * j

print "Area = {}".format(area)

First Moments of Area

The first moments of area are defined as:

Discretising the above expression results in the following finite element implementation:

This time, the function to be evaluated is a quadratic function (owing to the quadratic shape functions ) and as a result three Gauss points need to be used. The following code shows a python implementation of the above expressions:

# Initialise first moment of area variables
qx = 0
qy = 0

# Loop through all the elements in the mesh
for el in elements:
  # Determine the Gauss points for 3pt Gaussian quadrature
  gps = gauss_points(3)

  # Loop through each Gauss point for the current element
  for gp in gps:
    # Determine the shape functions, partial derivatives and Jacobian for the
    # current Gauss point and element described by coordinates xy
    (N, B, j) = shape_function(xy, gp)

    # Evaluate the integral at the current Gauss point and add to the total.
    # Note: gp[0] is the Gauss point weight, xy[1,:] are the y-coordinates of
    # the current element, xy[0,:] are the x-coordinates of the current element
    # and j is the determinant of the Jacobian
    qx += gp[0] * np.dot(N, np.transpose(xy[1,:])) * j
    qy += gp[0] * np.dot(N, np.transpose(xy[0,:])) * j

print "qx = {}".format(qx)
print "qy = {}".format(qy)

Second Moments of Area

The second moments of area are defined as:

Discretising the above expression results in the following finite element implementation:

This time, the function to be evaluated is a quartic function and as a result six Gauss points need to be used. The following code shows a python implementation of the above expressions:

# Initialise first moment of area variables
ixx = 0
iyy = 0
ixy = 0

# Loop through all the elements in the mesh
for el in elements:
  # Determine the Gauss points for 3pt Gaussian quadrature
  gps = gauss_points(6)

  # Loop through each Gauss point for the current element
  for gp in gps:
    # Determine the shape functions,{ p}artial derivatives and Jacobian for the
    # current Gauss point and element described by coordinates xy
    (N, B, j) = shape_function(xy, gp)

    # Evaluate the integral at the current Gauss point and add to the total.
    # Note: gp[0] is the Gauss point weight, xy[1,:] are the y-coordinates of
    # the current element, xy[0,:] are the x-coordinates of the current element
    # and j is the determinant of the Jacobian
    ixx += gp[0] * (np.dot(N, np.transpose([1,:]))) ** 2 * j
    iyy += gp[0] * (np.dot(N, np.transpose([0,:]))) ** 2 * j
    ixy += (gp[0] * np.dot(N, np.transpose([0,:])) *
              np.dot(N, np.transpose([1,:])) * j)

print "ixx = {}".format(ixx)
print "iyy = {}".format(iyy)
print "iyy = {}".format(ixy)

The above moments of inertia have been calculated about the global coordinate system, however we are usually more interested in the moments of inertia about the centroidal axis. The global moments of inertia can be transformed to the centroidal axis using the following expressions:

This is easily implemented in python as follows:

ixx_c = ixx - qx * qx / area
iyy_c = iyy - qy * qy / area
ixy_c = ixy - qx * qy / area

Area Centroids, Radii of Gyration and Elastic Section Moduli

These properties can be directly computed from the properties we have already computed. The area centroids are defined as follows:

The radii of gyration are defined as follows:

The elastic section moduli are defined as follows:

The above expressions can be directly computed after executing the previous python code snippets:

# calculate area centroids
x_c = qy / area
y_c = qx / area

# calculate radii of gyration
r_x = (ixx_c / area) ** 0.5
r_y = (iyy_c / area) ** 0.5

# calculate the elastic section moduli
xmax = nodes[:,0].max()
xmin = nodes[:,0].min()
ymax = nodes[:,1].max()
ymin = nodes[:,1].min()

zxx_plus = ixx_c / (ymax - x_c)
zxx_minus = ixx_c / (y_c - ymin)
zyy_plus = iyy_c / (xmax - x_c)
zyy_minus = iyy_c / (x_c - xmin)

Principal Section Properties

The principal bending axes are determined by calculating the principal moments of inertia [1]:

where is defined as follows:

Once the principal moments of inertia are calculated, the angle between the x-axis and the axis belonging to the largest principal moment of inertia can be computed as follows:

The principal radii of gyration can be easily calculated using the new principal moments of inertia. To calculate the principal elastic section moduli, the distance to the extreme fibres in the principal directions needs to be determined. Firstly, a function is written to convert a coordinate in the xy-axis into a principal axis coordinate:

def principal_coordinate(phi, x, y):
    """
    Determines the coordinates of the cartesian point *(x, y)* in the
    principal axis system given an axis rotation angle phi.
    """

    # convert principal axis angle to radians
    phi_rad = phi * np.pi / 180

    # form rotation matrix
    R = np.array([[np.cos(phi_rad), np.sin(phi_rad)],
                  [-np.sin(phi_rad), np.cos(phi_rad)]])

    # calculate rotated x and y coordinates
    x_rotated = R.dot(np.array([x, y]))

    return (x_rotated[0], x_rotated[1])

Now the extreme fibre positions can be calculated by looping through all the nodes and determining the extreme values:

# loop through all points in the mesh
for (i, point) in enumerate(nodes):
    # determine the coordinate of the point wrt the principal axis
    (x1, y2) = (principal_coordinate(phi, point[0] - x_c, point[1] - y_c))

    # initialise min, max variables
    if i == 0:
        x1max = x1
        x1min = x1
        y2max = y2
        y2min = y2

    # update the min and max where necessary
    x1max = max(x1max, x1)
    x1min = min(x1min, x1)
    y2max = max(y2max, y2)
    y2min = min(y2min, y2)

Finally the principal elastic section moduli can be calculated:

# evaluate principal elastic section moduli
z11_plus = i11_c / abs(y2max)
z11_minus = i11_c / abs(y2min)
z22_plus = i22_c / abs(x1max)
z22_minus = i22_c / abs(x1min)

The next blog post will focus on the calculation of the plastic section moduli, a tricky topic which deserves its own separate post.

References

  1. W.D. Pilkey, Analysis and Design of Elastic Beams: Computational Methods, John Wiley & Sons, Inc., New York, 2002.

Leave a comment