Search This Blog

Thursday, November 25, 2021

Partial differential equation

From Wikipedia, the free encyclopedia
 
A visualisation of a solution to the two-dimensional heat equation with temperature represented by the vertical direction and color.

In mathematics, a partial differential equation (PDE) is an equation which imposes relations between the various partial derivatives of a multivariable function.

The function is often thought of as an "unknown" to be solved for, similarly to how x is thought of as an unknown number to be solved for in an algebraic equation like x2 − 3x + 2 = 0. However, it is usually impossible to write down explicit formulas for solutions of partial differential equations. There is, correspondingly, a vast amount of modern mathematical and scientific research on methods to numerically approximate solutions of certain partial differential equations using computers. Partial differential equations also occupy a large sector of pure mathematical research, in which the usual questions are, broadly speaking, on the identification of general qualitative features of solutions of various partial differential equations. Among the many open questions are the existence and smoothness of solutions to the Navier–Stokes equations, named as one of the Millennium Prize Problems in 2000.

Partial differential equations are ubiquitous in mathematically-oriented scientific fields, such as physics and engineering. For instance, they are foundational in the modern scientific understanding of sound, heat, diffusion, electrostatics, electrodynamics, thermodynamics, fluid dynamics, elasticity, general relativity, and quantum mechanics (Schrodinger equation, Pauli equation, etc). They also arise from many purely mathematical considerations, such as differential geometry and the calculus of variations; among other notable applications, they are the fundamental tool in the proof of the Poincaré conjecture from geometric topology.

Partly due to this variety of sources, there is a wide spectrum of different types of partial differential equations, and methods have been developed for dealing with many of the individual equations which arise. As such, it is usually acknowledged that there is no "general theory" of partial differential equations, with specialist knowledge being somewhat divided between several essentially distinct subfields.

Ordinary differential equations form a subclass of partial differential equations, corresponding to functions of a single variable. Stochastic partial differential equations and nonlocal equations are, as of 2020, particularly widely studied extensions of the "PDE" notion. More classical topics, on which there is still much active research, include elliptic and parabolic partial differential equations, fluid mechanics, Boltzmann equations, and dispersive partial differential equations.

Introduction

One says that a function u(x, y, z) of three variables is "harmonic" or "a solution of the Laplace equation" if it satisfies the condition

Such functions were widely studied in the nineteenth century due to their relevance for classical mechanics. If explicitly given a function, it is usually a matter of straightforward computation to check whether or not it is harmonic. For instance

and


are both harmonic while

is not. It may be surprising that the two given examples of harmonic functions are of such a strikingly different form from one another. This is a reflection of the fact that they are not, in any immediate way, both special cases of a "general solution formula" of the Laplace equation. This is in striking contrast to the case of ordinary differential equations (ODEs) roughly similar to the Laplace equation, with the aim of many introductory textbooks being to find algorithms leading to general solution formulas. For the Laplace equation, as for a large number of partial differential equations, such solution formulas fail to exist.

The nature of this failure can be seen more concretely in the case of the following PDE: for a function v(x, y) of two variables, consider the equation

 It can be directly checked that any function v of the form v(x, y) = f(x) + g(y), for any single-variable functions f and g whatsoever, will satisfy this condition. This is far beyond the choices available in ODE solution formulas, which typically allow the free choice of some numbers. In the study of PDE, one generally has the free choice of functions.

The nature of this choice varies from PDE to PDE. To understand it for any given equation, existence and uniqueness theorems are usually important organizational principles. In many introductory textbooks, the role of existence and uniqueness theorems for ODE can be somewhat opaque; the existence half is usually unnecessary, since one can directly check any proposed solution formula, while the uniqueness half is often only present in the background in order to ensure that a proposed solution formula is as general as possible. By contrast, for PDE, existence and uniqueness theorems are often the only means by which one can navigate through the plethora of different solutions at hand. For this reason, they are also fundamental when carrying out a purely numerical simulation, as one must have an understanding of what data is to be prescribed by the user and what is to be left to the computer to calculate.

