Solving Partial Differential Equations with Finite Elements

Introduction

The aim of this tutorial is to give an introductory overview of the finite element method (FEM) as it is implemented in NDSolve. The notebook introduces finite element method concepts for solving partial differential equations (PDEs). First, typical workflows are discussed. The setup of regions, boundary conditions and equations is followed by the solution of the PDE with NDSolve. The visualization and animation of the solution is then introduced, and some theoretical aspects of the finite element method are presented. Classical PDEs such as the Poisson and Heat equations are discussed. Coupled PDEs are also introduced with examples from structural mechanics and fluid dynamics.

Why Finite Elements?

Explicit closed-form solutions for partial differential equations (PDEs) are rarely available. The finite element method (FEM) is a technique to solve partial differential equations numerically. It is important for at least two reasons. First, the FEM is able to solve PDEs on almost any arbitrarily shaped region. Second, the method is well suited for use on a large class of PDEs. While it is almost always possible to conceive better methods for a specific PDE on a specific region, the finite element method performs quite well for a large class of PDEs. In summary, the finite element method is important since it can deal with:

What Is Needed for a Finite Element Analysis

To solve partial differential equations with the finite element method, three components are needed:

The Scope of the Finite Element Method as Implemented in NDSolve

The current version of the implementation of the finite element method supports the following features:

Regions

To perform a finite element analysis, a region over which the partial differential equation is to be solved needs to be defined. Rectangular regions may be specified using {v,vmin,vmax} for each of the spatial independent variables. The exact argument specification is detailed in NDSolveValue.

Solve a Poisson equation and visualize the solution over a rectangular region.

Regions of arbitrary shape may be specified using the notation varsΩ, where Ω is a region so that RegionQ[Ω] gives True.

One way to specify a nonrectangular region is by using Boolean predicates. A predicate is a function that returns either True or False. Since the term predicate has many meanings in mathematical literature, the terminology Boolean predicate is used to emphasize that the predicate returns a Boolean. To describe regions, Boolean predicates can be used as in functions like RegionPlot and RegionPlot3D, for example.

Region setup and visualization.

This tutorial concentrates on solving partial differential equations with the finite element method, without emphasis on the creation of regions and meshes. More detailed information on this topic can be found in "Element Mesh Generation".

Classical Partial Differential Equations

The Coefficient Form of Partial Differential Equations

What types of equations can be solved with the finite element method as implemented in NDSolve? Consider a single partial differential equation in :

The PDE is defined in . Here is the dependent variable for which a solution is sought. The coefficients , , and are scalars; , and are vectors; and is an × matrix.

What follows are some well-known PDEs and their corresponding coefficients. To illustrate the generality of (1), the components that are relevant to a specific equation are red, while the non-relevant components are grayed out.

The Laplace equation simply contains a diffusive term:

To model Poisson's equation, only a small modification is needed; add a load term :

Helmholtz's equation adds a reaction term :

Convection-diffusion-reaction type equations are another common class of PDEs. Compared to the previous examples, these have an additional convection term :

The PDEs considered so far are stationary, i.e. they have no time dependence. The heat equation adds time dependence to the Poisson equation. It has the following form:

Similarly, the wave equation is given as:

Equation (1) provides the components for modeling a range of different phenomena, since it provides spatial derivatives up to order 2.

Poissons Equation with Dirichlet Conditions

The Poisson equation is to be solved over a region with boundary conditions. First, a region needs to be defined where the equation will be solved. Then the equation and boundary conditions are defined. Finally, the equation is solved over the region.

One way to specify a region is by using Boolean predicates.

Region setup and visualization.

Next, define a Poisson operator.

PDE operator setup.

The third step is to set up the boundary conditions. The first boundary condition enforces the dependent variable to a value of 0 wherever the evaluation of x08y10 yields True on the boundary of the region . In this case, this is the upper-left part of the boundary. This type of boundary condition is called a Dirichlet boundary condition. A second Dirichlet boundary condition specifies the value of the dependent variable whenever yields True on the boundary of region . Boundary conditions will be explained in further detail in a later section.

Dirichlet boundary conditions setup.

In the solution step, NDSolve needs the PDE, the boundary conditions and the region.

Solve the PDE.

Internally, the region is converted to a finite element mesh and a finite element method is used to solve the equation automatically.

To visualize the solution, a contour plot can be used.

Visualize the solution.

Partial Differential Equations and Boundary Conditions

