Useful Equations Glossary



Table of Contents

  • Multivariable Calculus
  • Differential Equations
  • Complex Analysis
  • Graph Theory
  • Matrix Methods
  • Fourier Analysis
  • Mechanics
  • Electrostatics
  • Diffusion
  • Electrochemistry
  • Quantum Chemistry
  • Computational Neuroscience
  • Probability
  • Information Theory
  • Electrical Engineering

Multivariable Calculus

Line integrals in a scalar field give the area under a space curve. The formula can be generalized for more variables.

LineIntegralScalarField - corrected

When a line integral is taken using a vector field, the work performed by the vector field on a particle moving along a space curve in the field can be computed. This is applicable to numerous analogous situations as well. The line integral in a vector field is given by the equation below. F defines the vector field and the curve C is a vector function given by r(t).
Eq2

The gradient is the vector of the partial derivatives of a function with respect to each of its variables.

Eq3

The gradient can be operated on in a variety of ways. For instance, the dot product of the gradient and a unit vector gives the directional derivative (the rate of change in the direction of that unit vector).

Eq4

Divergence is a measure of the “flow” emerging from any point in a vector field. Positive divergence indicates a “source,” while negative divergence indicates a “sink.”

Eq5

Curl describes the amount of counterclockwise rotation around any point in a vector field. Positive curl indicates more counterclockwise rotation, while negative curl indicates more clockwise rotation. 2D curl has a simple formula (below, top) and 3D curl has a somewhat more complicated formula (below, bottom).

Eq100

Integration by parts is a way to “reverse the product rule.” For integration by parts, let f(x)=u and g(x)=v.

Eq7

The Laplacian is the sum of unmixed second partial derivatives of a multivariable function. Roughly speaking evaluating the Laplacian at a point measures the “degree to which that point acts as a minimum.” Consider f(x,y,z). When a high positive value comes from evaluating the Laplacian at a point, that point will likely have a lower value for f than most of the neighboring points.    

Eq8

Differential Equations

Given a first order linear differential equation that can be arranged into the form given by the top equation below, the solution to that differential equation is given by the bottom equation below.

Eq9

The Laplace transform is useful for solving differential equations with known initial values for y(t), y(t), y’’(t), and any higher order derivatives present. It is defined by the top equation, but it is often easier to employ tables of Laplace transforms of common functions and modify the results for the problem of interest. Laplace transforms have a variety of useful properties described by the rest of the equations below. Furthermore, the Laplace transform is a linear operator.

Eq10

Complex Analysis

Euler’s identity relates e, i, and ϴ to trigonometric functions.

Eq11

For a complex valued function, f(z) = w, the complex variable z maps to another complex variable w. Complex valued functions can be described as a transformation from a point (x,y) to a point (u,v) as given by the equation below.

Eq12

Trigonometric functions of a complex variable z can be represented in terms of exponentials. In addition, a complex function f(z) raised to the power of another complex function g(z) may be expressed as the bottom equation.

Eq13

Complex integrals are also called contour integrals. Integrals of complex functions can be expressed in terms of line integrals if f(z) is continuous on a parameterized space curve.

Eq14

Cauchy’s integral formula states that, for a simply connected domain D and a curve C which lies within D and contains a point z0, the equation below holds. (Simply connected domains have no “holes” and their boundaries do not cross each other).

Eq15

In complex analysis, residues come from a generalized (to complex numbers) version of Taylor series called Laurent series. They are useful in evaluating contour integrals. If the complex part of a Laurent series contains a finite number of terms, then z = z0 is called a pole of order n. Here, n is the power to which (z – z0) is raised in the denominator of that term in the given Laurent series. If n=1, the pole is called a simple pole and can be computed by the formulas at top or middle. For higher order poles, the formula at bottom can compute the residue.

Eq16

Cauchy’s residue theorem requires a simply connected domain D with a closed contour C inside and a function f(z) which is differentiable on and within C except at a finite number of points z1, z2, … zn. If these conditions are met then, the contour integral of f(z) may be computed by the equation below.

Eq17

 

Graph Theory

The handshaking lemma states that, for any graph G(V,E), the sum of the node degrees equals twice the number of edges.

Eq18

Euler’s formula holds for simple (undirected and no self-edges) planar graphs. Planar graphs are graphs that can be represented without any edges crossing each other. V represents the number of nodes, E represents the number of edges, and F represents the number of faces including the infinite face outside of the graph.Euler’s formula holds for simple (undirected and no self-edges) planar graphs. Planar graphs are graphs that can be represented without any edges crossing each other. V represents the number of nodes, E represents the number of edges, and F represents the number of faces including the infinite face outside of the graph.

Eq19