To discuss such existence and uniqueness theorems, it is necessary to be precise about the domain of the "unknown function." Otherwise, speaking only in terms such as "a function of two variables," it is impossible to meaningfully formulate the results. That is, the domain of the unknown function must be regarded as part of the structure of the PDE itself.

The following provides two classic examples of such existence and uniqueness theorems. Even though the two PDE in question are so similar, there is a striking difference in behavior: for the first PDE, one has the free prescription of a single function, while for the second PDE, one has the free prescription of two functions.

  • Let B denote the unit-radius disk around the origin in the plane. For any continuous function U on the unit circle, there is exactly one function u on B such that
    and whose restriction to the unit circle is given by U.
  • For any functions f and g on the real line R, there is exactly one function u on R × (−1, 1) such that
    and with u(x, 0) = f(x) and u/y(x, 0) = g(x) for all values of x.

Even more phenomena are possible. For instance, the following PDE, arising naturally in the field of differential geometry, illustrates an example where there is a simple and completely explicit solution formula, but with the free choice of only three numbers and not even one function.

  • If u is a function on R2 with
    then there are numbers a, b, and c with u(x, y) = ax + by + c.

In contrast to the earlier examples, this PDE is nonlinear, owing to the square roots and the squares. A linear PDE is one such that, if it is homogeneous, the sum of any two solutions is also a solution, and all constant multiples of any solution is also a solution.

Well-posedness

Well-posedness refers to a common schematic package of information about a PDE. To say that a PDE is well-posed, one must have:

  • an existence and uniqueness theorem, asserting that by the prescription of some freely chosen functions, one can single out one specific solution of the PDE
  • by continuously changing the free choices, one continuously changes the corresponding solution

This is, by the necessity of being applicable to several different PDE, somewhat vague. The requirement of "continuity," in particular, is ambiguous, since there are usually many inequivalent means by which it can be rigorously defined. It is, however, somewhat unusual to study a PDE without specifying a way in which it is well-posed.

Existence of local solutions

In a slightly weak form, the Cauchy–Kowalevski theorem essentially states that if the terms in a partial differential equation are all made up of analytic functions, then on certain regions, there necessarily exist solutions of the PDE which are also analytic functions. Although this is a fundamental result, in many situations it is not useful since one cannot easily control the domain of the solutions produced. Furthermore, there are known examples of linear partial differential equations whose coefficients have derivatives of all orders (which are nevertheless not analytic) but which have no solutions at all: this surprising example was discovered by Hans Lewy in 1957. So the Cauchy-Kowalevski theorem is necessarily limited in its scope to analytic functions. This context precludes many phenomena of both physical and mathematical interest.

Classification

Notation

When writing PDEs, it is common to denote partial derivatives using subscripts. For example:

 In the general situation that u is a function of n variables, then ui denotes the first partial derivative relative to the i-th input, uij denotes the second partial derivative relative to the i-th and j-th inputs, and so on.

The Greek letter Δ denotes the Laplace operator; if u is a function of n variables, then

In the physics literature, the Laplace operator is often denoted by 2; in the mathematics literature, 2u may also denote the Hessian matrix of u.

Equations of first order

Linear and nonlinear equations

A PDE is called linear if it is linear in the unknown and its derivatives. For example, for a function u of x and y, a second order linear PDE is of the form

where ai and f are functions of the independent variables only. (Often the mixed-partial derivatives uxy and uyx will be equated, but this is not required for the discussion of linearity.) If the ai are constants (independent of x and y) then the PDE is called linear with constant coefficients. If f is zero everywhere then the linear PDE is homogeneous, otherwise it is inhomogeneous. (This is separate from asymptotic homogenization, which studies the effects of high-frequency oscillations in the coefficients upon solutions to PDEs.)

