List of numerical analysis topics

This is a list of numerical analysis topics.

General

Error

Error analysis (mathematics)

Elementary and special functions

Numerical linear algebra

Numerical linear algebra — study of numerical algorithms for linear algebra problems

Basic concepts

Solving systems of linear equations

Eigenvalue algorithms

Eigenvalue algorithm — a numerical algorithm for locating the eigenvalues of a matrix

Other concepts and algorithms

Interpolation and approximation

Interpolation — construct a function going through some given data points

  • Nearest-neighbor interpolation — takes the value of the nearest neighbor

Polynomial interpolation

Polynomial interpolation — interpolation by polynomials

Spline interpolation

Spline interpolation — interpolation by piecewise polynomials

Trigonometric interpolation

Trigonometric interpolation — interpolation by trigonometric polynomials

Other interpolants

  • Simple rational approximation
    • Polynomial and rational function modeling — comparison of polynomial and rational interpolation
  • Wavelet
  • Inverse distance weighting
  • Radial basis function (RBF) — a function of the form ƒ(x) = φ(|xx0|)
    • Polyharmonic spline — a commonly used radial basis function
    • Thin plate spline — a specific polyharmonic spline: r2 log r
    • Hierarchical RBF
  • Subdivision surface — constructed by recursively subdividing a piecewise linear interpolant
    • Catmull–Clark subdivision surface
    • Doo–Sabin subdivision surface
    • Loop subdivision surface
  • Slerp (spherical linear interpolation) — interpolation between two points on a sphere
    • Generalized quaternion interpolation — generalizes slerp for interpolation between more than two quaternions
  • Irrational base discrete weighted transform
  • Nevanlinna–Pick interpolation — interpolation by analytic functions in the unit disc subject to a bound
    • Pick matrix — the Nevanlinna–Pick interpolation has a solution if this matrix is positive semi-definite
  • Multivariate interpolation — the function being interpolated depends on more than one variable
    • Barnes interpolation — method for two-dimensional functions using Gaussians common in meteorology
    • Coons surface — combination of linear interpolation and bilinear interpolation
    • Lanczos resampling — based on convolution with a sinc function
    • Natural neighbor interpolation
    • PDE surface
    • Transfinite interpolation — constructs function on planar domain given its values on the boundary
    • Trend surface analysis — based on low-order polynomials of spatial coordinates; uses scattered observations
    • Method based on polynomials are listed under Polynomial interpolation

Approximation theory

Approximation theory

Miscellaneous

Finding roots of nonlinear equations

See #Numerical linear algebra for linear equations

Root-finding algorithm — algorithms for solving the equation f(x) = 0

Optimization

Mathematical optimization — algorithm for finding maxima or minima of a given function

Basic concepts

Linear programming

Linear programming (also treats integer programming) — objective function and constraints are linear

Convex optimization

Convex optimization

Nonlinear programming

Nonlinear programming — the most general optimization problem in the usual framework

Optimal control and infinite-dimensional optimization

Optimal control

  • Pontryagin's minimum principle — infinite-dimensional version of Lagrange multipliers
    • Costate equations — equation for the "Lagrange multipliers" in Pontryagin's minimum principle
    • Hamiltonian (control theory) — minimum principle says that this function should be minimized
  • Types of problems:
    • Linear-quadratic regulator — system dynamics is a linear differential equation, objective is quadratic
    • Linear-quadratic-Gaussian control (LQG) — system dynamics is a linear SDE with additive noise, objective is quadratic
      • Optimal projection equations — method for reducing dimension of LQG control problem
  • Algebraic Riccati equation — matrix equation occurring in many optimal control problems
  • Bang–bang control — control that switches abruptly between two states
  • Covector mapping principle
  • Differential dynamic programming — uses locally-quadratic models of the dynamics and cost functions
  • DNSS point — initial state for certain optimal control problems with multiple optimal solutions
  • Legendre–Clebsch condition — second-order condition for solution of optimal control problem
  • Pseudospectral optimal control
    • Bellman pseudospectral method — based on Bellman's principle of optimality
    • Chebyshev pseudospectral method — uses Chebyshev polynomials (of the first kind)
    • Flat pseudospectral method — combines Ross–Fahroo pseudospectral method with differential flatness
    • Gauss pseudospectral method — uses collocation at the Legendre–Gauss points
    • Legendre pseudospectral method — uses Legendre polynomials
    • Pseudospectral knotting method — generalization of pseudospectral methods in optimal control
    • Ross–Fahroo pseudospectral method — class of pseudospectral method including Chebyshev, Legendre and knotting
  • Ross–Fahroo lemma — condition to make discretization and duality operations commute
  • Ross' π lemma — there is fundamental time constant within which a control solution must be computed for controllability and stability
  • Sethi model — optimal control problem modelling advertising