The clustering coefficient for a graph is given below. Here, n is the number of edges among the neighbors of node i and k is the number of neighbors of node i.

Eq20

 

Matrix Methods

The matrix product is described by the equation below. Note that the inner dimensions of the matrices must match for the matrix product to be defined.

Eq101

The transpose of any matrix is applied as in the example below.

Eq21

The determinant of a 2×2 matrix is given by the equation below.

Eq22

Eigenvalues and eigenvectors are very useful for a variety of applications. They are related to a matrix A and a vector x by the equation at top. To find the eigenvalues of a matrix, apply the formula at middle and find the zeros of the resulting polynomial. The zeros are the eigenvalues of the matrix. The eigenvectors of an eigenvalue can be found by solving the system at bottom for x1…xn. The set of all scalar multiples of the solved vector [x1…xn] is the set of eigenvectors for the given eigenvalue.

Eq23

 

Fourier Analysis

Fourier series are weighted sums of sines and cosines that can represent any periodic signal. Here, the period of signal s is given by T.

Eq24

The Fourier series coefficients are the weights of the sines and cosines. They are given by the integrals below.

Eq25

The continuous Fourier transform takes in a signal function s(t) and decomposes it into its component weighted sines and cosines. It employs the relationship between complex numbers, sines, and cosines to achieve this. Fourier transforms are said to convert from the time domain to the frequency domain. By observing the frequency domain, a signal can be more easily analyzed and decoded.

Eq26

Since the output of a Fourier transform is usually complex, the equation below can be used to convert the output to a power spectrum.

Eq27

The signal can be reconstructed using the inverse Fourier transform. This is useful in data compression since the data can undergo a Fourier transform and then later be reconstructed using the inverse Fourier transform, given below.

Eq28

The discrete Fourier transform has the same purpose as the continuous version, but it operates on discrete data s(k) and so uses summation rather than integration.

Eq29

Power spectra can also be computed for discrete Fourier transforms.

Eq30

By applying the discrete Fourier transform and then the inverse discrete Fourier transform (below), a discrete signal can be compressed and then reconstructed.

Eq31

 

Mechanics

Multidimensional equation of motion (constant acceleration).

Eq32

Momentum in kg•ms-1 (top), work in J given constant force (middle), circular motion at constant speed (bottom).

Eq33

Newton’s second law in terms of mass and acceleration (top) and in terms of momentum (bottom). Force is measured in Newtons.

Eq34

Work-energy theorem.

Eq35

Velocity of an object undergoing circular motion given its period.

Eq36

Force from potential energy in 3D.

Eq37

Potential energy function for spring (top) and spring force formula (bottom).

Eq38

Objects move to minimize their potential energy. When the net force is zero, so is the derivative of the potential energy. Note that stable and unstable fixed points apply here.

Eq39

Energy of isolated system with thermal energy U.

Eq40

Multidimensional power with constant force. Power is measured in J/s.

Eq41

Multidimensional work with variable force (given by a vector field) as a line integral.

Eqn42

 

Electrostatics

Suppose that a constellation of point charges exists at a given time. If a new charge, q0 is brought into the vicinity of the other charges and placed at a location x,y,z, then the force from the other charges on q0 is given by the equation below. The ȓ0j represents a unit vector extending from qj to the point x,y,z. The ϵ0 represents a constant known as the permittivity of free space and is equal to 8.85•10-12.

Eq43

The electric field in the above scenario is defined as the equation below, where F has been divided by q0.

Eq44

To calculate the electric field from a continuous charge distribution at a point x0,y0,z0, the triple integral below is used over the volume region D. The unit vector ȓ points from (x,y,z) to (x0,y0,z0).

Eq45

The electrostatic potential energy of a point charge q brought into the vicinity of an electric field E is given by a line integral describing the work performed on the point charge to move it from position r0 to r.

Eq46

Given an electrostatic potential function UE, the electric field is given by the gradient of UE.

Eq47

 

Diffusion

Fick’s first law of diffusion describes the relationship between the flux J of particles across an area and the concentration of the particles. D is a proportionality constant called the diffusion coefficient. The law is given in 1D at top and in 3D at bottom.

Eq48

Fick’s second law of diffusion describes how particles flow given a concentration gradient. The law is given in 1D at top and in 3D at bottom. This is equivalent to the heat equation.

Eq49

 

Electrochemistry

The Nernst equation describes the membrane voltage given an ion’s concentration on each side of the membrane. R is the gas constant (8.314 J/K), F is Faraday’s constant (96,485 C/mol), z is the charge of the ion, and T is the temperature in Kelvin.

Eq50

The Goldman equation expresses the membrane voltage given multiple types of ions and relative permeabilities of the membrane to those ions.

