Two mathematical expressions can be equal {equation, algebra}. Mathematical expression can be less than or greater than another mathematical expression {inequality, mathematics}.
Polynomial equations have at least one solution {fundamental theorem of algebra}. The fundamental theorem of algebra requires complex numbers.
Linear equations {bilinear equation} can have products of two variables: c*x*y + b = 0, where x and y are variables to first power, and c and b are constants. Bilinear equations can be sums of indexed variables: a11 * x1 * y1 + a12 * x1 * y2 + ... + aNN * aN * yN, where aNN are constants, and xN and yN are indexed variables.
Graphs can approach limiting slope {asymptote, graph}|, as independent variable approaches infinity or negative infinity.
Circles {unit circle} can have center at origin of Cartesian coordinates and radius one unit.
angle
Unit-circle points define angle between radius and positive x-axis.
Counterclockwise angle is positive. 90 degrees equals pi/2 radians. 180 degrees equals pi radians. 270 degrees equals 3 * pi/2 radians.
Clockwise angle is negative. -90 degrees equals -pi/2 radians. -180 degrees equals -pi radians. -270 degrees equals -3 * pi/2 radians.
coordinates
Unit-circle point (x,y) relates to angle A by trigonometric functions: x = cos(A) and y = sin(A). Coordinates x and y relate: x^2 + y^2 = 1, because radius = 1.
Equation solutions {root, equation}| {zero, equation} are variable values that make equation true {solution, equation} {equation, solving}. Roots {null, equation} can be non-existent or zero. Equation-solution number equals equation degree. Two or more solutions can be equal {multiplicity, solution}.
order
Equations have highest exponent. Roots can be highest radical {order, radical} {radical, order}.
homogeneity
Equations can equal zero: f(x) = 0. Homogeneous equations have solutions.
polynomial
If polynomials have real-number coefficients, one factor is coefficient of highest-power term times product of polynomials of form (x - r) or (x^2 - (r + r')*x + r*(r')), where r is root and r' is root complex conjugate. Root complex conjugate is also a root.
complex number
If x and n are real, equation x^n = -1 solutions are complex numbers {roots of unity} {nth roots of unity}. For x^2 = -1, x = i. For x^3 = -1, x = i^(2/3). If w and z are complex, equation w^z = 1 solutions are log(1) = 0, 2 * pi * i, 4 * pi * i, 6 * pi * i, 8 * pi * i, ...
In unit circle, solutions are regular-polygon vertices, forming complex-number cyclic group Zn, a finite multiplicative group.
If equations {determinate equation} have only one unknown variable, equation has a numerical solution. If equation {indeterminate equation} has more than one unknown variable, equation has solution in terms of unknowns. If unknowns number equals equation number, equation system has numerical solutions. If unknowns number is more than equation number, equation system has solutions in terms of unknowns.
Expressions can have numeric values {evaluation, expression}.
To check solution steps {checking solution}, do additions and multiplications forward and backward, making sure that sign is correct. For (x - 3) / (x + 2) = x / (x - 2), x^2 - 2*x - 3*x + 6 = x^2 + 2, so 7x = 6.
For general quadratic-equation solution, quantity {discriminant, solution} under square root sign is b^2 - 4*a*c.
If unknowns number is less than equation number, solutions {extraneous solution}| can depend on other solutions.
For polynomials divisible by (x - a)^n, root a {repeated root} repeats n times.
If polynomial equals zero and has two positive or negative terms in succession, at least one root is negative {signs and roots rule} {rule of signs and roots}. If polynomial equals zero and has positive term succeeding negative term, or negative term succeeding positive term, at least one root is positive.
If you know two function points, two points make a line, and you can use the linear function to estimate function values {extrapolation}| for independent-variable values greater than the larger, or less than the smaller, of the point independent-variable values.
If you know two function points, two points make a line, and you can use the linear function to estimate function values {interpolation}| for independent-variable values between the point independent-variable values.
All terms with unknown variable can be on left or right equation side {isolate variable}.
process
Remove exponents outside parentheses by multiplying.
Remove all fractions and divisions by multiplying out all denominators. Factor denominator and cancel factors, divide into numerator to get quotient, or multiply both equation sides by denominator.
Remove parentheses by performing all multiplications, to make sum of terms.
Make irrational numbers or variables rational by taking both equation sides to power.
Multiply repeated variables in terms to make one variable.
Add similar terms.
Add all constants.
Put all terms containing unknown variable on one equation side.
roots
Assume left-side expression has unknown variable. Find left-side-expression roots by polynomial factoring or other method. Find right-side-expression roots. For whole equation, root is left-side-expression root minus right-side-expression root.
If h is small compared to x, change (x + h)^n to x + n*h to remove exponent and make linear {linearize}.
Equation sets {linear-equation system} {system of linear equations} can have only variables to first power. To find roots, use determinant laws. To determine points and slopes, use determinant laws. To rearrange equations, use matrix laws.
In equation systems {determinative system} {consistent system} {simultaneous system}, number of independent equations can equal number of variables, and all variables have numerical solutions. Number of independent equations can be less than number of variables {inconsistent system}, so not all variables have numerical solutions. If some equations are equivalent to others {dependent system}, not all variables have numerical solutions. Number of independent equations can be more than number of variables {overdetermined system}.
For linear-equation systems {triangular form}, first linear equation can have only first variable, second equation can have only first and second variables, and so on.
For linear-equation system, variable equals determinant value divided by resultant-determinant value {Cramer's rule} {Cramer rule}.
If two equations contain unknown raised to power, eliminate unknown from both equations by substitution {dialytic method}.
To eliminate a term {elimination, equation}, subtract one equation from another equation. If needed, multiply equation by coefficient or variable before subtracting.
Dividing equations by coefficients and subtracting equations {Gauss-Jordan elimination} can solve equation systems.
process
Divide first row by first-variable coefficient {pivot element}, so first-variable coefficient is one. For other rows, subtract multiple of first row to make first-variable coefficient equal zero, and replace row with resulting row.
Divide new second row by second-variable coefficient, so second-variable coefficient is one. For other rows, subtract multiple of second row to make second-variable coefficient equal zero, and replace row with resulting row.
Follow same steps for all rows. Use pivoting to avoid dividing by zero.
result
All rows begin with variable with coefficient equal one. All rows begin with different variables: row n begins with nth variable.
To solve equation systems, multiply {multiplier method} one equation by a scalar to make unknown's coefficient the same as unknown's coefficient in a second equation. Then subtract first equation from second equation to eliminate term with the unknown. Multiplier method does not change resultant determinant.
Interchanging rows {partial pivoting} or interchanging rows and columns {full pivoting} can put term to eliminate on the diagonal {pivoting in equation solving}. Typically, pivot is largest term.
To solve linear-equation systems, sum all linear-equation powers to derive a power function and then find power-function minimum {power function, linear equations}.
To solve equation systems, rearrange equation terms to have only one variable on equation left side {substitution, equation}. In second equation containing that variable, substitute first-equation right side for variable, to eliminate variable from second equation. This is an example of replacing whole by sum of its parts.
Numbers, terms, and vectors can be in arrays {matrix, mathematics}. Two-dimensional matrices have vertical positions {column, matrix}, horizontal positions {row, matrix}, and elements {cell, matrix}. Infinite matrices can have any number of dimensions, with any number of elements, as in quantum mechanics.
notation
Matrix notation is braces.
examples
One-element matrix is scalar. One-row matrix is vector.
multiplication
Matrices have products of scalars, vectors, and matrices.
purposes
Matrix elements can represent relations between set members. Matrices can be truth-tables, with element T or F listed for statement pairs. Propositions can be matrices in Boolean algebra form.
Matrices can be ordered-set components. Sequences can be n-dimensional matrices.
Matrices can represent states and operations of mathematical groups, state spaces, and symmetries. Matrices can represent particle-pair spin states.
Matrices can represent graphs. Rows and columns represent nodes. Elements are connection values between nodes.
Matrices model linear equations. Quadratic expressions use matrices to find moments of inertia. Product of solution-matrix transpose and coefficient matrix and solution matrix can find linear-equation solutions.
Matrices have cell values {element, matrix}.
Matrices have number of dimensions {order, matrix}. Scalars have order zero. Vectors have order one. Two-dimensional matrices have order two.
Matrices have maximum row or column number {rank, matrix}.
For linear equations, matrix equations {characteristic equation, matrix} can set matrix determinant minus x times unit-matrix determinant equal to zero-matrix determinant: |M| - x * |1| = |0|. Solving for x gives equation roots.
Characteristic-equation-root sums {trace, matrix} can be matrix parameters. Unitary matrices have invariant traces {character function} {group character} {character, matrix} that characterize the mathematical group that the matrix represents.
Coefficient-matrix A and solution-matrix X product can have a factor {lambda} {characteristic value}: A*X = lambda * X.
Adding corresponding elements adds matrices {matrix addition}. Adding vectors is an example. Summing matrices is like adding one effect to another effect to get total effect.
To multiply matrices {matrix multiplication} {matrix dot product}, multiply each row by each column. Matrix with m columns and n rows times matrix with n columns and p rows makes matrix of m columns and p rows. First-matrix rows and second-matrix columns must have same rank. For 1x1 matrices [a11] and [b11], matrix dot product is [a11*b11]. For 2x2 matrices [a11 a12 / a21 a22] and [b11 b12 / b21 b22], matrix dot product is [a11*b11 + a11*b21 a12*b12 + a12*b22 / a21*b11 + a21*b21 a22*b12 + a22*b22]. For example, [1 2 / 3 4] . [5 4 / 3 2] = [1*5+1*3 2*4+2*2 / 3*5+3*3 4*4+4*2].
vector
Vector dot products are matrix multiplications of one-row 1xN matrix with one-column Nx1 matrix.
properties
Matrix multiplication is not commutative but is associative.
purposes
Multiplying matrices indicates results of interactions between two effects. Squaring matrix is like repeating operation.
Cross products {matrix cross product} of two square matrices indicate interactions between set-A and set-B members: A x B. Matrix cross products can find extensive quantities, such as area, from intensive quantities, such as vector distances. Matrix cross products are differences between matrix dot product and reverse matrix dot product: A x B = (A . B) - (B . A). Only square matrices can have matrix cross products. Matrix cross products find square matrices. For 1x1 matrices [a11] and [b11], matrix cross product is [a11*b11 - b11*a11] = [0]. For 2x2 matrices [a11 a12 / a21 a22] and [b11 b12 / b21 b22], matrix cross product is [a11*b11 + a11*b21 a12*b12 + a12*b22 / a21*b11 + a21*b21 a22*b12 + a22*b22] - [b11*a11 + b11*a21 b12*a12 + b12*a22 / b21*a11 + b21*a21 b22*a12 + b22*a22] = [a11*b11 + a11*b21 - b11*a11 - b11*a21 a12*b12 + a12*b22 - b12*a12 - b12*a22 / a21*b11 + a21*b21 - b21*a11 - b21*a21 a22*b12 + a22*b22 - b22*a12 - b22*a22] = [a11*b21 - b11*a21 a12*b22 - b12*a22 / a21*b11 - b21*a11 a22*b12 - b22*a12]. If both matrices are the same, matrix cross product is zero matrix: A x A = 0. Matrix cross products are not commutative: A x B = (A . B) - (B . A) <> (B . A) - (A . B) = B x A.
If M is a square matrix and another matrix is equivalent to M, their difference is zero matrix {Cayley-Hamilton theorem}. Theorem helps find characteristic equation.
For non-unitary matrices, replacing each matrix element by its complex conjugate and transposing the matrix {Hermitean operation, transposing} makes the same matrix {conjugate transpose}. For unitary matrices, matrix conjugate transpose is matrix inverse.
Interchanging any two matrix rows does not change matrix meaning {equivalence operation}. Multiplying all elements in row by non-zero number does not change matrix meaning. Replacing row by sum of itself and another row does not change matrix meaning.
Replacing each matrix element by its complex conjugate and transposing matrix {Hermitean operation, matrix} makes a matrix. Hermitean operators follow general eigenvalue theory, where (R(f),g) = (f,R(g)) and R is linear.
Square-matrix diagonal elements have a sum {trace, sum}. Matrix-product trace is first-matrix trace times second-matrix trace. Finding matrix-product traces is commutative: trace(A . B) = trace(B . A).
Matrices {cofactor matrix} can represent linear-equation systems. Columns are variables plus one column for constant. Rows are equations. Elements are variable coefficients. Alternatively, elements can be variables, and columns can be variable coefficients.
Variable-coefficient and constant matrices {augmented matrix} can represent linear-equation systems.
Matrices have associated matrix {adjoint matrix} that replaces each element by its cofactor.
Complex numbers are equivalent to 2x2 real-number matrices {complex-number matrix} whose diagonal elements are equal and whose off-diagonal elements are equal but opposite in sign: a + b*i = (a b / -b a), where / indicates row end. For example, i equals (0 1 / -1 0), and 1 equals (1 0 / 0 1). Complex numbers and 2x2 real-number matrices have the same results under addition and multiplication, and the determinant of 2x2 real-number matrices equals the absolute value of their complex numbers.
Non-singular matrices have associated matrices {inverse matrix} that are reciprocals of determinant times adjoint matrix. To find matrix inverse, replace each element by its cofactor divided by matrix determinant. Matrix inverse can solve equations. Linear-equation system has coefficient matrix A, solution matrix X, and cofactor matrix B. A-inverse times A times X equals B: A^-1 * A * X = B. Solution matrix X equals coefficient-matrix A inverse times adjoint matrix B: X = A^-1 * B.
Matrices can have standard forms {Jordan canonical form}.
Matrices can be the identity matrix {normal form, matrix}.
Linear-equation systems have variable-coefficient matrices {quadratic form} and solution matrices. Solution matrix X transpose times variable-coefficient matrix A times solution matrix X equals bivariate sum with three coefficients: (transpose of X) * A * X = a*x*x + b*x*y + c*y*y.
Matrices {singular matrix} can have determinant equal zero. Matrices {non-singular matrix} can have determinant not equal zero.
Matrices {square matrix} can have same number of rows and columns.
Square matrices {transpose matrix} {transverse matrix} can interchange rows and columns. Matrix transpose can be same as matrix {symmetric matrix}, negative of matrix {skew symmetric matrix}, or conjugate of matrix {conjugate matrix}. Transposition can define square matrices {Hermitean matrix} {skew Hermitean matrix}. Adjoint matrices have transposes. Inverse transverse-matrix can equal matrix {orthogonal matrix}.
If principal diagonal is not all zeroes, matrices {triangular matrix} can transform to have only zeroes on left or right of principal diagonal.
Square matrices {unimodular matrix} can have determinant equal one.
Matrices {unitary matrix} can have ones on diagonal and zeroes everywhere else. Products of two unitary matrices make a unitary matrix.
group
Mathematical groups have representations {representational theory, group} as sets of same-order square unitary matrices, whose determinants equal one. For groups, square unitary matrices make an orthonormal basis-vector set.
group: trace
Unitary-matrix traces are invariant under transformation. Traces characterize the mathematical group. All class members have same trace. Different class characters are orthogonal.
Matrices define square element arrays {determinant, equation}|. Determinant symbol uses vertical lines at array sides: |A|. For square matrix, determinant elements are same as matrix elements. Second-order square matrices have rows "a b" and "c d": {a b / c d}, where / denotes row end. Determinant is |a b / c d|. Second-order square matrices have four elements. Third-order square matrices have nine elements. Fourth-order square matrices have 16 elements.
value
Determinants have scalar values, which are like area. To find determinant value, multiply each element of first column or first row by its signed minor. Add all products.
value: dependence
If a determinant row is a linear combination of other rows, determinant value equals zero.
value: triangular matrix
For triangular matrices, determinant value is product of principal-diagonal elements.
inverse
If matrix has determinant value zero, matrix is singular and has no inverse.
equation system
Equation systems have coefficient and constant arrays. Resultant determinant has variable coefficients: 2*x + 3*y = 0 and 4*x + 5*y = 0 goes to |2 3 / 4 5| = 2*5 + -3*4 = 2*5 + -4*3 = -2. Variables have determinants. Constants column replaces variable-coefficient column. For variable x, |0 3 / 0 5| = 0*5 + -3*0 = 0*5 + -0*3 = 0.
Determinative non-homogeneous linear-equation systems have determinant value not equal zero. Determinative homogeneous systems of linear equations have determinant value zero. To find variable values, use coefficient and constant determinant.
Determinant elements can have subdeterminants {minor, determinant} containing elements that are not in same row and column. For determinant with rows "a b" and "c d", element-a minor is d, because a is in first row and column, and d is not in first row and not in first column. The smallest minor is one element.
Minors {signed minor} {cofactor}| can have sign. Sign depends on sum of element row and column positions. If element is in row and column whose sum is odd, sign is -1. If element is in row and column whose sum is even, sign is +1. For determinant |a b / c d|, a's signed minor is +d, because element a has row 1 and column 1, which sum to 2, which is even. b's signed minor is -c, because element b has row 1 and column 2, which sum to 3, which is odd. Therefore, determinant value is a*d - b*c.
Determinants can have squares, cubes, and higher powers {modulus, determinant}.
Determinants have a number of rows {rank, determinant}. Determinants have same number of columns, because they are square. Matrix rank is biggest non-zero-determinant number of rows.
To find determinant value, copy determinant {Sarrus rule} {rule of Sarrus}. Write all determinant rows, except last row, below copy. Multiply elements on each diagonal. Change sign on ascending diagonals, going down to right, but not sign on descending diagonals, going up to right. Add terms.
For a matrix representing linear homogeneous equations, partial-derivative coefficient determinant {Hessian determinant} indicates inflection points.
Determinants {Jacobian determinant} {functional determinant} can be for coordinate transformations: double integral of F(x,y) * dx * dy = double integral of G(u,v) * determinant(fu, fv, gu, gv) * du * dv. Jacobian determinants have two rows of partial derivatives, one row for F(x,y) and one row for G(u,v). Jacobian determines scalar for unit vectors. Jacobians can determine normal vectors at function intersections.
Product of determinant inverse and second determinant B and first determinant A calculates third determinant C {similar determinant}, which is similar to second determinant: A^-1 * B * A = C.
Equation x^p - 1 = 0 {cyclotomic equation}, where p is prime number and x is independent variable, constructs polygons in circles. Polygons in circles have rotation-symmetry groups.
Lower-order equations {defective equation} can derive from equations.
Polynomial equations {Diophantine equation} can have integer coefficients. It can have integer solutions. If system of Diophantine equations has nine variables, no algorithm can decide if system has integer solutions.
Linear equations {homogeneous equation}| can have constant equal zero.
Equations {parametric equation} can depend on one variable. For example, line has parametric equations x = x1 + t*A and y = y1 + t*B, where t is parameter, A and B are constants, x and y are coordinates, and (x1,y1) is point on line. Line slope is B/A, if A is not 0. If A = 0, line is parallel to y-axis.
Wave equation {periodic equation} repeats at regular intervals: y = A * sin(a*x + b) or y = A * cos(a*x + b) or y = A * sin(a*x + b) + B * cos(c*x + d), where A is maximum y amplitude, a and b are constants, and x is independent variable. Phase angle is a*x + b. Angle phase shift from 0 is -b/a.
Two ratios can be equal {proportion} {analogy, mathematics}: a/b = c/d. In proportion, variable can be in numerator and another variable can be in other numerator {direct variation} {direct proportion}: x/3 = y/4. In proportions, product of two variables can be in numerator {inverse variation} {inverse proportion}: x*y = 4. Direct or inverse proportion can have a constant {proportionality constant}: c * (x/3) = y/4 or c * (x*y) = 4.
Proportions can change to product equalities by multiplying {cross-multiply} both equation sides by denominator product: x/3 = y/4 goes to 12 * x/3 = 12 * y/4 = 4*x = 3*y.
Two-variable equations {symmetric equation} can interchange x and y to make same equation.
Equations {quadratic equation} {second-degree equation} {quadric equation} can have one variable raised to second power. Quadratic equations have form a*x^2 + b*x + c = 0. Solution is x = (-b + (b^2 - 4*a*c)^0.5)/(2*a) and x = (-b - (b^2 - 4*a*c)^0.5)/(2*a). Quantity under square root is b^2 - 4*a*c {discriminant, quadratic equation}.
square
If quadratic equation has form a^2 * x^2 + b * x = c, add (b/(2*a))^2 to both equation sides {completing the square}. Factor left side: (a*x + b/(2*a))^2 = c. Take square root of both sides: a*x + b/(2*a) = c^0.5. Solve for x: x = (-b/(2*a) + c^0.5)/a.
factoring
If quadratic equation has form a*(x - r1)*(x - r2) = 0, then x = r1, x = r2, a = r1 + r2, and r1 * r2 = c/a.
graph
Quadratic-equation graph has U-shape.
Equations {cubic equation} can have variable raised to third power. General cubic equation has a solution.
Equations {quartic equation} can have variable raised to fourth power. General quartic equation has a solution.
General degree-higher-than-four equations {n-tic equation} do not have solutions.
Equations {linear equation} {first-degree equation} can have variables raised only to first power.
graph
Linear-equation graph is a straight line.
form
Standard form is a1 * x1 + a2 * x2 + ... + aN * xN = b, where b is constant, a1 to aN are coefficients, and x1 to xN are variables.
homogeneous
Linear homogeneous equations equal zero.
one variable
Linear equation can have only one variable: a1 * x1 = b. Straight line can have point where line intercepts y-axis {y-intercept} and point where line intercepts x-axis {x-intercept}. Straight line inclines to x-axis {slope, line}.
Linear equation can have form a*y + b*x = c {general form}. x = (c - a*y) / b. Slope is -b/a. y-intercept is c/a.
Linear equation can have form x/a + y/b = 1 {intercept form, line}. y-intercept is a. x-intercept is b.
Straight lines in planes can have length p. x * cos(A) + y * sin(A) - p = 0 {normal equation}, where A is angle that perpendicular from origin (0,0) to straight line makes with positive x-axis.
Linear equation can have form y - A = m * (x - B) {point-slope form}. (B,A) is line point. Slope is m.
Linear equation can have form y = m*x + b {slope-intercept form}. x = (y - b) / m. Slope is m. y-intercept is b.
Outline of Knowledge Database Home Page
Description of Outline of Knowledge Database
Date Modified: 2022.0225