Infinite-dimensional optimization

Uncertainty and randomness

Theoretical aspects

Applications

  • In geometry:
    • Geometric median — the point minimizing the sum of distances to a given set of points
    • Chebyshev center — the centre of the smallest ball containing a given set of points
  • In statistics:
    • Iterated conditional modes — maximizing joint probability of Markov random field
    • Response surface methodology — used in the design of experiments
  • Automatic label placement
  • Compressed sensing — reconstruct a signal from knowledge that it is sparse or compressible
  • Cutting stock problem
  • Demand optimization
  • Destination dispatch — an optimization technique for dispatching elevators
  • Energy minimization
  • Entropy maximization
  • Highly optimized tolerance
  • Hyperparameter optimization
  • Inventory control problem
    • Newsvendor model
    • Extended newsvendor model
    • Assemble-to-order system
  • Linear programming decoding
  • Linear search problem — find a point on a line by moving along the line
  • Low-rank approximation — find best approximation, constraint is that rank of some matrix is smaller than a given number
  • Meta-optimization — optimization of the parameters in an optimization method
  • Multidisciplinary design optimization
  • Optimal computing budget allocation — maximize the overall simulation efficiency for finding an optimal decision
  • Paper bag problem
  • Process optimization
  • Recursive economics — individuals make a series of two-period optimization decisions over time.
  • Stigler diet
  • Space allocation problem
  • Stress majorization
  • Trajectory optimization
  • Transportation theory
  • Wing-shape optimization

Miscellaneous

Numerical quadrature (integration)

Numerical integration — the numerical evaluation of an integral

Numerical methods for ordinary differential equations

Numerical methods for ordinary differential equations — the numerical solution of ordinary differential equations (ODEs)

Numerical methods for partial differential equations

Numerical partial differential equations — the numerical solution of partial differential equations (PDEs)

Finite difference methods

Finite difference method — based on approximating differential operators with difference operators

Finite element methods, gradient discretisation methods

Finite element method — based on a discretization of the space of solutions gradient discretisation method — based on both the discretization of the solution and of its gradient

  • Finite element method in structural mechanics — a physical approach to finite element methods
  • Galerkin method — a finite element method in which the residual is orthogonal to the finite element space
  • Rayleigh–Ritz method — a finite element method based on variational principles
  • Spectral element method — high-order finite element methods
  • hp-FEM — variant in which both the size and the order of the elements are automatically adapted
  • Examples of finite elements:
  • Direct stiffness method — a particular implementation of the finite element method, often used in structural analysis
  • Trefftz method
  • Finite element updating
  • Extended finite element method — puts functions tailored to the problem in the approximation space
  • Functionally graded elements — elements for describing functionally graded materials
  • Superelement — particular grouping of finite elements, employed as a single element
  • Interval finite element method — combination of finite elements with interval arithmetic
  • Discrete exterior calculus — discrete form of the exterior calculus of differential geometry
  • Modal analysis using FEM — solution of eigenvalue problems to find natural vibrations
  • Céa's lemma — solution in the finite-element space is an almost best approximation in that space of the true solution
  • Patch test (finite elements) — simple test for the quality of a finite element
  • MAFELAP (MAthematics of Finite ELements and APplications) — international conference held at Brunel University
  • NAFEMS — not-for-profit organisation that sets and maintains standards in computer-aided engineering analysis
  • Multiphase topology optimisation — technique based on finite elements for determining optimal composition of a mixture
  • Interval finite element
  • Applied element method — for simulation of cracks and structural collapse
  • Wood–Armer method — structural analysis method based on finite elements used to design reinforcement for concrete slabs
  • Isogeometric analysis — integrates finite elements into conventional NURBS-based CAD design tools
  • Loubignac iteration
  • Stiffness matrix — finite-dimensional analogue of differential operator
  • Combination with meshfree methods:
  • Variational multiscale method
  • List of finite element software packages

