Glossary of Terms
adaptive mesh refinement
A method of improving solution accuracy by adapting the mesh to the problem’s physical behavior.
affine transformations
Geometric transformations that are combinations of linear transformations and translations.
algebraic multigrid (AMG)
An algebraic multigrid solver or preconditioner that performs one or more cycles of a multigrid method using a coarsening of the discretization based on the coefficient matrix. Compare to geometric multigrid (GMG).
anisotropy
Variation of material properties with direction.
application program interface (API)
An API provides a set of documented functions and methods for interacting with a software product.
arbitrary Lagrangian-Eulerian formulation (ALE formulation)
A formulation where an Eulerian equation is transformed into an equation written with respect to a mesh, which can be moving in relation to both the Eulerian frame and the Lagrangian frame. The COMSOL Multiphysics solvers have built-in support for the necessary transformation of derivatives.
arc
A segment of the circumference of a circle or ellipse.
Argyris element
A 2D, 6-node triangular finite element with a 5th-order basis function providing continuous derivatives between elements.
aspect ratio
The ratio between the longest and shortest element or geometry dimension.
assemble
Taking the local element stiffnesses, masses, loads, and constraints to form the stiffness matrix, mass matrix, load vector, constraint matrix, and constraint residual vector.
associative geometry
An algorithm that maps data associated with a geometry to the new geometric entities when the geometry is modified.
backward differentiation formula (BDF)
A multistep formula based on numerical differentiation for solutions to ordinary differential equations. A BDF method of order n computes the solution using an nth-grade polynomial in terms of backward differences.
basis function
A function i in the finite element space such that the ith degree of freedom is 1, while all other degrees of freedom are 0. For the Lagrange finite element space, i is a linear or higher-order polynomial on each mesh element with value 1 in node i and 0 in all other nodes.
BEM
See Galerkin boundary element method.
Bernstein polynomial
See Bézier basis.
Bézier basis
A set of polynomial functions that occur in the definition of a Bézier curve. These polynomial functions are often called Bernstein polynomials.
Bézier curve
A rational Bézier curve is a parameterized curve formed as the quotient of two polynomials expressed in the Bézier basis. It is a vector-valued function of one variable. The coefficients of a rational Bézier curve are geometrically interpreted as control points and control weights. A nonrational Bézier curve is a rational Bézier curve with all weights equal, thereby making the denominator polynomial equal to a constant. A nonrational Bézier curve is also called an integer Bézier curve.
Bézier patch, Bézier surface
A Bézier patch or Bézier surface is a surface extension of a Bézier curve. A Bézier patch is a function of two variables with an array of control points.
bidirectional constraint
A constraint enforced by reaction terms affecting both equations in a constraint of the type u1 = u2. Symmetric constraints are an important special case. See also reaction terms and constraint.
Boolean operations
Boolean operations are used to construct a geometry object from other geometry objects. At least two primary geometry objects are required to create a resultant new geometry object. That new object depends on the type of Boolean operation:
boundary
A geometric entity with a dimension one less than the space dimension for the geometry (a face in a 3D geometry, an edge in a 2D geometry, and a vertex in a 1D geometry). In a mathematical context, the symbol ∂Ω represents the boundary of the domain Ω . Sometimes boundary is used in a narrower sense meaning an exterior boundary. See also interior boundary, exterior boundary.
boundary element method
See Galerkin boundary element method.
boundary modeling
A geometry modeling method to create a geometry by defining its boundaries. Compare to solid modeling and surface modeling.
brick element
See hexahedral element.
chamfer
A CAD operation that trims off a corner with a plane or straight line.
Cholesky factorization
A memory-saving version of LU factorization where U is the transpose of L. It requires that the coefficient matrix A (A = LU) be a symmetric positive definite matrix. See also LU factorization and positive definiteness.
coefficient form PDE
A PDE in the coefficient form is a PDE formulation suited for linear PDEs.
component coupling
See nonlocal coupling.
composite geometry object
Geometric objects made up by combining primitive geometry objects and other composite objects. See also constructive solid geometry, primitive geometry object, and Boolean operations.
COMSOL Application Server
For each application launched from a COMSOL Server ™ installation, a separate COMSOL Application Server process is started to run the application. A COMSOL Application Server process contains functionality that is similar to a COMSOL Multiphysics Server together with functionality to generate the application’s user interface accessed from a web browser or a COMSOL Client.
COMSOL Client
A Windows® client that runs an implementation of a COMSOL application, created with the Application Builder, and that connects to a COMSOL Server™.
COMSOL Desktop
The COMSOL Desktop® is an integrated simulation environment for the COMSOL products with a number of windows such as the Model Builder window, the Graphics window, and each model tree node’s Settings window.
COMSOL binary file
A binary data file with the extension .mphbin that contains geometry objects or mesh objects.
COMSOL text file
A text data file with the extension .mphtxt that contains geometry objects or mesh objects.
COMSOL Multiphysics server
The COMSOL Multiphysics server is a single user server allowing multiple sessions of the same user, one session at a time.
COMSOL Server
A COMSOL Server™ license make it possible to deploy and run COMSOL applications in major web browsers. Using the Windows® operating system, you can also run COMSOL applications by connecting to a COMSOL Server with an COMSOL Client.
condition number
A measure of the possible error in a solution due to ill-conditioning of the equations. See also ill-conditioning.
constant
A named model property that has a constant numeric value. The built-in constants in COMSOL Multiphysics include mathematical and numerical constants and physical constants.
constraint
Restriction imposed upon the dependent variables on the form R(u1,u2,...) = 0. A Dirichlet boundary condition is a special case. Neumann boundary conditions are not regarded as constraints. When a constraint is added, the finite element algorithm adds corresponding reaction terms to the system of equations. These generalized reaction forces modify the flux conditions so that the resulting model becomes solvable.
constructive solid geometry (CSG)
A solid-modeling method that combines simple solid shapes, or primitives, to build more complex models using Boolean operations. See also solid modeling and primitive.
contributing node
A boundary condition or source is contributing when it adds to other boundary conditions or sources defined on the same geometric entity. Examples of contributing boundary conditions are loads in structural mechanics and heat flux components in heat transfer. See also exclusive nodes.
control point
Bézier and NURBS curves and surfaces are defined by a set of points known as control points. The locations of these points control the curve’s shape.
control weight
Scalar values assigned to control points to further control the shape of a curve or surface.
contour plot
A plot that shows the variation of a solution component or other quantity. Points with equal values of the plotted quantity are connected with contour lines.
convergence
The tendency for a finite element solution to approach the exact solution within well-defined and specified tolerances, for example, by reducing the mesh element size or the time step.
Costabel FEM-BEM coupling
A symmetric coupling method for combining finite elements and boundary elements, where the coupling to the finite elements makes it possible to solve problems where the coefficients of the differential operator are not constant.
curl element
See vector element.
curve
The path of a point moving through space. See also Bézier curve, NURBS, and manifold.
curve object
A geometry object consisting of only edges and vertices (where no vertex is isolated), for example, a geometry object representing a curve.
curve segment
An individual polynomial or rational polynomial curve. Compounded curves consist of several curve segments.
curved mesh element
See mesh element.
degree of freedom (DOF)
One of the unknowns in a discretized finite element model. A degree of freedom is defined by a name and a node point. The degree of freedom names often coincide with the names of the dependent variables. The local degrees of freedom are all degrees of freedom whose node points are in one mesh element.
deformed geometry
A geometry where the shape changes with a moving-mesh algorithm. It is also the name of a physics interface for modeling deforming geometries. This is similar to the Parameterized Geometry interface in earlier versions of COMSOL Multiphysics.
deformation gradient
In solid mechanics, it contains the complete information about the local straining and rotation of the material. It is a nonsingular matrix with positive determinant, as long as material cannot be annihilated.
dependent variable
A varying quantity whose changes are arbitrary but regarded as produced by changes in other variables on which the varying quantity depends. For example, temperature is a function of the spatial coordinates and time. In a narrower sense, the dependent variables, or solution components, are the unknowns in a mathematical PDE model. Compare to independent variable.
differential-algebraic equation (DAE)
A set of equations that includes both differential and algebraic equations. A DAE is classified in terms of its index, a positive integer, which is related to the minimum number of differentiations needed to transform a DAE to an ODE form.
direct solver
A solver for a system of linear equations that uses some variant of Gaussian elimination. Compare to iterative solver.
Dirichlet boundary condition
A Dirichlet boundary condition specifies the value of the function (dependent variable) on a boundary. Dirichlet boundary conditions are sometimes called essential boundary conditions or constraints. See also constraint.
discretization
The process of dividing a continuous system into a finite number of elements with finite size. The difference between the finite-element representation and the real system, the discretization error, drops as the size of the elements decreases. For a time-dependent analysis, a discretization of time into steps provides an idealized behavior of the variations in the solution during these steps.
divergence element
A finite element with properties suitable for representing certain electromagnetic vector fields. The degrees of freedom on the boundary of a mesh element correspond to normal components of the field.
domain
A topological part of the modeling space in a geometry model. The geometric representation of a domain is a line segment (interval) in 1D, an area in 2D, and a volume in 3D. In a mathematical context, the symbol Ω represents the domain where the equations are defined.
domain decomposition
Domain decomposition is a solver method that divides the modeling domain into subdomains where the equations in the subdomains are easier to solve. The total solution is then obtained by iterating between the computed solutions for each subdomain using the currently known solutions from the other subdomains as boundary conditions.
drop tolerance
A nonnegative scalar used in the incomplete LU preconditioner for the iterative solvers. See incomplete LU factorization.
dynamic model
See time-dependent model.
edge, edge segment
A geometric entity representing a bounded part of a curve. An edge or edge segment is a boundary in a 2D geometry. See also domain.
edge element
See vector element.
eigenvalue PDE
A PDE that describes an eigenvalue problem with unknown eigenmodes (eigenfunctions) u and eigenvalues λ. The coefficient form eigenvalue PDE is:
elliptic PDE
A linear stationary second-order elliptic PDE has the form
where c is positive or negative definite (for example, Poisson’s equation).
embed
To insert a 2D geometry into a 3D geometry model.
error
Deviations from the correct solution, primarily due to: poor modeling; discretization (such as insufficiently fine mesh, poor elements, or insufficiently short time steps); and roundoff and truncation (depending on numerical representation, ill-conditioning, or the solution algorithms).
error estimate
An estimation of the error in the numeric solution to a problem, either locally or globally, primarily for use by an adaptive mesh refinement. See also adaptive mesh refinement, error.
equivalent boundaries
Boundaries that are rigid transformations of each other and have compatible meshes. See also periodic boundary condition.
essential boundary condition
See Dirichlet boundary condition.
Eulerian formulation
An Eulerian formulation means that the partial differential equations that describe some physics are formulated in a spatial frame (coordinate system), with coordinate axes fixed in space. An Eulerian formulation is common for fluid flow when the focus is on specific locations in space through which fluid flows. Compare to Lagrangian formulation.
exclusive node
A boundary condition or material model in a domain is exclusive when there can only be one such node defined for a given geometric entity. Adding another exclusive boundary condition to the same boundary, for example, the last added boundary condition (last in the Model Builder tree) overrides any other similar boundary condition defined on the same boundary. Examples of exclusive boundary conditions are prescribed displacements in structural mechanics and specified temperature in heat transfer. See also contributing node.
extended mesh
A data structure that includes the full finite element mesh. See also mesh, node point.
extended multiphysics
A model that includes nonlocal couplings and dependencies between variables, where the value at a point is the result of a computation elsewhere in the domain or in another geometry defined in the same model. Coupling operators provide the ability to project or extrude values from one geometry or domain to another. Compare to multiphysics.
exterior boundary
An exterior boundary for a dependent variable u is a boundary such that u is defined only on one of the adjacent domains, that is, a boundary to the computational domain. See also boundary.
extrude
To create a 3D geometry object from a 2D geometry object in a work plane or a planar face in 3D by translating (extruding) it in the normal direction.
extrusion nonlocal coupling
A coupling defined in the destination that takes values from the source by interpolation at points that depend on the position of the evaluation points in the destination.
face
A geometric entity describing a bounded part of a surface in a 3D geometry. A face is a boundary in a 3D geometry. See also domain.
fallback feature
Used with the pair node to enable pairs to have the option to add additional subnodes with conditions for nonoverlapping parts of the pair.
FEM
See finite element method.
Fick’s law
The first law relates the concentration gradients to the diffusive flux of a solute infinitely diluted in a solvent. The second law introduces the first law into a differential material balance for the solute.
field variables
Dependent variables and variables derived from them, defined as fields — functions of x, y, z, and t in a general time-dependent 3D case.
fillet
A curved transition from one boundary to another, creating a rounded corner.
finalized geometry
The resulting geometry used for assigning materials and physics. COMSOL Multiphysics creates the finalized geometry by forming a union of the entire geometry sequence or by forming an assembly where the geometry objects in the geometry sequence are treated as individual parts. The finalized geometry consists of geometric entities.
finite element
In the mathematical sense, a mesh element together with a set of shape functions and corresponding degrees of freedom. The linear combinations of the shape functions form a space of functions called the finite element space. In the traditional FEA sense, the concept of a finite element also includes the discretized form of the PDEs that govern the physics. COMSOL generally uses finite element in the mathematical sense.
finite element analysis (FEA)
A computer-based analysis method for field problems using the finite element method.
finite element method (FEM)
A computational method that subdivides an object into very small but finite-size elements. The physics of one element is approximately described by a finite number of degrees of freedom (DOFs). Each element is assigned a set of characteristic equations (describing physical properties, boundary conditions, and imposed forces), which are then solved as a set of simultaneous equations to predict the object’s behavior.
finite element space
The linear space of functions where the finite element approximation to the solution of a PDE problem is sought. The functions in the finite element space are linear combinations of basis functions (shape functions).
finite volume method (FVM)
A computation method that, in ways similar to the finite element method, computes values at discrete places on a meshed geometry. Finite volume refers to the small volume surrounding each node point in a mesh.
finite void
A finite volume in the geometry that is not defined as a solid domain and that cannot contain a volumetric finite element mesh; only physics interfaces based on the boundary element method can be active in finite voids.
flux condition
A boundary condition that specifies the value of the normal flux across a boundary, also known as a natural boundary condition. A (generalized) Neumann boundary condition is a special case.
flux vector
The general flux vector is as below, with three terms: the first term describes diffusion, the second term describes convection with a velocity −α, and the third term γ is a source term. See also generalized Neumann boundary condition and normal flux.
frame
A frame is a coordinate system that is fixed in space, to a material, to the geometry, or to a mesh. The frames make it possible to use an Eulerian formulation or a Lagrangian formulation for various physics in a model or using the arbitrary Lagrangian-Eulerian (ALE) method. The following frame types are available: material frame (reference frame), geometry frame, mesh frame, and spatial frame.
free mesh
An unstructured mesh that can represent any geometry. Compare to mapped mesh.
free mesher
The mesh generator creating free meshes. The mesh generator creating triangular elements is also referred to as the free triangle mesher, and the mesh generator creating quadrilateral elements is also referred to as the free quad mesher.
free quad mesher
The mesh generator creating unstructured quadrilateral meshes.
free tet mesher
The mesh generator creating unstructured tetrahedral meshes.
free triangle mesher
The mesh generator creating unstructured triangular meshes.
function
COMSOL Multiphysics supports user-defined functions, which can be analytic, piecewise, and interpolation functions as well as special types of common functions that implement, for example, steps, ramps, and other wave forms. There are also common built-in mathematical functions such as trigonometric functions, logarithms, and special functions.
Gauss point
A Gauss point is an integration point in the special case of numerical integration using Gaussian quadrature. Sometimes, Gauss point is improperly used as a synonym for integration point. See also integration point.
Galerkin boundary element method
A variant (the Galerkin method) of the method for solving linear partial differential equations that have been formulated as integral equations (the boundary element method) in which the integrals over the source and field patches are the same.
general form PDE
A PDE in the general form is a PDE formulation suited for nonlinear PDEs:
generalized Neumann boundary condition
A generalized Neumann boundary condition (also called a mixed boundary condition or a Robin boundary condition) specifies the value of a linear combination of the normal flux and the dependent variables on a boundary. For a coefficient form PDE, the generalized Neumann boundary condition is
The generalized Neumann condition is often called just Neumann condition in the documentation.
generalized reaction force
see reaction term.
geometric entities
The basic parts that constitute the finalized geometry: In 3D, they are divided into the following four types or geometric entity levels: domains, boundaries (faces), edges, and points (vertices). In 2D, there are no faces, and the edges are the boundaries. In 1D, there are only domains and points, which are also the boundaries.
geometric entity level
The geometric entity levels are the vertex, edge, face, and domain levels (in 3D). An entity of dimension one less than the space dimension is referred to as a boundary. See also geometric entities.
geometric multigrid (GMG)
A geometric multigrid solver or preconditioner performs one or more cycles of a multigrid method, using a coarsening of the discretization based on a coarsening of the mesh or a reduction in the order of the shape functions. Compare to algebraic multigrid (AMG).
geometry frame
In the geometry frame (coordinate system), the domain is fixed and identical to the original geometry. No physics is formulated directly in the geometry frame — only the material frame and spatial frame have physical significance. The geometry frame is used only as a reference for the Deformed Geometry interface and for postprocessing. When there is no Deformed Geometry interface present, the geometry frame is identical to the material frame.
geometry model
A collection of geometric entities that form a complete geometric description of the model.
geometry object
An object generated by a geometry feature. See also point object, curve object, surface object, primitive geometry object, solid object, and mixed object.
geometry sequence
The sequence of geometry features that define a geometry (of a model component) plus other settings that define the geometry. In the Model Builder, this is represented by the Geometry node and its child nodes.
grid
A grid usually refers to sets of evenly-spaced parallel lines at particular angles to each other in a plane, or the intersections of such lines. Compare to mesh.
Hermite element
A finite element similar to the Lagrange element. The difference is that there are degrees of freedom for the (first-order) space derivatives at the mesh vertices. See also Lagrange element.
hexahedral element
A 3D mesh element with eight corners and six faces, also referred to as brick element; sometimes also called hex element as a short form.
higher-order element
A finite element with basis functions that consists of polynomials of degree 2 or higher.
hybrid geometry modeling
Creating a geometry model using a combination of boundary modeling/surface modeling and solid modeling.
hyperbolic PDE
A typical example of a linear second-order hyperbolic PDEs is the wave equation
where ea and c are positive.
IGES file
An IGES file contains 3D CAD data, including the 3D geometry, in an open format according to the Initial Graphics Exchange Specification. IGES files can be imported into COMSOL Multiphysics using the CAD Import Module.
ill-conditioning
An ill-conditioned system is sensitive to small changes in the inputs and is susceptible to roundoff errors. See also condition number.
imprint
An imprint of the usually smaller boundary on the larger boundary that makes the parts in a pair match. An imprint inserts points on the boundary in 2D and creates edges on the boundary in 3D.
incomplete LU factorization
An approximate LU factorization where small matrix elements are discarded to save memory and computation time. The drop tolerance is a relative measure of the smallness of the elements that should be discarded. See also LU factorization.
independent variable
A variable that can cause variation in a second, dependent variable. The independent variables are most often spatial coordinates and time. Compare to dependent variable.
index, for DAE
See differential-algebraic equation.
infinite void
A single unbounded region, surrounding the geometry, that cannot contain a volumetric finite element mesh; only physics interfaces based on the boundary element method can be active in an infinite void.
initial condition
The starting values for the dependent variables in a time-dependent analysis and for nonlinear iterations or other iterative solvers.
integration nonlocal coupling
A coupling that evaluates integrals of expressions over the source and returns a single scalar value when used in the destination, which for this type of nonlocal coupling is the entire model. Similar functionality is available to evaluate the average, minimum, and maximum values.
integration order
The order (a positive integer) in a numerical integration formula where evaluation points and weights are chosen such that result of the numerical integration is exact for all expressions that are polynomials of an order that is no higher than the specified integration order.
integration point
See numerical integration formula.
interactive meshing
Building a mesh in an incremental fashion where each meshing operation acts on a set of geometry domains.
interior boundary
An interior boundary for a dependent variable u is a boundary such that u is defined on both adjacent domains or in no adjacent domain. See also boundary.
interval
The domain between two vertices (points) in a 1D geometry. Also called a domain.
inverted curved element
An inverted curved element occurs when a curved mesh element inverts locally when more node points are added to better approximate the shape of the geometry. There are many possible geometrical causes, but the element is often too large compared to the geometry feature size.
isoparametric element
A finite element that uses the same shape function for the element shape coordinates as for the dependent variables.
isosceles triangle
A triangle with at least two equal sides (and two equal angles).
iteration
See iterative solver.
iterative solver
A solver for a system of linear equations that uses an iterative method, calculating a sequence of more and more accurate approximations to the solution. Each step in this sequence is one linear iteration. This should not be confused with the Newtons iterations (nonlinear iterations) that occur in the solution of a nonlinear system of equations. Compare to direct solver and nonlinear iteration.
Jacobian matrix
A matrix containing the first derivative of a vector-valued function of a vector variable. In particular, it is the derivative of the residual vector with respect to the solution vector. When used in this narrower sense, the term stiffness matrix is sometimes used.
Lagrange element
A finite element with polynomial shape functions of a certain order (degree). The value of the function is used as the degree of freedom, and the node points are the Lagrange points.
Lagrange multiplier
An extra dependent variable introduced in the flux conditions when a constraint is added. The Lagrange multiplier often has a physical meaning and an interpretation as a (generalized) reaction force. See also constraint.
Lagrange point
In a mesh element, the Lagrange points of order k are the points whose local (element) coordinates are integer multiples of 1/k. These points are used as node points for the Lagrange element. For example, the Lagrange points of order 1 are the corners of the mesh element.
Lagrangian formulation
A Lagrangian formulation means that the partial differential equations that describe some physics are formulated in a material frame (coordinate system) with coordinate axes fixed to the material in its reference configuration and following the material as it deforms. The Lagrangian formulation is common for solid mechanics because it makes anisotropic material properties independent of the current spatial orientation of the material. Compare to Eulerian formulation.
linear iteration
A step in a linear iterative solver. See iterative solver. Compare to nonlinear iteration.
linear PDE
An equation where both sides are sums of a known function, the unknown functions, and their partial derivatives, multiplied by known coefficients that only depend on the independent variables. Other PDEs are called nonlinear.
LU factorization
For a linear system of equations, a version of Gaussian elimination that produces a factorization A = LU of the coefficient matrix, where L and U are the lower and upper triangular matrices, respectively. This makes it easy to quickly solve a number of systems with the same coefficient matrix. See also direct solver.
mapped mesh
A structured mesh with quadrilateral elements generated by mapping using transfinite interpolation.
mapped mesher
The mesh generator creating mapped meshes.
mass matrix
The matrix E that multiplies the second time derivative of the solution vector in the linearized discretized form of a PDE problem. If there are no second time derivatives (that is, if E = 0), then the term mass matrix is often used for the matrix D that multiplies the first derivative of the solution vector (the D matrix is otherwise called the damping matrix).
material frame
The material frame defines a coordinate system that is fixed to the material in its reference configuration and follows the material as it deforms. The material frame is used in connection with a Lagrangian formulation. This frame is also referred to as a reference frame.
mathematical and numerical constants
Built-in common mathematical constants such as π and i and numerical constants such as the machine precision or machine epsilon.
mesh
A subdivision of the entities of a geometric model into, for example, triangles (2D) or tetrahedra (3D). These are examples of mesh elements. See also grid, structured mesh, and unstructured mesh.
mesh element
The individual elements in the mesh that together form a partitioning of the geometry, for example, triangular elements and tetrahedral elements. See also finite element. A curved mesh element is a mesh element that is extended with additional node points to better approximate the shape of the geometry.
mesh frame
In the mesh frame (coordinate system), the domain is fixed until an automatic or manual remeshing operation is performed, as well as between remeshing events. When remeshing is not used, the mesh frame is identical to the geometry frame.
mesh vertex
An endpoint or corner of a mesh element. See also node point and vertex.
meshing sequence
The sequence of meshing features that define a mesh. In the Model Builder, this is represented by the Mesh node and its child nodes.
method of lines
A method for solving a time-dependent PDE through a space discretization, resulting in a set of ODEs.
mixed boundary condition
See generalized Neumann boundary condition.
mixed object
A nonempty geometry object that is not a solid object, surface object, curve object, or point object. For example, the union of a solid object and a curve object is a mixed object.
mode reduction
A model-reduction technique for reducing systems with many degrees of freedom, such as large finite element models, to a form with fewer degrees of freedom for dynamic system simulations and analysis. See also state-space model.
model coupling
See nonlocal coupling.
model input
Model inputs are fields such as temperature and velocities or other physical properties that act as inputs for material properties and model equations. The model inputs can be fields computed by other physics interfaces or user-defined values.
model file for Java
A file that contains Java® commands calling on the COMSOL API. Use a text editor to extend and modify the model file. Compiling and running a model file for Java creates the COMSOL Multiphysics model.
model file for MATLAB
A text file containing commands that create a COMSOL Multiphysics model. A model file for MATLAB is a text file (M-file) that is similar to a model file for Java and that can be modified and used with MATLAB. If you have a MATLAB license and a license for LiveLink™ for MATLAB®, the COMSOL Desktop can load a model file for MATLAB. Compare with Model MPH-file.
Model MPH-file
A binary data file with the extension .mph that contains a COMSOL Multiphysics model or application. Often also just called model file or application file.
model object
An object (data structure) that contains all data for a model. This is the fundamental data structure in a COMSOL Multiphysics model.
Model Wizard
Part of the COMSOL Desktop that is used to start building a model. It contains the Select Space Dimension, Select Physics, and Select Study Type pages.
MRI data
Magnet resonance imaging (MRI) data is an image data format, primarily for medical use. MRI produces high-quality images of the inside of the human body. 3D MRI data is usually represented as a sequence of 2D images.
multigrid
A solver or preconditioner for a linear system of equations that computes a sequence of increasingly accurate approximations of the solution by using a hierarchy of coarsened versions of the linear system (having fewer degrees of freedom). See also algebraic multigrid, geometric multigrid.
multiphysics
Multiphysics models include more than one equation and variable from different types of physics. These variables can be defined in different domains. The equations can be coupled together through equation coefficients that depend on variables from other equations. Compare to extended multiphysics.
natural boundary condition
See Neumann boundary condition.
Neumann boundary condition
A Neumann boundary condition specifies the value of the normal flux across a boundary. Neumann boundary conditions are sometimes called natural boundary conditions. Compare to generalized Neumann conditions.
Newton’s method
An iterative solver method, also called the Newton-Raphson method, for solving nonlinear equations. See also nonlinear iterations.
Newton-Raphson method
See Newton’s method.
node point
Any point in the mesh element where the degrees of freedom are defined. The node points often include the mesh vertices and possibly interior or midpoint locations. See also degree of freedom (DOF) and mesh vertex.
nonlinear iteration
A Newton step in the solution of a nonlinear PDE problem. Each nonlinear iteration involves the solution of a linear system of equations. Compare to linear iteration.
nonlinear PDE
See linear PDE.
nonlocal coupling
User-defined nonlocal couplings are used to couple data within a model component (geometry) or between different model components (geometries). See also extrusion nonlocal coupling, projection nonlocal coupling, and integration nonlocal coupling. Nonlocal couplings can be reused with different arguments (for example, for integrating different quantities over the same domain).
norm
A scalar measure of the magnitude of a vector or a matrix. Several types of norms are used to measure the accuracy of numerical solutions.
numerical integration formula
A numerical integration method that approximates an integral by taking the weighted sum of the integrand evaluated at a finite number of points, the integration points (sometimes improperly called Gauss points). Also called quadrature formula.
normal flux
The normal component of the flux vector at a boundary.
NURBS
The nonuniform rational B-spline (NURBS) is a curve and surface representation scheme. A NURBS representation can be divided into a number of rational Bézier curves or surfaces.
online model reduction
In the context of model reduction, online refers to using the reduced order for evaluations rather than producing them.
operator, operator function
A user-defined operator function, or just operator, is similar to a function but behaves differently. For example, COMSOL Multiphysics includes differentiation operators that take expressions as input arguments to define a derivative of an expression with respect to a variable. There are also built-in arithmetic, relational, and logical operators.
order of a finite element
The degree of the polynomials that define the shape functions (basis functions).
ordinary differential equation (ODE)
An equation involving functions and their derivatives. The derivatives are with respect to one independent variable only. Compare to partial differential equation (PDE).
parabolic PDE
A typical example of a linear 2nd-order parabolic PDE is the heat equation
where da and c are positive.
parameter
A constant that can take on different values for each model in a parametric analysis. See also constant.
partial differential equation (PDE)
An equation involving functions and their partial derivatives; that is, an equation that includes derivatives with respect to more than one independent variable. Compare to ordinary differential equation (ODE).
periodic boundary condition
A boundary condition where the values of the solution appear in a periodic pattern, typically so that the value of the solution on one boundary is equal to the value on another boundary. See also equivalent boundaries.
phasor
A complex number or a vector of complex numbers representing a sinusoidally varying current or voltage.
physical quantity
A quantity (quantifiable property) that can be used in the mathematical equations of science and technology.
physics interfaces
Sets of physics nodes for different types of physics in the COMSOL Desktop environment. The physics interfaces (sometimes referred to as the physics) contain predefined equations and boundary conditions and a set of nodes for setting up models for that type of physics.
pivot
Usually a value on the main diagonal of the stiffness matrix. Pivoting is the interchanging of rows and columns in order to place a particularly large element in the diagonal position. The value of the diagonal element when it is used to eliminate values below it is called the pivot value.
point
A location in space. Often used in a narrower sense with the same meaning as vertex.
point object
A geometry object with only vertices.
positive definiteness
A symmetric matrix is positive definite when all its eigenvalues are positive.
preconditioner
The convergence rate of iterative methods depends on the spectral properties of the coefficient matrix. A preconditioner is a matrix that transforms the linear system into one that has the same solution but that has more favorable spectral properties. See also algebraic multigrid, geometric multigrid, incomplete LU factorization, iterative solver, and SSOR.
preselection
A selection of one or more geometric entities, such as domains or boundaries, that is not assigned to a physics feature or any other node in the model tree. Such a preselection can then be assigned to, for example, a physics feature that you add to the model tree.
primitive, primitive geometry object
A geometry object with a basic shape such as a cube or a sphere. Add primitives to a model, using arbitrary sizes and positions, and combine them to form complex shapes. See also constructive solid geometry, composite geometry object, and Boolean operations.
prism element
A 3D mesh element with six corners and five faces, also referred to as wedge element.
projection nonlocal coupling
A coupling that takes values from the source by evaluating line integrals over lines whose positions are dependent on the position of the evaluation points in the destination.
quadrature formula
See numerical integration formula.
quadrilateral element
A 2D mesh element with four corners and four edges; sometimes also called quad element as a short form.
rational Bézier curve
See Bézier curve.
reaction force
see reaction term.
reaction term
Terms that are automatically added to the system of equations in order to enforce a constraint. Reaction terms from boundary constraints appear as a flux condition and share the same physical meaning. Using an analogy from structural mechanics, reaction terms are sometimes referred to as (generalized) reaction forces.
reference frame
See material frame.
residual vector
The vector L in the discretized form of a PDE problem. In the absence of constraints, the discrete form of a stationary equation is 0 = L(U) where U is the solution vector.
revolve
To create a 3D geometry object from a planar face by rotating it about an axis.
Robin boundary condition
See generalized Neumann boundary condition.
shape function
A basis function described in local element coordinates. See also basis function.
shift
A value σ around which an eigensolver searches for eigenvalues.
simplex element
Triangle element in 2D and tetrahedral element in 3D.
solid
See solid object.
solid modeling
A 3D geometry modeling method that describes both the boundary and interior of the geometry using solid objects. See also constructive solid geometry (CSG) and solid object.
solid object
A geometry object whose vertices, edges, and faces all have an adjacent domain.
solution component
See dependent variable.
solution matrix
A matrix that contains a sequence of solutions as columns. A steady-state problem results in a solution vector, but eigenvalue problems, time-dependent problems, and parametric analyses produce a solution matrix.
solution vector
A vector with components that contain all the degrees of freedom (values of the dependent variables) as its components. See also solution matrix.
solver sequence
A sequence of named solver settings and commands that can be replayed by a single solver call.
sparse matrix
Matrix for which the number of zero elements is large enough to justify special data types and algorithms that avoid operations on zero elements.
spatial frame
The spatial frame defines a coordinate system with coordinate axes fixed in space. The spatial frame (also called the Eulerian frame) is used in connection with a Eulerian formulation.
split
To divide a geometry object into its minimal parts.
stability
A solver for a time-dependent model is unconditionally stable if the initial conditions are not amplified artificially and the roundoff errors do not grow, regardless of the size of the time step. A solver is conditionally stable if there is a maximum value of the time step above which the numerical solution is unstable.
state-space model
A linear time-invariant representation of a dynamic system as a set of first-order ODEs of the form
where x is the state vector, u is the input, and y is the output. A, B, C, and D are the constant dynamics, input, output, and direct transmission matrices, respectively.
static model
See stationary model.
stationary model
A model where the dependent variables do not change over time. It typically represents a steady-state solution. Also called static model or steady model.
steady model
See stationary model.
stiffness matrix
See Jacobian matrix.
streakline
The locus of particles that have earlier passed through a prescribed point in space. See also streamline.
streamline
A curve that is tangent to the vector field everywhere (in particular a velocity field) at a given instant of time. Sometimes called a flow line or flux line. See also streakline.
streamline-diffusion stabilization
A numerical technique for stabilization of the numeric solution to a PDE by artificially adding diffusion in the direction of the streamlines.
strong form
A partial differential equation in the strong form is the standard formulation as an equality of functions. The strong form is divided into the coefficient form and the general form. Compare to coefficient form, general form, and weak form.
structured mesh
A mesh for which all elements and nodes have the same topology. Compare to unstructured mesh.
surface
A smooth mathematical function from 2D to 3D space.
surface normal
A vector perpendicular to the surface.
surface modeling
A 3D geometry modeling method to describe a geometry by defining its bounding surfaces. Compare to boundary modeling and solid modeling.
surface object
A geometry object without domains, isolated edges, or isolated vertices. Typically a trimmed surface is represented as a surface object.
swept mesh
A 3D mesh generated by sweeping a face mesh along a domain.
symmetric matrix
A matrix that equals its own transpose.
symmetric successive overrelaxation (SSOR)
A symmetric successive overrelaxation (SSOR) preconditioner uses classic SSOR iterations.
symmetry
The invariance of an object attribute or of the object itself under a transformation such as inversion, rotation, or reflection. A symmetry allows for a reduction of the model geometry so that appropriate boundary conditions account for the redundant portions of the geometry. Axial symmetry is a common type of symmetry.
symmetric constraint
A constraint that is enforced by reaction terms chosen so as to preserve the symmetry of symmetric unconstrained systems. This choice of reaction terms is unique and leads to a bidirectional constraint that modifies the equations corresponding to all dependent variables appearing in the constrained expression.
symmetry boundaries
See equivalent boundaries.
test function
See weak form.
tetrahedral element
A 3D mesh element with four corners, six edges, and four triangular faces.
time-dependent model
See transient model.
transient model
A model where at least one of the dependent variables changes over time, for example, the heat equation or the wave equation. Also called dynamic model, time-dependent model, or unsteady model.
triangular element
A 2D mesh element with three corners and three edges.
trimmed surface
If the parameter space of a surface is divided into “valid” and “invalid” regions, the image of the valid regions is called the trimmed surface. This corresponds to the part of the surface limited by a closed loop of edges lying on the surface.
unidirectional constraint
A constraint enforced by reaction terms that only affect one of the dependent variables in a constraint of type u1 = u2. The other dependent variables are treated as independent with respect to the unidirectional constraint. Compare to symmetric constraint. See also constraint.
unstructured mesh
A mesh without a specific pattern where the elements can have different shapes and the nodes can have different connectivities. Compare to structured mesh.
unsteady model
See time-dependent model.
user-defined variable
A user-defined variable can be defined on a global level or on any geometric entity in terms of dependent variables, independent variables, parameters, constants, and other variables.
vector element
A finite element often used for electromagnetic vector fields. Each mesh element has degrees of freedom corresponding only to tangential components of the field. Also called curl element, Nédélec’s edge element, or just edge element.
vertex
A point in a geometry model, often an endpoint of an edge or an intersection of geometric entities of a higher degree such as edges or faces. A vertex is referred to as a point for the specification of point sources and other PDE modeling. See also domain.
weak constraint
A reformulation of a constraint as a weak form equation. When using a weak constraint, the corresponding Lagrange multiplier becomes a solution component (dependent variable).
weak form
A partial differential equation in the weak form is a more general formulation than the strong form. It is produced by multiplying the strong form PDE with an arbitrary function called the test function and integrating over the computational domain. Physics interfaces in COMSOL Multiphysics are implemented using a weak form. Compare to strong form.
wedge element
See prism element.
well-posed
A well-posed mathematical problem has a unique solution and depends continuously on its input, such as initial conditions, source terms, and boundary conditions.
work plane
An embedded 2D work space that can be positioned relative to the coordinate planes or an already existing 3D geometry. Using work planes makes it possible to define a geometry in terms of previously created geometry objects such as points, edges, and faces. From a work plane with a 2D geometry, 3D geometry objects can be created using extrude or revolve operations.