Nearest to linear PDEs are semilinear PDEs, where the highest order derivatives appear only as linear terms, with coefficients that are functions of the independent variables only. The lower order derivatives and the unknown function may appear arbitrarily otherwise. For example, a general second order semilinear PDE in two variables is

In a quasilinear PDE the highest order derivatives likewise appear only as linear terms, but with coefficients possibly functions of the unknown and lower-order derivatives:

 Many of the fundamental PDEs in physics are quasilinear, such as the Einstein equations of general relativity and the Navier–Stokes equations describing fluid motion.

A PDE without any linearity properties is called fully nonlinear, and possesses nonlinearities on one or more of the highest-order derivatives. An example is the Monge–Ampère equation, which arises in differential geometry.

Linear equations of second order

Elliptic, parabolic, and hyperbolic partial differential equations of order two have been widely studied since the beginning of the twentieth century. However, there are many other important types of PDE, including the Korteweg–de Vries equation. There are also hybrids such as the Euler–Tricomi equation, which vary from elliptic to hyperbolic for different regions of the domain. There are also important extensions of these basic types to higher-order PDE, but such knowledge is more specialized.

The elliptic/parabolic/hyperbolic classification provides a guide to appropriate initial and boundary conditions and to the smoothness of the solutions. Assuming uxy = uyx, the general linear second-order PDE in two independent variables has the form

 where the coefficients A, B, C... may depend upon x and y. If A2 + B2 + C2 > 0 over a region of the xy-plane, the PDE is second-order in that region. This form is analogous to the equation for a conic section:

More precisely, replacing x by X, and likewise for other variables (formally this is done by a Fourier transform), converts a constant-coefficient PDE into a polynomial of the same degree, with the terms of the highest degree (a homogeneous polynomial, here a quadratic form) being most significant for the classification.

Just as one classifies conic sections and quadratic forms into parabolic, hyperbolic, and elliptic based on the discriminant B2 − 4AC, the same can be done for a second-order PDE at a given point. However, the discriminant in a PDE is given by B2AC due to the convention of the xy term being 2B rather than B; formally, the discriminant (of the associated quadratic form) is (2B)2 − 4AC = 4(B2AC), with the factor of 4 dropped for simplicity.

  1. B2AC < 0 (elliptic partial differential equation): Solutions of elliptic PDEs are as smooth as the coefficients allow, within the interior of the region where the equation and solutions are defined. For example, solutions of Laplace's equation are analytic within the domain where they are defined, but solutions may assume boundary values that are not smooth. The motion of a fluid at subsonic speeds can be approximated with elliptic PDEs, and the Euler–Tricomi equation is elliptic where x < 0.
  2. B2AC = 0 (parabolic partial differential equation): Equations that are parabolic at every point can be transformed into a form analogous to the heat equation by a change of independent variables. Solutions smooth out as the transformed time variable increases. The Euler–Tricomi equation has parabolic type on the line where x = 0.
  3. B2AC > 0 (hyperbolic partial differential equation): hyperbolic equations retain any discontinuities of functions or derivatives in the initial data. An example is the wave equation. The motion of a fluid at supersonic speeds can be approximated with hyperbolic PDEs, and the Euler–Tricomi equation is hyperbolic where x > 0.

If there are n independent variables x1, x2 , …, xn, a general linear partial differential equation of second order has the form

The classification depends upon the signature of the eigenvalues of the coefficient matrix ai,j.

  1. Elliptic: the eigenvalues are all positive or all negative.
  2. Parabolic: the eigenvalues are all positive or all negative, save one that is zero.
  3. Hyperbolic: there is only one negative eigenvalue and all the rest are positive, or there is only one positive eigenvalue and all the rest are negative.
  4. Ultrahyperbolic: there is more than one positive eigenvalue and more than one negative eigenvalue, and there are no zero eigenvalues. There is only a limited theory for ultrahyperbolic equations (Courant and Hilbert, 1962).

Systems of first-order equations and characteristic surfaces