NDSolve and related functions allow for specifying three types of spatial boundary conditions: Dirichlet conditions, Neumann values and periodic boundary conditions.

Dirichlet boundary conditions prescribe a constraint on the dependent variable of value on some part of the boundary:

Generalized Neumann boundary values, also known as Robin values or Neumann boundary conditions, specify a value . The value prescribes a flux over the outward normal on some part of the boundary:

The finite element method is based on the weak form of the differential equation. This form is obtained by taking equation (1), multiplying it by a so-called test function , and integrating over the region :

Integration by parts gives:

This process is done internally. The integrand in the boundary integral in (11) can be replaced with (9) and yields:

specifies the value of the boundary integral integrand (11) in the weak form and thus the name NeumannValue.

Instead of making use of integration by parts to obtain equation (11), the divergence theorem and Green's identities can also be used.

Periodic boundary conditions make the dependent variables behave according to a given relation between two distinct parts of the boundary. Other boundary conditions are conceivable, but currently not implemented.

In most cases, Dirichlet boundary conditions need not be associated with a particular equation. They can be specified independently of the equation. Dirichlet boundary conditions are specified as equations. Generalized Neumann values, on the other hand, are specified by giving a value, since the equation satisfied is implicit in the value. Neumann values are mathematically tied to the PDE.

For practical reasons, in NDSolve and related functions, NeumannValue needs to be given as a part of the equation. Consider a system of coupled PDEs. One would like to be able to unambiguously specify any given Neumann value to any given single PDE of that system of PDEs. It is not possible to derive (unambiguously) from the Neumann value with which PDE equation the value should be associated. Making a NeumannValue part of a PDE equation solves this problem without ambiguity. DirichletCondition may also be given in a PDE equation as well.

{op[u[x1,]] ΓN,ΓD,ΓP}partial differential equation with differential operator op, Neumann boundary values ΓN, Dirichlet boundary condition equations ΓD and periodic boundary condition ΓP
{op1[u[x1,],v[x1,],] ΓN1,op2[u[x1,],v[x1,],] ΓN2,,ΓD,ΓP}system of coupled partial differential equation operators opj, Neumann boundary values ΓNj and Dirichlet and periodic boundary condition equations ΓD and ΓP

Specifying partial differential equations with boundary conditions.

DirichletCondition, NeumannValue and PeriodicBoundaryCondition all require a second argument that is a predicate describing the location on the boundary where the conditions/values are to be applied. Additionally, the PeriodicBoundaryCondition has a third argument specifying the relation between the two parts of the boundary.

A partial differential equation typically needs at least one Dirichlet boundary condition on some part of the region to be uniquely solvable. For this reason, Dirichlet boundary conditions are also called essential boundary conditions.

The use of generalized Neumann values arises from the boundary integral from the weak form, and so they are also commonly referred to as natural conditions.

A pure Neumann boundary equation is a generalized Neumann boundary equation (9) where :

If is also not specified, then a Neumann zero boundary value is automatically implied ():

Note that when the Neumann value is zero, the term drops out in (12). This is typically a case where there is no flux or stress at the boundary. When no boundary conditions are explicitly specified for a part of the region boundary , a Neumann zero value is assumed.

Poissons Equation with Neumann Values

Consider the solution of Poisson's equation with generalized Neumann boundary values.

Use that same region and the PDE operator.

Poisson's equation is given as:

The corresponding Neumann boundary equation is:

Note how the normal derivative of the Neumann-type equation relates to the PDE. In the Neumann boundary equation, one specifies the values of and on the right-hand side. The left-hand side is implicitly specified through the PDE. If the coefficient in the PDE is given as an identity matrix, then the coefficient on the left-hand side of the Neumann equation is that same coefficient .

The Neumann boundary value is specified though the values and . Typically when , one speaks of a Neumann boundary value, and in the case , one speaks of a generalized Neumann or Robin boundary value. It is common to use the term Neumann boundary condition for both the generalized Neumann and Neumann boundary value.

Specify a generalized Neumann value and Dirichlet boundary condition.

It is important to observe that the constants in the term of the Neumann boundary equation exactly match the constants in from the weak form of the PDE (11). Because these terms are required to match, NeumannValue only requires the user to enter the right-hand side of the boundary equation. For example, to enter the boundary equation , it suffices to enter NeumannValue[1,]. The correct expression for the left-hand side of the boundary equation (i.e. ) is implied by the term in the weak form of the PDE (12). This close relation of the Neumann boundary value and the PDE is further accommodated by making the NeumannValue part of the equation.