Eq51

The Nernst-Planck equation describes ion flow with electrical potential and concentration gradients. Jp indicates particle flux over an area, D is a diffusion coefficient, UE is the electrical potential, e represents the elementary charge of 1.6•10-19 C, z is the charge of the given type of ion, and u is the mobility constant of the ion in the solution.

Eq52

The free energy required for an ion to cross a semipermeable membrane (like a phospholipid membrane) is given by the equation below. This equation accounts for a preexisting membrane voltage from another ion. If the free energy is negative, the ions in the first term will spontaneously cross the semipermeable membrane. Note that the numerator and denominator within the natural logarithm are switched relative to the Nernst equation.

Eq53

 

Quantum Chemistry

The Rydberg equation gives the wavelength emitted when an electron moves from an excited state ni to a lower energy level nf. Here, R is the Rydberg constant, 1.097•107 m-1.

Eq54

Given an electromagnetic wave, its velocity (the speed of light c), frequency, and wavelength are related by the equation below.

Eq55

Particles have wavelengths known as de Broglie wavelengths. They can be computed using Planck’s constant 6.626•10-34 m2kg/s over the momentum mv.

Eq56

The energy of a wave (in J) is given by the formulas below. Note that frequency is equivalent to c/λ.

Eq57

The time independent Schrödinger equation relates the wavefunctions of a particle and its energy. Solving this equation gives a formula for the wavefunction of a given particle. The symbol  represents h/2π. V(x) is the potential energy, m is the mass, and E is the energy. The 1D version is shown at top and the 3D version is shown at bottom.

Schrodinger - corrected

The Hamiltonian operator describes the kinetic and potential energy of a quantum system. It can be applied to wavefunctions to generate the Schrödinger equation. The Hamiltonian in 1D is given at top and the Hamiltonian in 3D is given at bottom.

Hamiltonian - corrected

The wavefunction solution of a 1D particle in a box with boundary conditions ψ(0)=0 and ψ(L)=0 is given at top. The n represents the discrete energy level of the particle and may take on values of 1,2,3… The energy of the particle at energy level n is given at bottom.

Eq60

The wavefunction solution of a 3D particle in a box with boundary conditions ψ(0,y,z)=0, ψ(Lx,y,z)=0, ψ(x,0,z)=0, ψ(x,Ly,z)=0, ψ(x,y,0)=0, ψ(x,y,Lz)=0 is given at top. The nx, ny, and nz represent the x,y,z components of the particle’s discrete energy level n. Each component must still be a poösitive integer. The energy of the particle at energy level n is given at bottom.

Eq61

The integral of the wavefunction squared denotes the probability that a particle will be found within a given region. Since wavefunctions may be complex, the square must be computed using the complex conjugate. This is the 1D version of the equation.

Eq62

The average or expectation value of a measurable property (associated with an operator) is given in 1D and 3D by the integrals below. Note that the integral in the denominator acts to normalize the result.

Eq63

The time-dependent Schrödinger equation describes the evolution of a wavefunction over time.

Eq64

The general solution to the time-dependent Schrödinger equation is the time-independent wavefunction times a complex exponential.

Eq65

 

Computational Neuroscience

Consider the spikes of a single neuron being recorded over a time interval t. This experiment is carried out for K trials. The firing rate v in trial k is given by the number of spikes over t. Repeating the experiment several times allows the repeatability of the spike count nk across repetitions to be calculated. This variability, the Fano Factor, is the variance of the spike count over the mean spike count.

Eq66

To construct a peri-stimulus-time histogram, consider a spike train over time interval t with k trials. Split the interval into subintervals (t; t + ∆t) and sum the number of spikes over all trials within each subinterval. Then divide by k∆t, the number of trials times the size of each subinterval. 

Eq67

Average neural population activity can be computed from simultaneously measuring of j different neurons over a time interval t. Split the time interval into subintervals (t; t + ∆t) and sum the number of spikes over the whole population for each subinterval. Then divide by j∆t to obtain the average population activities at each subinterval.

Eq68

Integrate-and-fire neurons are modeled by a linear differential equation. The solution to that differential equation given an initial condition v(0) = vrest is shown below. The variable v represents the membrane voltage, R is the membrane resistance, I0 is the injected current, and τ is a time constant for the membrane. When using integrate-and-fire neurons, a firing threshold is often set.

Eq69

The Hodgkin-Huxley equations are a system of differential equations that model neural electrophysiology. The system must be solved numerically. The C(dv/dt) term, in which capacitance is multiplied by the change in voltage with respect to time, is equivalent to current across the membrane. Note that membrane voltage is a function of time. Eion is the equilibrium potential for that ion across the membrane, Iin is the injected current, and gion is the conductance value for that ion across the membrane. The parameters m, n, and h help describe the gating of the ion channels and fit the model to data.