The classification of partial differential equations can be extended to systems of first-order equations, where the unknown u is now a vector with m components, and the coefficient matrices Aν are m by m matrices for ν = 1, 2, …, n. The partial differential equation takes the form

 where the coefficient matrices Aν and the vector B may depend upon x and u. If a hypersurface S is given in the implicit form

where φ has a non-zero gradient, then S is a characteristic surface for the operator L at a given point if the characteristic form vanishes: 

The geometric interpretation of this condition is as follows: if data for u are prescribed on the surface S, then it may be possible to determine the normal derivative of u on S from the differential equation. If the data on S and the differential equation determine the normal derivative of u on S, then S is non-characteristic. If the data on S and the differential equation do not determine the normal derivative of u on S, then the surface is characteristic, and the differential equation restricts the data on S: the differential equation is internal to S.

  1. A first-order system Lu = 0 is elliptic if no surface is characteristic for L: the values of u on S and the differential equation always determine the normal derivative of u on S.
  2. A first-order system is hyperbolic at a point if there is a spacelike surface S with normal ξ at that point. This means that, given any non-trivial vector η orthogonal to ξ, and a scalar multiplier λ, the equation Q(λξ + η) = 0 has m real roots λ1, λ2, …, λm. The system is strictly hyperbolic if these roots are always distinct. The geometrical interpretation of this condition is as follows: the characteristic form Q(ζ) = 0 defines a cone (the normal cone) with homogeneous coordinates ζ. In the hyperbolic case, this cone has m sheets, and the axis ζ = λξ runs inside these sheets: it does not intersect any of them. But when displaced from the origin by η, this axis intersects every sheet. In the elliptic case, the normal cone has no real sheets.

Analytical solutions

Separation of variables

Linear PDEs can be reduced to systems of ordinary differential equations by the important technique of separation of variables. This technique rests on a characteristic of solutions to differential equations: if one can find any solution that solves the equation and satisfies the boundary conditions, then it is the solution (this also applies to ODEs). We assume as an ansatz that the dependence of a solution on the parameters space and time can be written as a product of terms that each depend on a single parameter, and then see if this can be made to solve the problem.

In the method of separation of variables, one reduces a PDE to a PDE in fewer variables, which is an ordinary differential equation if in one variable – these are in turn easier to solve.

This is possible for simple PDEs, which are called separable partial differential equations, and the domain is generally a rectangle (a product of intervals). Separable PDEs correspond to diagonal matrices – thinking of "the value for fixed x" as a coordinate, each coordinate can be understood separately.

This generalizes to the method of characteristics, and is also used in integral transforms.

Method of characteristics

In special cases, one can find characteristic curves on which the equation reduces to an ODE – changing coordinates in the domain to straighten these curves allows separation of variables, and is called the method of characteristics.

More generally, one may find characteristic surfaces.

Integral transform

An integral transform may transform the PDE to a simpler one, in particular, a separable PDE. This corresponds to diagonalizing an operator.

An important example of this is Fourier analysis, which diagonalizes the heat equation using the eigenbasis of sinusoidal waves.

If the domain is finite or periodic, an infinite sum of solutions such as a Fourier series is appropriate, but an integral of solutions such as a Fourier integral is generally required for infinite domains. The solution for a point source for the heat equation given above is an example of the use of a Fourier integral.

Change of variables

Often a PDE can be reduced to a simpler form with a known solution by a suitable change of variables. For example, the Black–Scholes equation

 is reducible to the heat equation

 by the change of variables

Fundamental solution

Inhomogeneous equations can often be solved (for constant coefficient PDEs, always be solved) by finding the fundamental solution (the solution for a point source), then taking the convolution with the boundary conditions to get the solution.

This is analogous in signal processing to understanding a filter by its impulse response.

Superposition principle