Solve the PDE.
Plot the solution.

In the previous examples, not all boundaries had boundary conditions explicitly attributed; for those parts of the boundaries, the Neumann zero condition is used.

Inspect the values of the solution at .

Note that the values beyond 8 are zero, as required by the Dirichlet condition.

Poissons Equation with a Periodic Boundary Condition

The purpose of PeriodicBoundaryCondition is to relate the values of a solution of a PDE at two distinct parts of the boundary. PeriodicBoundaryCondition[a+b u,pred,f] specifies a periodic boundary condition where the predicate pred specifies a target at which the solution should relate to values from a distinct source, and the function f maps coordinates from the target locations (blue) to the source locations (green) where the dependent variable relation is evaluated. The resulting values will be set as a condition at the target.

68.gif

An example is the best way to understand how PeriodicBoundaryCondition works.

Specify and visualize a region marked with a blue target and green source boundary.

The PDE in this example is a Laplacian with a load term of 1 unit active in a rectangle specified by . Everywhere else there the load is 0.

Specify a PDE.

PeriodicBoundaryCondition allows either periodic or antiperiodic or relational boundary conditions to be modeled. In this example, a periodic boundary condition is presented. A periodic condition is specified when the first argument is the dependent variable, u, and requires that the dependent variable u at the predicate (blue, target) is to have the same values as at position (green, source). During the solution process, the dependent variable u is to be evaluated at the source. For this, a mapping from the predicate (blue, target) to (green, source) is needed. The function FindGeometricTransform can construct such a mapping from a list of coordinates.

Compute a mapping for the PeriodicBoundaryCondition using FindGeometricTransform.

Investigate to see that the mapping maps a point from the green source to the blue target.

The PeriodicBoundaryCondition is then set up by giving the relation of the dependent variable, the target predicate and a mapping. In the periodic case, the relation is .

Additionally, on both curved sides DirichletCondition is placed. Note that the DirichletCondition is excluded at such that there is no DirichletCondition on the target boundary. Having Dirichlet boundary conditions there would not be consistent with the solution mapped to these places.

Specify a DirichletCondition at .
Solve the PDE.
Visualize the solution.
Inspect that the solution at is the same as at .

An antiperiodic boundary condition can be realized by using the negative of the dependent variable in the PeriodicBoundaryCondition. In the next example, everything except the antiperiodic boundary condition remains the same.

Specify a antiperiodic PeriodicBoundaryCondition with .
Solve the PDE.
Visualize the solution.
Inspect the sum of the solution at the two parts of the boundary.

Partial Differential Equations with Variable Coefficients

In the following example, the PDE coefficients depend on space and time. Here indicates the temporal variable and the spatial variables:

The example of a shielded microstrip illustrates the effect of variable coefficients. It is an electrostatics application that can be modeled with a Poisson equation where the coefficient is the relative permittivity and depends on space:

A geometry is constructed where the boundary separates two materials. In each material, has a different value.

First, a boundary mesh is created. For more information about creating element meshes, please consult ToBoundaryMesh.

Create a boundary mesh.
Visualize the boundary mesh.

The conversion of the boundary mesh to an element mesh is done with ToElementMesh.

Convert the boundary mesh to a full mesh and visualize the resulting mesh.

Next, the PDE is set up. The load term of the PDE is the charge density divided by the vacuum permittivity :

The lower part of the geometry is silicon, while the upper part is vacuum. Silicon has a relative permittivity of about 11.7, while vacuum has a value of 1.

Also, see this note about how to set up computationally efficient PDE coefficients.

The charge density and vacuum permittivity are given as follows.

Set up the partial differential operator.

For the use of Inactive in PDEs, see the section Formal Partial Differential Equations.

The potential is set to 0 wherever . A second potential is set to 1000 in the inner strip.

Set up the boundary conditions.
Solve the PDE.
Visualize the result.

In many cases when there are explicit discontinuities in the PDE coefficients, NDSolve automatically includes these in the mesh it generates to solve the problem. The discontinuity at is automatically detected for this example.

Create a symbolic specification for the region.
Solve the PDE.
Inspect the boundary mesh that has been auto-created.

As can be seen, the original input region did not have an internal boundary at the discontinuity, but during the mesh generation process, the internal line along the discontinuity was added.

An alternative to model multiple materials is to use markers for the specific subregions. This is shown and explained further in the section Markers in the Element Mesh Generation.