Other methods

  • Spectral method — based on the Fourier transformation
    • Pseudo-spectral method
  • Method of lines — reduces the PDE to a large system of ordinary differential equations
  • Boundary element method (BEM) — based on transforming the PDE to an integral equation on the boundary of the domain
    • Interval boundary element method — a version using interval arithmetics
  • Analytic element method — similar to the boundary element method, but the integral equation is evaluated analytically
  • Finite volume method — based on dividing the domain in many small domains; popular in computational fluid dynamics
    • Godunov's scheme — first-order conservative scheme for fluid flow, based on piecewise constant approximation
    • MUSCL scheme — second-order variant of Godunov's scheme
    • AUSM — advection upstream splitting method
    • Flux limiter — limits spatial derivatives (fluxes) in order to avoid spurious oscillations
    • Riemann solver — a solver for Riemann problems (a conservation law with piecewise constant data)
    • Properties of discretization schemes — finite volume methods can be conservative, bounded, etc.
  • Discrete element method — a method in which the elements can move freely relative to each other
    • Extended discrete element method — adds properties such as strain to each particle
    • Movable cellular automaton — combination of cellular automata with discrete elements
  • Meshfree methods — does not use a mesh, but uses a particle view of the field
  • Methods designed for problems from electromagnetics:
    • Finite-difference time-domain method — a finite-difference method
    • Rigorous coupled-wave analysis — semi-analytical Fourier-space method based on Floquet's theorem
    • Transmission-line matrix method (TLM) — based on analogy between electromagnetic field and mesh of transmission lines
    • Uniform theory of diffraction — specifically designed for scattering problems
  • Particle-in-cell — used especially in fluid dynamics
    • Multiphase particle-in-cell method — considers solid particles as both numerical particles and fluid
  • High-resolution scheme
  • Shock capturing method
  • Vorticity confinement — for vortex-dominated flows in fluid dynamics, similar to shock capturing
  • Split-step method
  • Fast marching method
  • Orthogonal collocation
  • Lattice Boltzmann methods — for the solution of the Navier-Stokes equations
  • Roe solver — for the solution of the Euler equation
  • Relaxation (iterative method) — a method for solving elliptic PDEs by converting them to evolution equations
  • Broad classes of methods:
    • Mimetic methods — methods that respect in some sense the structure of the original problem
    • Multiphysics — models consisting of various submodels with different physics
    • Immersed boundary method — for simulating elastic structures immersed within fluids
  • Multisymplectic integrator — extension of symplectic integrators, which are for ODEs
  • Stretched grid method — for problems solution that can be related to an elastic grid behavior.

Techniques for improving these methods

Grids and meshes

  • Grid classification / Types of mesh:
    • Polygon mesh — consists of polygons in 2D or 3D
    • Triangle mesh — consists of triangles in 2D or 3D
      • Triangulation (geometry) — subdivision of given region in triangles, or higher-dimensional analogue
      • Nonobtuse mesh — mesh in which all angles are less than or equal to 90°
      • Point-set triangulation — triangle mesh such that given set of point are all a vertex of a triangle
      • Polygon triangulation — triangle mesh inside a polygon
      • Delaunay triangulation — triangulation such that no vertex is inside the circumcentre of a triangle
      • Constrained Delaunay triangulation — generalization of the Delaunay triangulation that forces certain required segments into the triangulation
      • Pitteway triangulation — for any point, triangle containing it has nearest neighbour of the point as a vertex
      • Minimum-weight triangulation — triangulation of minimum total edge length
      • Kinetic triangulation — a triangulation that moves over time
      • Triangulated irregular network
      • Quasi-triangulation — subdivision into simplices, where vertices are not points but arbitrary sloped line segments
    • Volume mesh — consists of three-dimensional shapes
    • Regular grid — consists of congruent parallelograms, or higher-dimensional analogue
    • Unstructured grid
    • Geodesic grid — isotropic grid on a sphere
  • Mesh generation
    • Image-based meshing — automatic procedure of generating meshes from 3D image data
    • Marching cubes — extracts a polygon mesh from a scalar field
    • Parallel mesh generation
    • Ruppert's algorithm — creates quality Delauney triangularization from piecewise linear data
  • Subdivisions:
  • Apollonian network — undirected graph formed by recursively subdividing a triangle
  • Barycentric subdivision — standard way of dividing arbitrary convex polygons into triangles, or the higher-dimensional analogue
  • Improving an existing mesh:
  • Jump-and-Walk algorithm — for finding triangle in a mesh containing a given point
  • Spatial twist continuum — dual representation of a mesh consisting of hexahedra
  • Pseudotriangle — simply connected region between any three mutually tangent convex sets
  • Simplicial complex — all vertices, line segments, triangles, tetrahedra, ..., making up a mesh