The superposition principle applies to any linear system, including linear systems of PDEs. A common visualization of this concept is the interaction of two waves in phase being combined to result in a greater amplitude, for example sin x + sin x = 2 sin x. The same principle can be observed in PDEs where the solutions may be real or complex and additive. If u1 and u2 are solutions of linear PDE in some function space R, then u = c1u1 + c2u2 with any constants c1 and c2 are also a solution of that PDE in the same function space.

Methods for non-linear equations

There are no generally applicable methods to solve nonlinear PDEs. Still, existence and uniqueness results (such as the Cauchy–Kowalevski theorem) are often possible, as are proofs of important qualitative and quantitative properties of solutions (getting these results is a major part of analysis). Computational solution to the nonlinear PDEs, the split-step method, exist for specific equations like nonlinear Schrödinger equation.

Nevertheless, some techniques can be used for several types of equations. The h-principle is the most powerful method to solve underdetermined equations. The Riquier–Janet theory is an effective method for obtaining information about many analytic overdetermined systems.

The method of characteristics can be used in some very special cases to solve nonlinear partial differential equations.

In some cases, a PDE can be solved via perturbation analysis in which the solution is considered to be a correction to an equation with a known solution. Alternatives are numerical analysis techniques from simple finite difference schemes to the more mature multigrid and finite element methods. Many interesting problems in science and engineering are solved in this way using computers, sometimes high performance supercomputers.

Lie group method

From 1870 Sophus Lie's work put the theory of differential equations on a more satisfactory foundation. He showed that the integration theories of the older mathematicians can, by the introduction of what are now called Lie groups, be referred, to a common source; and that ordinary differential equations which admit the same infinitesimal transformations present comparable difficulties of integration. He also emphasized the subject of transformations of contact.

A general approach to solving PDEs uses the symmetry property of differential equations, the continuous infinitesimal transformations of solutions to solutions (Lie theory). Continuous group theory, Lie algebras and differential geometry are used to understand the structure of linear and nonlinear partial differential equations for generating integrable equations, to find its Lax pairs, recursion operators, Bäcklund transform and finally finding exact analytic solutions to the PDE.

Symmetry methods have been recognized to study differential equations arising in mathematics, physics, engineering, and many other disciplines.

Semianalytical methods

The Adomian decomposition method, the Lyapunov artificial small parameter method, and his homotopy perturbation method are all special cases of the more general homotopy analysis method. These are series expansion methods, and except for the Lyapunov method, are independent of small physical parameters as compared to the well known perturbation theory, thus giving these methods greater flexibility and solution generality.

Numerical solutions

The three most widely used numerical methods to solve PDEs are the finite element method (FEM), finite volume methods (FVM) and finite difference methods (FDM), as well other kind of methods called Meshfree methods, which were made to solve problems where the aforementioned methods are limited. The FEM has a prominent position among these methods and especially its exceptionally efficient higher-order version hp-FEM. Other hybrid versions of FEM and Meshfree methods include the generalized finite element method (GFEM), extended finite element method (XFEM), spectral finite element method (SFEM), meshfree finite element method, discontinuous Galerkin finite element method (DGFEM), Element-Free Galerkin Method (EFGM), Interpolating Element-Free Galerkin Method (IEFGM), etc.

Finite element method

The finite element method (FEM) (its practical application often known as finite element analysis (FEA)) is a numerical technique for finding approximate solutions of partial differential equations (PDE) as well as of integral equations. The solution approach is based either on eliminating the differential equation completely (steady state problems), or rendering the PDE into an approximating system of ordinary differential equations, which are then numerically integrated using standard techniques such as Euler's method, Runge–Kutta, etc.

Finite difference method

Finite-difference methods are numerical methods for approximating the solutions to differential equations using finite difference equations to approximate derivatives.

Finite volume method

Similar to the finite difference method or finite element method, values are calculated at discrete places on a meshed geometry. "Finite volume" refers to the small volume surrounding each node point on a mesh. In the finite volume method, surface integrals in a partial differential equation that contain a divergence term are converted to volume integrals, using the divergence theorem. These terms are then evaluated as fluxes at the surfaces of each finite volume. Because the flux entering a given volume is identical to that leaving the adjacent volume, these methods conserve mass by design.