Many more multi-material application examples can be found in the application examples of the PDE Models Overview page.

Also, see this note about the setup of efficient PDE coefficients.

Partial Differential Equations with Nonlinear Coefficients

Some PDE coefficients may, in addition to space and time , also depend on the dependent variable and the first derivatives . Here indicates the spatial variables , , . If a coefficient depends on the dependent variable , the equation is nonlinear. Consider the nonlinear equation:

As an example, to compute a minimal surface the following equation can be used:

The equation is nonlinear, since the derivative of the dependent variable appears in the diffusion coefficient.

Set up a disk as a region.
Set up the partial differential operator.

To solve nonlinear stationary equations, an initial seed for the solution can be specified. This is done by making use of InitialSeeding. InitialSeeding specifies an expression to be evaluated over the region of interest. The expression can depend on the spatial variables. If no initial seed is specified, 0 is assumed as an initial seed.

Solve the nonlinear equation.
Visualize the result.

More examples on the usage of InitialSeeding can be found on the reference page.

Many more nonlinear application examples can be found in the application examples of the PDE Models Overview page.

Partial Differential Equations with Nonlinear Variable Coefficients

The following section presents a magneto statics application example. Magneto static applications typically make use of several, possibly nonlinear, materials in different areas of the simulation domain. This example looks at a simplified model of a motor, for which the distribution of the magnetic potential and a vector density field of the magnetic flux will be computed.

In the preceding representation of the motor geometry, the stator sections are gray, the rotor is red, and the blue area represents air. Also, several coils are grouped and displayed in orange, light orange and yellow.

The PDE model is derived from Ampère's circuital law of Maxwell equations:

Here is the current density and the permeability. The magnetic flux density is connected to the magnetic potential via

Inserting 1 in 2, you obtain

To simplify the model to two dimensions, assume that currents only flow orthogonal to the and plane: . Further assuming that is constant in the direction and and are constant, you can write:

Since a model is assumed that is homogenous in the direction, the components drop out and the following is used:

The equation is nonlinear, since the permeability is a function of the spatial coordinates and the derivative of the unknown . In the rotor and stator, the permeability of a ferromagnetic material is used, while in the rest of the domain, the permeability of air will be used. The right-hand side of the equation, , is the -component of a variable current density that flows through the coils.

The first step is to create a mesh that has markers for the different regions. These markers can then be used to activate, for example, in different regions of the simulation domain. Using markers for this is much simpler than specifying the formula for regions where different parts of the PDE are active. More information on markers and their generation in meshes can be found in the "Element Mesh Generation" tutorial.

Use a manually generated mesh region.
Generate a boundary element mesh from the MeshRegion.

For markers to be attributed to different subregions, coordinates lie in those subregions need to be specified.

Set up the marker coordinates.

Visualizing the boundary mesh and the marker coordinates helps one to understand the process of specifying marker coordinates. For the visualization, it is necessary to group the marker coordinates and set up colors that will go with the markers.

Group the marker coordinates and set up marker colors.
Visualize the boundary mesh and the marker coordinates in different colors.

The coils, currently visualized with an orange point, are to carry different currents. To simplify this process, each coil will get a marker assigned such that coils carrying the same current are grouped together.

Specify the coil marker.
Check that there are as many coil markers as there are coil coordinates.

Now you have a list of coordinates lying in the subregions and have attributed markers with those coordinates.

Specify the markers.

Next, create the full mesh.

Generate the mesh with markers.
Visualize the mesh with the stator in gray, the rotor in red, air in blue and the coils in orange, light orange and yellow.

Now the material data is set up.

Set up the permeability of air.

The change of permeability for ferromagnetic materials is typically given in BH-curves. These contain material data. For this data, an interpolating function can be created that can be used as a PDE coefficient. As a more efficient alternative, a fit can be generated that can be used as the PDE coefficient. Both approaches will be shown.

Specify values of a ferromagnetic material from the BH-curve data sheet.
Set up the BH-curve data.

While generating the interpolation, make sure that the smallest and largest values of the BH-curve are continued if the interpolating function is queried outside of its domain. Also instruct the interpolating function to not give warning messages when queried outside of the domain.

Generate an interpolating function from the BH-curve data.
Compute the norm of the magnetic flux density and avoid it becoming zero.

If the permeability coefficient is evaluated either in the rotor or the stator, then the ferromagnetic material will be used in all other regions the permeability for air is used.