Analysis

  • Lax equivalence theorem — a consistent method is convergent if and only if it is stable
  • Courant–Friedrichs–Lewy condition — stability condition for hyperbolic PDEs
  • Von Neumann stability analysis — all Fourier components of the error should be stable
  • Numerical diffusion — diffusion introduced by the numerical method, above to that which is naturally present
    • False diffusion
  • Numerical dispersion
  • Numerical resistivity — the same, with resistivity instead of diffusion
  • Weak formulation — a functional-analytic reformulation of the PDE necessary for some methods
  • Total variation diminishing — property of schemes that do not introduce spurious oscillations
  • Godunov's theorem — linear monotone schemes can only be of first order
  • Motz's problem — benchmark problem for singularity problems
  • Variants of the Monte Carlo method:
    • Direct simulation Monte Carlo
    • Quasi-Monte Carlo method
    • Markov chain Monte Carlo
      • Metropolis–Hastings algorithm
        • Multiple-try Metropolis — modification which allows larger step sizes
        • Wang and Landau algorithm — extension of Metropolis Monte Carlo
        • Equation of State Calculations by Fast Computing Machines — 1953 article proposing the Metropolis Monte Carlo algorithm
        • Multicanonical ensemble — sampling technique that uses Metropolis–Hastings to compute integrals
      • Gibbs sampling
      • Coupling from the past
      • Reversible-jump Markov chain Monte Carlo
    • Dynamic Monte Carlo method
    • Particle filter
    • Reverse Monte Carlo
    • Demon algorithm
  • Pseudo-random number sampling
    • Inverse transform sampling — general and straightforward method but computationally expensive
    • Rejection sampling — sample from a simpler distribution but reject some of the samples
      • Ziggurat algorithm — uses a pre-computed table covering the probability distribution with rectangular segments
    • For sampling from a normal distribution:
    • Convolution random number generator — generates a random variable as a sum of other random variables
    • Indexed search
  • Variance reduction techniques:
    • Antithetic variates
    • Control variates
    • Importance sampling
    • Stratified sampling
    • VEGAS algorithm
  • Low-discrepancy sequence
  • Event generator
  • Parallel tempering
  • Umbrella sampling — improves sampling in physical systems with significant energy barriers
  • Hybrid Monte Carlo
  • Ensemble Kalman filter — recursive filter suitable for problems with a large number of variables
  • Transition path sampling
  • Walk-on-spheres method — to generate exit-points of Brownian motion from bounded domains
  • Applications:
    • Ensemble forecasting — produce multiple numerical predictions from slightly initial conditions or parameters
    • Bond fluctuation model — for simulating the conformation and dynamics of polymer systems
    • Iterated filtering
    • Metropolis light transport
    • Monte Carlo localization — estimates the position and orientation of a robot
    • Monte Carlo methods for electron transport
    • Monte Carlo method for photon transport
    • Monte Carlo methods in finance
      • Monte Carlo methods for option pricing
      • Quasi-Monte Carlo methods in finance
    • Monte Carlo molecular modeling
      • Path integral molecular dynamics — incorporates Feynman path integrals
    • Quantum Monte Carlo
      • Diffusion Monte Carlo — uses a Green function to solve the Schrödinger equation
      • Gaussian quantum Monte Carlo
      • Path integral Monte Carlo
      • Reptation Monte Carlo
      • Variational Monte Carlo
    • Methods for simulating the Ising model:
      • Swendsen–Wang algorithm — entire sample is divided into equal-spin clusters
      • Wolff algorithm — improvement of the Swendsen–Wang algorithm
      • Metropolis–Hastings algorithm
    • Auxiliary field Monte Carlo — computes averages of operators in many-body quantum mechanical problems
    • Cross-entropy method — for multi-extremal optimization and importance sampling
  • Also see the list of statistics topics

Applications

Software

For a large list of software, see the list of numerical-analysis software.

Journals

Researchers

References

  1. ^ Smith, N. J. J. (2008). "Worldly Vagueness and Semantic Indeterminacy". Vagueness and Degrees of Truth. pp. 277–316. doi:10.1093/acprof:oso/9780199233007.003.0007. ISBN 9780199233007.