The energy method

The energy method is a mathematical procedure that can be used to verify well-posedness of initial-boundary-value-problems. In the following example the energy method is used to decide where and which boundary conditions should be imposed such that the resulting IBVP is well-posed. Consider the one-dimensional hyperbolic PDE given by

where is a constant and is an unknown function with initial condition . Multiplying with and integrating over the domain gives

Using that

where integration by parts has been used for the second relationship, we get 

Here denotes the standard L2-norm. For well-posedness we require that the energy of the solution is non-increasing, i.e. that , which is achieved by specifying at if and at if . This corresponds to only imposing boundary conditions at the inflow. Note that well-posedness allows for growth in terms of data (initial and boundary) and thus it is sufficient to show that holds when all data is set to zero.

Simple harmonic motion

From Wikipedia, the free encyclopedia
 

In mechanics and physics, simple harmonic motion (sometimes abbreviated SHM) is a special type of periodic motion where the restoring force on the moving object is directly proportional to the magnitude of the object's displacement and acts towards the object's equilibrium position. It results in an oscillation which, if uninhibited by friction or any other dissipation of energy, continues indefinitely.

Simple harmonic motion can serve as a mathematical model for a variety of motions, but is typified by the oscillation of a mass on a spring when it is subject to the linear elastic restoring force given by Hooke's law. The motion is sinusoidal in time and demonstrates a single resonant frequency. Other phenomena can be modeled by simple harmonic motion, including the motion of a simple pendulum, although for it to be an accurate model, the net force on the object at the end of the pendulum must be proportional to the displacement (and even so, it is only a good approximation when the angle of the swing is small; see small-angle approximation). Simple harmonic motion can also be used to model molecular vibration as well.

Simple harmonic motion provides a basis for the characterization of more complicated periodic motion through the techniques of Fourier analysis.

Introduction

The motion of a particle moving along a straight line with an acceleration whose direction is always towards a fixed point on the line and whose magnitude is proportional to the distance from the fixed point is called simple harmonic motion.

Simple harmonic motion shown both in real space and phase space. The orbit is periodic. (Here the velocity and position axes have been reversed from the standard convention to align the two diagrams)

In the diagram, a simple harmonic oscillator, consisting of a weight attached to one end of a spring, is shown. The other end of the spring is connected to a rigid support such as a wall. If the system is left at rest at the equilibrium position then there is no net force acting on the mass. However, if the mass is displaced from the equilibrium position, the spring exerts a restoring elastic force that obeys Hooke's law.

Mathematically, the restoring force F is given by

where F is the restoring elastic force exerted by the spring (in SI units: N), k is the spring constant (N·m−1), and x is the displacement from the equilibrium position (m).

For any simple mechanical harmonic oscillator:

  • When the system is displaced from its equilibrium position, a restoring force that obeys Hooke's law tends to restore the system to equilibrium.

Once the mass is displaced from its equilibrium position, it experiences a net restoring force. As a result, it accelerates and starts going back to the equilibrium position. When the mass moves closer to the equilibrium position, the restoring force decreases. At the equilibrium position, the net restoring force vanishes. However, at x = 0, the mass has momentum because of the acceleration that the restoring force has imparted. Therefore, the mass continues past the equilibrium position, compressing the spring. A net restoring force then slows it down until its velocity reaches zero, whereupon it is accelerated back to the equilibrium position again.

As long as the system has no energy loss, the mass continues to oscillate. Thus simple harmonic motion is a type of periodic motion. If energy is lost in the system, then the mass exhibits damped oscillation.

Note if the real space and phase space plot are not co-linear, the phase space motion becomes elliptical. The area enclosed depends on the amplitude and the maximum momentum.

Dynamics