Specify an inverse permeability based on the interpolated data.

With the interpolating function approach comes great flexibility, and the coefficient can be used as it is. However, a more efficiently evaluatable approach is to find a fit for the BH-curve data.

Find a fit for the BH-curve data with a Gaussian model and generate a function.
Visualize the difference between the interpolated and the fitted BH-curve.
Specify an inverse permeability that is efficiently evaluatable.

Also, see this note about how to set up computationally efficient PDE coefficients.

The current density in the coils is specified such that there is a positive current in elements with ElementMarker 4, a negative current in the elements with ElementMarker 6 and a zero current elsewhere.

Specify the current density.
Specify the partial differential equation.

The boundary condition is set up in such a way that the magnetic potential is zero at the out rim of the stator.

Set up the boundary condition.
Solve the nonlinear PDE.
Find the minimum and maximum of the magnetic potential.
Visualize the magnetic potential and magnetic flux density B.

More examples on the usage of InitialSeeding can be found on the reference page.

Many more nonlinear application examples can be found in the application examples of the PDE Models Overview page.

Partial Differential Equations and Nonlinear Boundary Conditions

NDSolve and related functions allow for specifying nonlinear generalized Neumann values. Dirichlet and periodic boundary conditions cannot be nonlinear. A nonlinear generalized Neumann value is given by:

This is very similar to the linear generalized Neumann value, except that the dependent variable is now a function of .

A common use case for generalized nonlinear Neumann value is to model radiating boundaries. As a one-dimensional example, a nonlinear radiating heat transfer is used:

The boundary condition on the right is a nonlinear radiation condition:

On the left boundary, a Dirichlet condition is made use of. Here is the thermal conductivity coefficient, is a cross-sectional area exposed to radiation, is the StefanBoltzmann constant, is the emissivity, is the ambient temperature, and is a heat source.

Set up the nonlinear equation.
Set up the radiation boundary condition.
Set up a Dirichlet condition.
Set up material parameters.
Set up the PDE with material parameters substituted.
Solve the equation.
Visualize the result.

For a verification of a similar example, please refer to the nonlinear Finite Element verification tests.

Heat Equation

The heat equation is a time-dependent Poisson equation

where the dependent variable depends on the spatial coordinates and time .

Both Dirichlet boundary conditions and Neumann boundary values may also depend on time.

The overall procedure to solve PDEs remains the same: a region needs to be specified and a PDE with boundary conditions needs to be set up.

Set up the spatial region.

The dependent variable now depends on time and space.

Set up the PDE operator, being sure to include the time as an argument of .

Also, the boundary conditions may depend on space and time.

Set up the boundary conditions.

To solve first-order time-dependent problems, NDSolve needs an initial condition and a time region.

Solve the PDE.
Make an animation of the solution.

Note that it is more efficient to convert the mesh once and use the discretized mesh during the plotting instead of rediscretizing the region for every animation frame.

More information about the heat equation and applicable boundary conditions can be found in the Heat Transfer tutorial and the Heat Transfer PDE models guide page.

Wave Equation

The wave equation is a second-order time-dependent equation:

Define circular region .
Define the wave equation PDE operator.
Dirichlet boundary conditions are set to a fixed value of on all boundaries.

The wave equation is a second-order time-dependent PDE, and initial conditions and the derivative of the initial condition must be specified.

Initial conditions for the wave equation.
Solve the PDE and have NDSolve find initial values.

To make an animation of the resulting InterpolatingFunction, use Plot3D and Animate.

Make an animation of the solution.

If no boundary conditions are specified, which implicitly means a Neumann zero boundary condition, then the wave is reflected at the boundary. This can be seen well in a 1D example.

Define line region .
Define a wave operator.
Initial conditions for the wave equation.
Solve the wave equation with reflecting boundaries.

To make an animation of the resulting InterpolatingFunction, use Plot3D and Animate.

For time-dependent systems, boundary conditions may be specified for any time derivative of a dependent variable of order strictly less than the time derivative order of that dependent variable in the equation. Thus for equations that are first order in time, boundary conditions may only be given for the dependent variables. For equations that are second order in time, boundary conditions may be given for the dependent variables and their first derivative with respect to time.

To model a wave equation with absorbing boundary conditions, one can proceed by using a temporal derivative of a Neumann boundary condition. For this, the exact same wave equation as in the preceding is used, but a Neumann value is added to the equation.

Solve the wave equation with absorbing boundaries.

