TWOD
Functions for 2D Finite Elements
TWOD
is a MATLAB library which
contains functions useful for 2D finite element calculations,
by Jeff Borggaard.
Related Data and Programs:
FEM2D,
a data directory which
contains a description of the data files
that can be used to describe a 2D finite element model.
FEM_IO,
a MATLAB library which
reads and writes the node, element and data files that define a finite element model.
FEM1D_PACK,
a MATLAB library which
contains utilities for 1D finite element calculations.
FEM2D_HEAT,
a MATLAB program which
solves the time dependent heat equation in the unit square.
FEM2D_PACK,
a MATLAB library which
is useful for 2D finite element calculations.
FEM2D_POISSON,
a MATLAB program which
solves the Poisson equation in the unit square.
FEM2D_POISSON_RECTANGLE_LINEAR,
a MATLAB program which
solves the 2D Poisson equation on a rectangle, using the finite element method,
and piecewise linear triangular elements.
FEM2D_PROJECT,
a MATLAB program which
projects a function F(X,Y) into a given finite element space
of piecewise linear triangular elements.
FEM2D_SAMPLE,
a MATLAB library which
evaluates a finite element function defined on an order 3 or order 6 triangulation.
FEM3D_PACK,
a MATLAB library which
contains utilities for 3D finite element calculations.
ONED,
a MATLAB library which
contains functions useful for 1D finite element calculations.
THREED,
a MATLAB library which
contains functions useful for 3D finite element calculations.
TWOD_PLOTC,
a MATLAB program which
makes a color contour plot of scalar data defined on a 2D finite element mesh.
TWOD_TO_VTK,
a MATLAB program which
accepts computational data from a 2D finite element fluid flow program
and writes it to a VTK "legacy" file for postprocessing by PARAVIEW.
TWOD_TO_VTU,
a MATLAB program which
accepts computational data from a 2D finite element fluid flow program
and writes it to a VTK unstructured grid file for postprocessing by PARAVIEW.
Author:
Jeff Borggaard, Virginia Tech.
Source Code:
-
twod_backm2d.m
calculates a mesh density function and generates
a backm2d file readable by amiral.
-
twod_bilinear.m
integrates kernel(x,y) * basis function(x,y) * test function(x,y).
-
twod_f_int.m
computes the integral of f(x,y) times a test function.
-
twod_gauss.m
sets Gauss integration points for triangular elements.
-
twod_getfaces.m
finds element faces corresponding to
a set of boundary nodes.
-
twod_mesh.m
generates a rectangular mesh with a prescribed density.
This routine returns nodal coordinates, element
connectivity, and the nodal indices of boundary nodes.
-
twod_plotc.m
produces a filled contour plot of triangular
finite element data.
-
twod_plotm1.m
plots linear triagular mesh.
Also works for quadratic straight sided elements.
-
twod_plotm2.m
plots linear triagular mesh.
Also works for quadratic straight sided elements.
-
twod_projectd.m,
projects the derivative onto the
continuous finite element space (ZZ projection).
-
twod_readcad5out.m
reads in solution data from a *.cad5out file
generated with cadyf.
This code is quite problem specific, since the
*.cad5out file is setup to solve the Navier-Stokes
equations.
-
twod_readcadyf.m
reads in mesh, connectivity and boundary node
numbers from a *.cadyf file generated with
amiral (preprocessor for cadyf).
This code is quite problem specific, since the
*.cadyf file is setup to solve the Navier-Stokes
equations.
-
twod_readcadyf1.m
reads in mesh, connectivity and boundary node
numbers from a *.cadyf file generated with
amiral (preprocessor for cadyf).
This code is quite problem specific, since the
*.cadyf file is set up to solve the Navier-Stokes
equations.
-
twod_shape.m
computes test functions and derivatives on an
element given element coordinates and Gauss points.
Optimized for straight-sided elements. Use
"twod_shapeiso" for isoparametric elements.
-
twod_shapeiso.m
computes test functions and derivatives on an
element given element coordinates and Gauss points.
Specifically set up for isoparametric
elements. Use "twod_shape" for linear elements.
-
twod_to_tecplot.m
writes out a 2D finite element solution to a file, in a format
readable by TECPLOT.
-
twod_to_vu.m
writes out a 2D finite element solution to a file, in a format
readable by Vu.
You can go up one level to
the MATLAB source codes.
Last modified on 05 September 2009.