Eq70

 

Probability

Conditional probability (the probability of B happening given A).

Eq71

Joint probability (the probability of A and B occurring). This is described using an intersection. Joint probability for three events and four events is also given. Further extrapolation follows the same pattern.

Eq72

The probability of A or B, but not both (described using a union). The probability of A, B, or C but not any other combination of the events is also given. Further extrapolation follows the same pattern.

Eq73

Bayes theorem gives the probability of an event based on prior knowledge of other conditions that may have influence on the event.

Bayes - corrected

For a discrete random variable, a probability mass function gives the probability associated with each outcome of a random experiment.

Eq75

Cumulative distribution functions (CDFs) give the probability that a random variable X will give a value less than or equal to x.

Eq76

For a continuous random variable, the integral of a probability density function fX gives the probability that the outcome lies on the chosen interval.

Eq77

The expected value is the average of each outcome times its probability. The discrete case is given at top and the continuous case is given at bottom.

Eq78

The variance is a measure of the spread of data. The square root of variance is standard deviation. The general equation for variance is given at top. To compute discrete variance, use the equation at middle. To compute continuous variance, use the equation at bottom.

Eq79

Given a set of n total elements, a permutation is a selection of k elements from the set such that the order does matter. The number of permutations of a set is given below.

Eq80

Given a set of n total elements, a combination is a selection of k elements from the set such that the order does not matter. The number of combinations of a set is given below.

Eq81

 

Information Theory

Shannon information is a measure of “surprise” associated with an outcome. The units are bits and p(x) is the probability of the given outcome.

Eq82

Entropy is the average amount of Shannon information from a stochastic data source.

Eq83

Joint entropy is the entropy for multiple random variables (the joint entropy for two random variables is given below).

Eq84

Conditional entropy is the entropy of X given that a particular outcome y (from the other variable) is known.

Eq85

Mutual information measures the mutual dependence of two random variables. It does not necessarily imply causality, though sometimes it is associated with causality. The mutual information I(X;Y) is given by the sum of individual entropies minus the joint entropy.

Eq86

 

Electrical Engineering

Electrical current is defined as the amount of charge in Coulombs that flows through a conductor or circuit element per unit time. The Coulomb is a unit of charge that is equivalent to 1.602•1019 elementary charges. One electron has a charge of -1.602•10-19 C. Current is measured in amperes, which are C/s. Voltage is defined as the amount of energy per unit charge that moves through a given circuit element. It is measured in J/C or volts. Voltage can be thought of as electrical potential energy. Resistance has units of V/A or ohms, represented by Ω. Current, voltage, and resistance are related by Ohm’s law (top). Conductance refers to the inverse of resistance, is represented by G, and is measured in inverse ohms Ω-1 or siemens S. Ohm’s law in terms of conductance is given at bottom.

Eq87

Power is the rate of energy transfer in J/s or watts. Power is given by the product of current and voltage.

Eq88

Energy delivered to a circuit element is computed by integrating power over a time interval.

Eq89

Kirchhoff’s current law states that the net current entering a node equals zero. The net current equals the sum of currents entering minus the sum of currents leaving. Alternatively, this law states that the sum of the currents entering a node equals the sum of the currents leaving the node. If several circuit elements are connected to a pair of nodes which are themselves connected, then the circuit elements can be considered as connected to a common node.

Eq90

The closed path from a node, through some circuit elements, and back to the same node is called a loop. Kirchhoff’s voltage law states that the sum of the voltage changes around a closed loop in a circuit equals zero. If the path taken around the loop starts in the direction of a circuit element that undergoes a voltage drop, that circuit element is given a positive value. If the path starts by crossing a circuit element such that there is a voltage gain, that circuit element is given a negative value.

Eq91

If the length L of a resistor is much larger than its cross sectional area A, then the resistance can be approximated by the formula below. The letter ρ is a constant for the material of the given resistor called the resistivity. The resistivity is measured in ohm meters Ωm.

Eq93

Resistances in series can be summed into a single resistance. This single equivalent resistance can replace the original set of resistances in the analysis.

Eq94

Resistances in parallel can be converted into a single equivalent resistance using the equation below.

Eq95

The equation for conductance in series is given below.

Eq97

The equation for conductance in parallel is given below.

Eq98

The capacitance for a parallel plate capacitor, measured in Farads (coulombs per volt), is given by the equation below. Here, ε is the dielectric constant for the material between the plates, A is measured in square meters, and d is measured in meters.

Eq99

 

 

2 Comments

Leave a comment