To make an animation of the resulting InterpolatingFunction, use Plot3D and Animate.

Modeling periodic boundary conditions of waves can be implemented with PeriodicBoundaryCondition. In this example, the derivative of the initial condition is not zero but chosen such that the initial wave travels to the right.

Initial conditions for the wave equation.
Specify a periodic boundary condition that absorbs the wave on the right and reinserts it on the left.
Solve the wave equation with absorbing boundaries.

To make an animation of the resulting InterpolatingFunction, use Plot3D and Animate.

Formal Partial Differential Equations

A PDE that is making use of Laplacian can also be formulated with Div and Grad. To do so, use the coefficient in . Here is an × matrix where is the number of dimensions in .

To prevent evaluation, Inactive can be used.

Set up the PDE operator.

The formal version of the PDE allows you to easily modify the coefficient matrix .

One scenario where the use of Inactive can be important is when modeling the relation between a PDE and a Neumann value. Consider the following PDE:

The corresponding Neumann boundary equation is

Consider a PDE where is the identity matrix and is given by . Specifying the PDE without the use of Inactive will cause the expression to evaluate.

Note, however, that the evaluation changes the PDE to the following:

is and is .

These PDEs are equivalent.

Even though the PDEs are equivalent, the corresponding Neumann values are not:

For the second PDE, the Neumann value modeled is the following:

To prevent evaluation and model a Neumann value of the following form, the use of Inactivate is needed.

A more in-depth discussion of formal PDEs can be found in Finite Element Method Usage Tips.

Also, note that while it is possible to specify a coefficient as a function, this deprives the internal code of the ability to optimize the coefficient integration. In this specific case, the coefficient is constant, and with the optimization, the coefficient is only integrated once. A black box function would need continuous evaluations over the region. For example, a function that hides its internals is not ideal, since the FEM code cannot make use of the optimized diffusion operator for constant coefficients.

A black box function hiding its internals that should be avoided as a PDE coefficient.

Systems of Partial Differential Equations

The Coefficient Form of Systems of Partial Differential Equations

Consider a system of two equations with dependent variables and :

For a region in , each is an × matrix, and each of , and are vectors.

In this case, the generalized Neumann equations are:

One-Dimensional Coupled Partial Differential Equation

The following example is set up such that the parameters are easy to modify. First, the region is specified.

Specify a region.

Here is the PDE to be solved:

The PDE has two dependent variables and . The coupling is between two diffusion operators. Note that since this is a one-dimensional system, each coefficient is a 1×1 matrix, which is equivalent to a number.

Set up the PDE operators.

Each equation has its own set of boundary conditions. In the most general form, Dirichlet boundary conditions are now systems of conditions:

Neumann values specify a system of the following form:

Next, the boundary conditions are set up.

Specify boundary conditions for the first equation.
Specify boundary conditions for the second equation.
Solve the system of equations.

Here is the analytical solution of the system of PDEs computed with DSolve.

The analytical solution.

Note how in the DSolve formulation of the system of equations the generalized Neumann boundary equations have to be given explicitly, and how their coefficients match those in the PDE.

To compare the analytical result to the numeric result, make a plot of the difference between the two.

Plot the difference between the analytical and numerical solutions.

This example also makes apparent why the NeumannValue is part of the equation. The equations for the Neumann value are given by:

Consider the boundary value .

There is no way to know from the Neumann value with which equation it should be associated. Making the Neumann value part of the equation disambiguates with which equation the Neumann value is associated.

Structural Mechanics

In structural mechanics, the deformation of objects under load is computed. Structural mechanics provides good examples of coupled PDEs. As an example region, consider a beam five units long and one unit high.

The PDE that models the physics is a plane stress relation and is valid for thin objects. Here, "thin" means thin relative to the other dimensions of the object. The plane stress formulation depends on two dependent variables and the independent variables. The two dependent variables give the componentwise contribution of the deformed object. As material data, the Young's modulus and the Poisson ratio need to be specified.

Define a plane stress operator.

The operator is given as a Formal Partial Differential Equation in Inactive form.

Alternatively, one could use the function SolidMechanicsPDEComponent to generate the PDE component. The SolidMechanicsPDEComponent reference page also contains the equations in text form.

Use SolidMechanicsPDEComponent to create a plane stress operator.

Furthermore, a boundary load may be specified. In this case, the boundary load applies at the right edge of the beam and a pressure of unit is applied in the negative direction.

On the left-hand side of the region, both dependent variables are held fixed with 0 displacement.