In Newtonian mechanics, for one-dimensional simple harmonic motion, the equation of motion, which is a second-order linear ordinary differential equation with constant coefficients, can be obtained by means of Newton's 2nd law and Hooke's law for a mass on a spring.

where m is the inertial mass of the oscillating body, x is its displacement from the equilibrium (or mean) position, and k is a constant (the spring constant for a mass on a spring).

Therefore,

Solving the differential equation above produces a solution that is a sinusoidal function:

where The meaning of the constants and can be easily found: setting on the equation above we see that , so that is the initial position of the particle, ; taking the derivative of that equation and evaluating at zero we get that , so that is the initial speed of the particle divided by the angular frequency, . Thus we can write:

This equation can also be written in the form:

where
or equivalently

In the solution, c1 and c2 are two constants determined by the initial conditions (specifically, the initial position at time t = 0 is c1, while the initial velocity is c2ω), and the origin is set to be the equilibrium position. Each of these constants carries a physical meaning of the motion: A is the amplitude (maximum displacement from the equilibrium position), ω = 2πf is the angular frequency, and φ is the initial phase.

Using the techniques of calculus, the velocity and acceleration as a function of time can be found:

Speed:
Maximum speed: v = ωA (at equilibrium point)
Maximum acceleration: 2 (at extreme points)

By definition, if a mass m is under SHM its acceleration is directly proportional to displacement.

where

Since ω = 2πf,

and, since T = 1/f where T is the time period,

These equations demonstrate that the simple harmonic motion is isochronous (the period and frequency are independent of the amplitude and the initial phase of the motion).

Energy

Substituting ω2 with k/m, the kinetic energy K of the system at time t is

and the potential energy is
In the absence of friction and other energy loss, the total mechanical energy has a constant value

Examples

An undamped spring–mass system undergoes simple harmonic motion.

The following physical systems are some examples of simple harmonic oscillator.

Mass on a spring

A mass m attached to a spring of spring constant k exhibits simple harmonic motion in closed space. The equation for describing the period

shows the period of oscillation is independent of the amplitude, though in practice the amplitude should be small. The above equation is also valid in the case when an additional constant force is being applied on the mass, i.e. the additional constant force cannot change the period of oscillation.

Uniform circular motion

Simple harmonic motion can be considered the one-dimensional projection of uniform circular motion. If an object moves with angular speed ω around a circle of radius r centered at the origin of the xy-plane, then its motion along each coordinate is simple harmonic motion with amplitude r and angular frequency ω.

Oscillatory Motion

It is the motion of a body when it moves to and fro about a definite point. This type of motion is also called Oscillatory motion or vibratory motion.

Mass of a simple pendulum

The motion of an undamped pendulum approximates to simple harmonic motion if oscillation is small.

In the small-angle approximation, the motion of a simple pendulum is approximated by simple harmonic motion. The period of a mass attached to a pendulum of length l with gravitational acceleration is given by

This shows that the period of oscillation is independent of the amplitude and mass of the pendulum but not of the acceleration due to gravity, , therefore a pendulum of the same length on the Moon would swing more slowly due to the Moon's lower gravitational field strength. Because the value of varies slightly over the surface of the earth, the time period will vary slightly from place to place and will also vary with height above sea level.

This approximation is accurate only for small angles because of the expression for angular acceleration α being proportional to the sine of the displacement angle:

where I is the moment of inertia. When θ is small, sin θθ and therefore the expression becomes
which makes angular acceleration directly proportional to θ, satisfying the definition of simple harmonic motion.

Scotch yoke

A Scotch yoke mechanism can be used to convert between rotational motion and linear reciprocating motion. The linear motion can take various forms depending on the shape of the slot, but the basic yoke with a constant rotation speed produces a linear motion that is simple harmonic in form.

Scotch yoke animation

 

Nonverbal learning disorder

From Wikipedia, the free encyclopedia https://en.wikipedia.org/wiki/Nonverbal...