Set up the boundary conditions so that the beam is held fixed at the left.
Solve the equation.

In order to show the deformed beam, an element mesh must be created for the beam at rest, which is deformed by the interpolating functions given.

Visualize the boundary of the beam at rest versus the deformed mesh of the beam.

More information about the usage of ElementMeshDeformation can be found in "Element Mesh Visualization".

The following contour plots show the deformation of the beam. The dependent represents the deformation in the direction. It can be seen that the top-right part of the beam experiences a shift in the positive direction. The lower-right part is moved in the negative direction.

The contour plot of the dependent represents the deformation in the direction. The right-hand side of the beam undergoes a deformation in the negative direction.

Note that the color scale of the two contour plots is not the same.

For completeness, a PDE that models the physics of a plane strain relation is presented. The plane strain formulation is, in contrast to the plane stress formulation, valid for thick objects. Here, "thick" means thick relative to the other dimensions of the object. The plane strain formulation depends on two dependent variables and the independent variables. The two dependent variables give the componentwise contribution of the deformed object. As material data, the Young's modulus and the Poisson ratio need to be specified.

Define a plane strain operator.

Again, the component could have been generated with the function SolidMechanicsPDEComponent.

The boundary conditions this time are prescribed displacements on both sides. On the left-hand side of the region, both dependent variables are held fixed with 0 displacement. On the right-hand side, a displacement of one unit in the direction of negative axes is given and the displacement on the direction is held fixed.

Set up the boundary conditions so that the beam is held fixed at the left and the right.
Solve the equation.

In order to show the deformed beam, an element mesh must be created for the beam at rest, which is deformed by the interpolating functions given.

Visualize the boundary of the beam at rest versus the deformed mesh of the beam.

The following contour plots show the additive deformation of the beam. The dependent represents the deformation in the direction, and the dependent represents the deformation in the direction.

More information about solid mechanics and applicable boundary conditions can be found in the Solid Mechanics monograph and the Solid Mechanics PDE models guide page.

Fluid Flow

A linear model of a fluid flow is the Stokes equation. The Stokes equation in three dimensions is given as:

where , and are the fluid velocities in the , and directions, respectively. is the pressure and is the dynamic viscosity of the fluid.

In this example, a flow through a narrowing two-dimensional tube is analyzed.

Specify and visualize a region that narrows.
The Stokes operator is set for a viscosity .

The operator is given as a Formal Partial Differential Equation in Inactive form.

Here represents the fluid's velocity in the direction and represents the velocity in the direction. stands for the pressure in the fluid.

Specify the PDE.

The inflow velocity in the direction is prescribed with the boundary conditions. This is done by specifying an inflow profile for the dependent variable on the left-hand side of the region. On the bottom and upper part of the region, a no-flow condition is specified. This is done by setting both the and components on those parts to 0. An outflow condition is set on the right-hand side of the domain. Here the pressure is arbitrarily set to 0. In general, each dependent variable should either have a Dirichlet condition or a Robin-type Neumann specified. A pure Neumann value like Neumann 0 is not sufficient. In that case, the solution to the equation can only be correct up to a constant.

Setup of the boundary conditions.

A stable solution can be found if the velocities are interpolated with a higher order than the pressure. NDSolve allows an interpolation order for each dependent variable to be specified. Most of the time specifying the "InterpolationOrder" is not necessary, but this is a standard procedure when using the finite element method for fluid flow and this is how it can be done in the Wolfram Language. This setup corresponds to what is called P2P1- or Q2Q1-type elements, which are also known as TaylorHood elements. Leaving out the "InterpolationOrder" will result in using a second-order interpolation for all variables, which is fine. Using first-order interpolation for all dependent variables can lead to wrong results and may not be numerically stable. Specifying second order for the velocities and first order for the pressure gives good accuracy of the solution, and the size of the discretized PDE model is a bit smaller.

Solve the equations while specifying a finer mesh than the default.

An explanation of the usage of the finite element method option interpolation order is given in "Finite Element Method Usage Tips".

Visualize the flow in the direction.
Visualize the flow in the direction.
Visualize the pressure.
Visualize the flow field.

A nonlinear model of a fluid flow is the NavierStokes equation. The NavierStokes equation is given as:

with the density.

In this example, a flow-through around a cylinder is analyzed by looking at a 2D cross section.

Specify and visualize a region around a cross section of a cylinder.
The NavierStokes operator is set for a viscosity and density .

The operator is given as a Formal Partial Differential Equation in Inactive form.

Here represents the fluid's velocity in the direction, and represents the velocity in the direction. stands for the pressure in the fluid.

Specify the PDE.

The inflow velocity in the direction is prescribed with the boundary conditions. This is done by specifying an inflow profile for the -dependent variable on the left-hand side of the region. On the bottom and upper part of the region and around the cylinder, a no-flow condition is specified. This is done by setting both the and components on those parts to 0. An outflow condition is set on the right-hand side of the domain. Here the pressure is arbitrarily set to 0.

Setup of the boundary conditions.

Suppose you would like to compute the pressure difference from a point before the cylinder and a point behind the cylinder . Additionally, the length of recirculation is to be computed. Also the drag and lift force on the cylinder are of interest. is the coordinate of the end of the cylinder and is the end of the recirculation area. In order to get a good result, the area around the cylinder is to be refined in a piriform shape, and a higher than default accuracy and precision are to be used for the mesh generation.

Set up a piriform refinement region around the cylinder.
Visualize the refinement region and the simulation domain .
Create a refinement function based on the region of refinement.

A stable solution can be found if the velocities are interpolated with a higher order than the pressure. NDSolve allows an interpolation order for each dependent variable to be specified.

Solve the equations, while specifying points to be included, increased accuracy and precision and a refinement function.

An explanation of the usage of the finite element method option interpolation order is given in "Finite Element Method Usage Tips".

Compute the pressure difference before and after the cylinder.

The expected value for the pressure difference is between 0.1172 and 0.1176.

Find the recirculation length after the cylinder.

The expected value for the recirculation length is between 0.0842 and 0.0852.

Set up a function to compute the drag and lift force around the cylinder.
Compute the drag and lift force on the cylinder.

The expected value for the drag force is between 5.57 and 5.59, and for the lift force between 0.0104 and 0.0110.

Visualize the and components of the velocity as , pressure contours
as black lines, and the velocity vector field.

The transient NavierStokes equation can also be solved. The vectorized equations are given as:

For this, the same geometry as in the stationary case is used. First the time-dependent NavierStokes equation is set up.

The transient NavierStokes operator is set for a viscosity and density .

Suppose you would like to model an inflow on the left, set a pressure condition on the outflow on the right, and all remaining walls have a non-slip boundary condition. For the inflow boundary condition to be consistent with initial conditions, a helper function that smoothly ramps up the inflow over time is created.

Function to ramp up the inflow boundary condition over time.
Set up the boundary conditions.
The initial conditions are set to 0.

Because the Navier-Stokes equation is a high-index differential algebraic equation, options are specified to time-integrate the equations efficiently. The maximum difference order of the time integrator is reduced to minimize the number of rejected steps. The time-dependent boundary conditions are differentiated to create a consistent system of equations that are more efficient to time integrate. Lastly, a mesh somewhat finer than the default mesh is used. Solving this equation can, depending on the hardware used, take a few minutes.

Time-integrate the NavierStokes equation.
Find the maximum and minimum of the velocity range.
For efficient visualization, extract the mesh from the solution.
Create contour plots of the velocity.
Visualize the velocity component.

As a next step, the NavierStokes equation is coupled to a heat equation to model energy transport.

First a region and some parameters are specified.

Specify parameters and a rectangular region with cutouts.
Visualize the region.
Specify a Prandtl number and a Rayleigh number .

Set up a viscous NavierStokes equation that is coupled to a heat equation making use of a Boussinesq approximation. The vectorized equations are given as:

where is the temperature, the diffusion coefficient and the kinematic viscosity.

Use the material parameters specified.

Set up a NavierStokes equation coupled to a heat equation.

Boundary conditions and initial conditions need to be set up.

Set up no-slip boundary conditions for the velocities on all boundary walls.
Set up a reference pressure point.
Specify a temperature difference between the left and right walls.
Replace parameters in the boundary conditions.
Set up initial conditions such that the system is at rest.

Monitor the time integration progress and the total time it takes to solve the PDE while using a refined mesh and interpolating the velocities and and the temperature with second order and the pressure with first order.

Monitor the time integration of the equations.

The last step is post-processing.

Construct a visualization of the region's boundary.
Visualize the pressure distribution.
Visualize the temperature distribution.
Visualize the velocity field.
Animate the change in temperature and the velocity streamlines.

For the curious, investigate the different velocity field produced by simply swapping the cut-out positions.

A different region to try.