Chapter 1. Vector Algebra and Vector Space

Size: px
Start display at page:

Download "Chapter 1. Vector Algebra and Vector Space"

Transcription

1 1. Vector Algebra 1.1. Scalars and vectors Chapter 1. Vector Algebra and Vector Space The simplest kind of physical quantity is one that can be completely specified by its magnitude, a single number, together with the units in which it is measured. Such a quantity is called a scalar and examples include temperature, time and density. they are described by numbers: Scalar = number (real or complex). A vector is a quantity that requires both a magnitude (> 0) and a direction in space to specify it completely; we may think of it as an arrow in space. A familiar example are force, velocity, displacement, momentum and electric field. Vectors are also used to describe quantities such as angular momentum and surface elements. Such quantities are represented geometrically by arrows. Vector = number (its size) and direction. Magnitude of vector: The length of the arrow representing a vector A is called the length or the magnitude of a (written a or a) or the norm of a ( a ). In three dimensions a = a = a x 2 + a y 2 + a z 2 where a i (i = x,y,z ) are the component of the vector. Unit Vector: A vector of length 1 is called a unit vector and is denoted by a or a Given a vector a, the unit vector in the direction of a is a = a a In the cartesian coordinate system (x, y, z), we may introduce the unit vectors i, j and k, which point along the positive x-, y- and z- axes respectively. A vector a may then be written as a sum of three vectors, each parallel to a different coordinate axis: a = a x i + a y j + a z k. The sum of two vectors a and b is found by simply adding their components, i.e. and their difference by subtracting them, Example: 1

2 and geometrically the addition and substraction can be shown as The Scalar Product: The scalar product (or dot product) of two vectors a and b is denoted by a. b and is given by a. b = a b cos (θ) where θ is the angle between the two vectors, placed 'tail to tail' or 'head to head'. It should be noted in particular that the Cartesian basis vectors i, j and k, being mutually orthogonal unit vectors, satisfy the i. i = j. j = k. k = 1 and i. j = j. k = i. k = 0. If the scalar product of two vectors is equal to zero, they are orthogonal to each other. It is represented geometrically as Example: Find the angle between the vectors a = i + 2j + 3k and b = 2i + 3j + 4k. The scalar product a and b has the value a.b = lx2+2x3+3x4=20, and the lengths of the vectors are a = a = = 14 and b = b = = 29. Thus, cos θ = a. b a b = and θ = 0.12 rad. 2

3 Example: Find the angle between i + j and i 3j The Vector Product: The vector product (or cross product) of two vectors a and b is denoted by axb and is given by axb = a b sin (θ)n where θ is the angle between the two vectors and n is defined as a unit vector in the positive normal direction to the plane of a and b. Example: Find the angle between the vectors A = 3 i - 2 j + 4 k and B = 2 i -3 j -2 k. Example: 3

4 Example: Example: Work done by force F over distance (direction) d W = F d Find work done by force F = i + 2j in moving from the origin to the point A = j. F d = (1 2) (0 1) = 2 Cross Products and Mechanics Angular motion: If a particle in a rigid body is rotating about an axis with angular velocity w (yes a vector!), then the linear velocity of a particle with position vector r, relative to the axis of motion is v = w r Angular Momentum: Suppose a planet of mass m is in orbit at position r with linear velocity v. Take the centre of rotation (e.g., the sun) as being the origin of coordinates. The angular momentum of the planet is then L = r (mv). Moment: The moment, or torque, m of a force F applied to a point with position vector r with respect to the origin is m = r F. The moment describes the turning effect of force about a fixed point, as shown in 4

5 the figure. Note that r denotes the position vector from origin of any point on the line of action of the force Differentiation of Vectors In many practical problems, we often deal with vectors that change with time, e.g. velocity, acceleration, etc. If a vector A depends on a scalar variable time t, then a can be represented as A(t) and A is then said to be a function of t. If A = a x i + a y j + a z k then a x, a y and a z will also dependent on the parameter t. A(t) = a x (t)i + a y (t)j + a z (t)k. Differentiation with respect to t gives Perhaps the simplest application of the above is to finding the velocity and acceleration of a particle in classical mechanics. If the time-dependent position vector of the particle with respect to the origin in Cartesian coordinates is given by r(t) = x(t) i + y(t) j + z(t) k then the velocity and the acceleration of the particle are given by the vector Example: The speed of the particle at t = 1 is simply v(1) = = 61 m/s. The acceleration of the particle is constant (i.e. independent of t), and its component in the direction s is given by Example: A particle moves in space so that at time t its position is stated as x = 2t+3, y = t 2 +3t, z = t 3 +2t 2. We are required to find the components of its velocity and acceleration in the direction of the vector 2i + 3j + 4 k when t=1. 5

6 First we can write the position as a vector r as r = (2t+3) i + (t 2 +3t) j + (t 3 +2t 2 ) k. Example: A particle moves in space at time t with position vector as r = t 3 i (4t 2-8t+1) j. Fint the corresponding quantities related with that particle. 6

7 1.3. Differentiation of composite vector expressions In composite vector expressions each of the vectors or scalars involved may be a function of some scalar variable u, and as we have seen. The derivatives of such expressions are easily found using the rules of ordinary differential calculus. Let consider assume that a and b are differentiable vector functions of a scalar u and that is a differentiable scalar function of u: the order of the factors in the terms on the RHS of final equation is, of course, just as important as it is in the original vector product. Example: A particle of mass m with position vector r relative to some origin 0 experiences a force F, which produces a torque T = r x F about O. The angular momentum of the particle about 0 is given by L = r x mv, where v is the particle's velocity. Show that the rate of change of angular momentum is equal to the applied torque. The rate of change of angular momentum is given by where in the last line we use Newton's second law, namely F = d(mv)/dt. Similiarly, let consider the following vector and apply tis properties. 7

8 1.4. Vector functions of several arguments The concept of the derivative of a vector is easily extended to cases where the vectors (or scalars) are functions of more than one independent scalar variable, u 1, u 2,...,u n. In this case, the partial derivatives of a in Cartesian coordinates is If If a = a (u 1, u 2,...,u n ) and each of the ui is also a function u i (v 1, v 2,...,v n ) of the variables v i then, the equation is generalized to As an example, the infinitesimal change in an electric field E in moving from a position r to a neighbouring one r + dr is given by Example: If a vector function F is given by F = 2uv i + (u 2-2v) j + (u+v 2 ) k. Find F u, F v, 2 F u 2 and 2 F u v. F F = 2vi + 2uj + k, u 1.5. Integration of vectors = 2ui 2j + 2vk, v 2 F = 2j and u2 2 F u v = 2i The integration of a vector (or of an expression involving vectors that may itself be either a vector or scalar) with respect to a scalar u can be regarded as the inverse of differentiation. We must remember, however, that (i) the integral has the same nature (vector or scalar) as the integrand, (ii) the constant of integration for indefinite integrals must be of the same nature as the integral. Example: If a vector F = (3t 2 +4t) i + (2t-5) j + 4t 3 k, then evaluate the integral of F over the range from 1 to 3. Example: If F = 3u i + u 2 j + (u+2) k and V = 2u i 3u j + (u-2) k, evaluate the integral of FxV over the range from 0 and 2 8

9 1.6. Scalar and Vector Fields If every point P(x,y,z) of a region R of space associated with it a scalar quantity φ (x, y, z), then φ (x, y, z) is a scalar function and a scalar field is said to exist in the region R. Examples of scalar fields are, temperature, potential, etc. Similiarly, if every point P(x, y, z) of region R has associated with it a vector quantity F(x,y,z), then F(x,y,z) is a vector function and a vector field is said to exist in the region R. Examples of vector fields are force, velocity, acceleration, etc Vector operators Certain differential operations may be performed on scalar and vector fields and have wide-ranging applications in the physical sciences. The most important operations are those of finding the gradient of a scalar field and the divergence and curl of a vector field. Central to all these differential operations is the vector operator, which is called del (or sometimes nabla) and in Cartesian coordinates is defined by Gradient of a scalar field The gradient of a scalar field φ(x, y, z) is defined by 9

10 Clearly, when φ is a scalar function φ is a vector field whose x-, y- and z- components are the first partial derivatives of φ (x, y, z) with respect to x, y and z respectively. Example: Find the gradient of the scalar field φ = x y 2 z 3. The gradient of φ is given by φ = y 2 z 3 i + 2xyz 3 j + 3xy 2 z 2 k. Example: Find the gradient of the A.B where A = x 2 z i + xz j + y 2 z k and B = yz 2 i + xz j + x 2 z k. Directional Derivative: Starting from dφ = dr. φ, it can be reached to dφ ds = a gradφ where a isa unit vector in the direction of dr as a = dr ds. dφ ds is thus the projection of gradφ on the unit vector a is called the directional derivative of φ in the direction of a. It gives the rate of change of φ with distance measured in the direction of a. Example: Suppose the temperature T at the point (x,y,z) is given by T = x 2 - y 2 + xyz + 273; in which direction is the temperature increasing most rapidly at (-1,2,3), and what is the rate? Here, T = (2x+yz) i + (-2y+xz) j + xy k and at (-1,2,3) T = 4 i -7 j -2 k. The rate of increase is dt = T = = 69. We can also say that the temperature is ds decreasing most rapidly in the direction - T = 69. Heat flow in the direction - T (that is from hot to cold.) Example: Find the directional derivative of the function φ = x 2 z 2xy 2 + yz 2 at the point (1, 2,-1) in the direction of the vector given as A = 2 i + 3 j - 4 k. 10

11 Unit normal vector The equation of φ(x,y,z)=constant represents a surface in space. For example, 3x - 4y + 2z = 1 is the equation of the plane and x 2 + y 2 + z 2 = 4 represents a sphere centered on the origin and of radius 2. The unit vector N in the direction of grad φ is called the unit normal vector at P. Example: Find the unit normal vector to the surface x 3 y + 4xz 2 + xy 2 z + 2 = 0 at the point (1, 3, -1). Divergence of a vector field The divergence of a vector field a (x, y, z) is defined by Clearly,. a is a scalar field. Any vector field a for which. a = 0 is said to be solenoidal. Example: Find the divergence of the vector field a = x 2 y 2 i - y 2 z 2 j - x 2 z 2 k. The divergence of a is given by 11

12 The operator 2, the Laplacian Now if some vector field a is itself derived from a scalar field via a = φ then. a has the form. φ or, as it is usually written 2 φ, where 2 (del squared) is the scalar differential operator is a scalar differential operator which is called the Laplacian, after a French mathematician of the eighteenth century named Laplace. 2 φ is called the Laplacian of φ and appears in several important partial differential equations of mathematical physics. Example: Find the Laplacian of the scalar field φ = xy 2 z 3. The Laplacian of φ is given by Curl of a vector field The curl of a vector field a(x, y, z) is defined by The RHS can be written in a more memorable form as a determinant where it is understood that, on expanding the determinant, the partial derivatives in the second row act on the components of a in the third row. Clearly, xa is itself a vector field. Any vector field a for which xa = 0 is said to be irrotational. 12

13 Example: If A = (y 4 -x 2 z 2 ) i + (x 2 +y 2 ) j - yzx 2 k, determine the curl of A at the point (1,3,-2) Line Integrals: Suppose an object moves along same path (say from A to B as in figure) with the force F acting on it varying as it moves. For example F might be the force on a charged particle in electric field; then F would be vary from point to point, that is, it would be a function of x, y, z. However, on a curve, x, y, z are related by the equation of curve. Thus along a curve, there is one independent variable; then we write F and dr = dx i+ dy j+ dz k as a functions of a single variable. The integral of dw = F.dr along the given curve gives the total work done by F in moving an abject. Such an integral is called a line integral. A line integral means an integral along a curve (or line), that is, a single integral as contrasted to a double integral over a surface or area, or a triple integral over a volume. In general, we may encounter line integrals of the forms C dr, a. dr C C a x dr where φ is a scalar field and a is a vector field. The three integrals themselves are respectively vector, scalar and vector in nature. As we will see below, in physical applications line integrals of the second type are by far the most common. Each of the line integrals is evaluated over some curve C that may be either open (A and B being distinct points) or closed (the curve C forms a loop, so that A and B are coincident). In the case where C is closed, the line integral is written C to indicate this. The curve may be given either parametrically by r(u) = x(u) i + y(u) j + z(u) k or by means of simultaneous equations relating x, y, z for the given path (in Cartesian coordinates). In practice, x, y, and z are often expressed in terms of parametric equations of a fourth 13

14 variable (say u), i.e. x = x(u); y = y(u); and z = z(u). From these, dx, dy and dz can be written in terms of u and the integral evaluated in terms of this parameter. Evaluating line integrals The method of evaluating a line integral is to reduce it to a set of scalar integrals. It is usual to work in Cartesian coordinates, in which case dr = dx i + dy j + dz k. The first type of line integral then becomes simply C dr = i C (x, y, z)dy + j (x, y, z)dy C + j (x, y, z)dy C The second and third line integrals in (11.1) can also be reduced to a set of scalar integrals by writing the vector field a in terms of its Cartesian components as a = a x i + a y j + a z k, where a x, a y, and a z are each (in general) functions of x, y, z. The second line integral can then be written as C a. dr = C a x i + a y j + a z k. dx i + dy j + dz k = a x dx + a y dy + a z dz C = a x dx C + a y dy + a z dz C C Example: Given the force F = xy i y 2 j, find the work done by F along the paths indicated in figure from (0, 0) to (2, 1). If we write the integrand in terms of one variable, we can obtain y = ½ x, dy = ½ dx. Substituting these values, we get We could just as well use y as the independent variable and put x = 2y, dy = 2 dy, and integrate from 0 to 1. Along path 2 (a parabola), y = 1/4 x 2, dy = ½ xdx, then we get 14

15 Along path 3, we integrate first from (0,0) to (0,1) and then from (0,1) to (2,1) and add the results. Along (0,0) to (0,1), x = 0 and dx = 0 so we must use y as the variable. Then we have Along (0,1) to (2,1), y = 1, dy = 0, so we use x as the variable. We have Then the total W 3 = -1/3 + 2 = 5/3. Path 4 illustrates still another technique. Instead of using either x or y as the integration variable, we can use a parameter t. For x = 2t 3, y = t 2, we have dx = 6t 2 dt, dy = 2tdt. At the origin, t = 0 and at (2, 1), t = 1. Substituting these values, we get Example: If V = xy 2 z, evaluate the integral of V dr for the curve having parametric equations x = 3u; y = 2u 2 ; z = u 3 between A(0,0,0) and B(3,2,1). x = 3u, dx = 3du; y = 2u 2, dy = 4udu; z = u 3, dz =3 u 2 du, thus the position vector becomes dr(u) = 3du i + 4udu j +3 u 2 du k and the points A(0,0,0) corresponds u = 0, and B(3,2,1) corresponds u = Conservative fields and potentials We saw that, for paths in the xy-plane, line integrals whose integrands have certain properties are independent of the path taken. For line integrals of the form a dr, there exists a class of vector fields for which the line integral between two points is independent of the path taken. Such vector fields are called conservative. A vector field a that has continuous partial derivatives in a simply connected region R is conservative if, and only if, any of the following is true. (i) The integral a. dr from A to B lie in the region R, is independent of the path from A to B. Hence the integral of a. dr around any closed loop in R is zero. (ii) There exists a single-valued function φ of position such that a = φ. (iii) a = 0 or curla = 0 (iv) a dr is an exact differential. Let us assume that (i) above is true. If the line integral from A to B is independent of the path taken between the points then its value must be a function only of the positions of A and B. We may therefore write 15

16 a. dr = A (B) which defines a single-valued scalar function of position φ. One example of conservative filed is the work done by an applying force F. The integration of F.dr must be independent of the path, that is, curlf = 0 for conservative fields and curlf is different from zero for nonconservative fields. Suppose that for a given function F there is a function W(x,y,z) such that Then F = W x, y, z = i W x F x = W x, F y = W y, + j W x F z = W z, + k W x Example: Show that F = (2xy - z 3 ) i + x 2 j (3xz 2 +1) k is conservative, and find a scalar potential such that F = So, F is conservative. Then or 16

17 Physical examples of line integrals There are many physical examples of line integrals, but perhaps the most common is the expression for the total work done by a force F when it moves its point of application from a point A to a point B along a given curve C. Naturally, other physical quantities can be expressed in such a way. For example, the electrostatic potential energy gained by moving a charge q along a path C in an electric field E is q E dr. We may also note that Ampere s law concerning the magnetic field B associated with a currentcarrying wire can be written as B dr = μ 0 I where I is the current enclosed by a closed path C traversed in a right-handed sense with respect to the current direction. Magnetostatics also provides a physical example of the third type of line integral. If a loop of wire C carrying a current I is placed in a magnetic field B then the force df on a small length dr of the wire is given by df = I dr B, and so the total (vector) force on the loop is F = I dr B Surface integrals As with line integrals, integrals over surfaces can involve vector and scalar fields and, equally, can result in either a vector or a scalar. The form of surface integrals have forms S ds, a. ds S S a x ds (a) A closed surface and (b) an open surface. In each case a normal to the surface is shown: ds = n ds. All the above integrals are taken over some surface S, which may be either open or closed, and are therefore, in general, double integrals. Following the notation for line integrals, for surface integrals over a closed surface S is replaced by S. 17

18 Example: A scalar field V = xyz exists over the curved surface S defined by x 2 + y 2 = 4 between the planes z = 0 and z = 3 in the first octant. Evaluate S V ds over this surface. We have to evaluate this integral over the prescribed surface. Changing to cylindrical coordinates with ρ = 2. 18

19 Example: A vector field F = y i + 2j + k exist over a surface S defined by x 2 + y 2 + z 2 = 9 bounded by x = 0, y = 0, z = 0, in the first octant. Evaluate S F.dS over the surface indicated. Before integrating over the surface, we convert to spherical coordinates as Limits of θ = 0 to π/2; and φ = 0 to π/2; Physical examples of surface integrals 19

20 There are many examples of surface integrals in the physical sciences. Surface integrals of the form occur in computing the total electric charge on a surface or the mass of a shell, ρ(r) ds, given the charge or mass density ρ(r). For a vector field a, the surface integral a ds is called the flux of a through S. Examples of physically important flux integrals are numerous. For example, let us consider a surface S in a fluid with density ρ(r) that has a velocity field v(r). The mass of fluid crossing an element of surface area ds in time dt is dm = ρv ds dt. Therefore the net total mass flux of fluid crossing S M = ρ(r)v(r) ds. As another example, the electromagnetic flux of energy out of a given volume V bounded by a surface S is (E H) ds. The solid angle, to be defined below, subtended at a point O by a surface (closed or otherwise) can also be represented by an integral of this form, although it is not strictly a flux integral (unless we imagine isotropic rays radiating from O). The integral = r. ds r 3 = r. ds r 2 gives the solid angle Ω subtended at O by a surface S if r is the position vector measured from O of an element of the surface Volume integrals: Volume integrals are defined in an obvious way and are generally simpler than line or surface integrals since the element of volume dv is a scalar quantity. We may encounter volume integrals of the forms V dv, a dv V Clearly, the first form results in a scalar, whereas the second form yields a vector. Two closely related physical examples, one of each kind, are provided by the total mass of a fluid contained in a volume V, ρ(r) dv, and the total linear momentum of that same fluid, given by ρ(r) v(r)dv where v(r) is the velocity field in the fluid. 20

21 Example: Evaluate V F dv where V is the region bounded by the planes x = 0, x = 2, y = 0,, y = 3, z = 0, z = 4 and the vector field F = xy i + zj x 2 k Appendix Curvilinear Coordinates In order to study solutions of the wave equation, the heat equation, or even Schrödinger s equation in different geometries, we need to see how differential operators, such as the Laplacian, appear in these geometries. The most common coordinate systems arising in physics are polar coordinates, cylindrical coordinates, and spherical coordinates. These reflect the common geometrical symmetries encountered in our studies. In this section we will consider general coordinate systems and how the differential operators are written in the new coordinate system. Cylindrical Polar Coordinates (,, z): Let P be a point with cylindrical coordinates (,, z) as shown. The position of the P is a function of the three variables (,, z). 21

22 Spherical Polar Coordinates (r,, ): The position of the P is a function of the three variables (r,, ). Where Scale Factors Collecting the recent results together, we have: a) For cylindrical polar coordinates, the unit base vectors are b) For spherical polar coordinates, the unit base vectors are where in each case h is called scale factor. 22

23 23

24 General Curvilinear Coordinate system ( u, v, w) 24

25 Transformation Equations Elements of arc ds and element of volume dv in orthogonal curvilinear coordinates 25

26 Example: Grad, div and Curl in orthogonal curvilinear coordinates Exercises: A particle moves along the curve x = 2 t 2, y = t 2-4t, and z = 3t - 5, where t is the time. Find the components of the particle s velocity and acceleration at time t = 1 in the direction i 3 j + 3 k. 4. Find the unit vector normal to the surface x 2 + y 2 z = 1 at the point P(1,1,1). 26

27 5. Find the directional derivative of = x 2 yz + 4xz 3 at (1,-2,-1) in the direction 2 i j - 2 k. 6. Consider an electric dipole moment p at the origin. It produces an electric field of = p.r 4πε r 3 outside the dipole. Nothing that E = -, find the electric field at r. 7. Find constants a, b, c such that A = ( x + 2y + a z) i +( b x - 3y - z) j +(4 x + 2cy + 2 z) k is irrotational The Vector Space R n The Vector Space R n The world of everyday experience has three space dimensions. But often we encounter setting s in which more dimensions occur. If we want to specify not only the location of a particle but the time in which it occupies a particular point, we need four coordinates (x, y, z, t). And specifying the location of each particle in a system of particles may require any number of coordinates. The natural setting for such problems is R n, the space of points having n coordinates. Theorem: If n is a positive integer, an n-vector is an n-tuple (x 1, x 2,.., x n ), with each coordinate x j a real number. The set of all n-vectors is denoted R n. R 1 is the real line, consisting of all real numbers. We can think of real numbers as 1-vectors, but there is is no advantage to doing this. R 2 consists of ordered pairs (x, y) of real numbers, and each such ordered pair (or 2-vector) can be identified with a point in the plane. R 3 consists of all 3-vectors, or points in 3-space. If n > 4, we can no longer draw a set of mutuall y independent coordinate axes, one for each coordinate, but we can still work with vectors in R n according to rules we will now describe. Algebra of R n 1. Two n-vectors are added by adding their respective components: (x 1, x 2,.., x n )+ (y 1, y 2,.., y n ) = (x 1 + y 1, x 2 + y 2,.., x n + y n ) 2. An n-vector is multiplied by a scalar by multiplying each component by the scalar: (x 1, x 2,.., x n )= ( x 1, x 2,.., x n ) The zero vector in R n is the n-vector 0 = (0, 0,..., 0) having each coordinate equal to zero. The algebraic rules in R n mirror those we saw for R 3. Properties Let F, G, and H be in R n, and let and be real numbers. Then F+G = G+F. F+(G+H) = (F+G) + H. F+O=F. ( + ) F = F+ F. ( ) F = ( F). (F+G) = F+ G. O=O. 27

28 Because of these properties of the operations of addition of n-vectors, and multiplicatio n of an n-vector by a scalar, we call R n a vector space. In the next section we will clarify the sense in which R n can be said to have dimension n. The length (norm, magnitude) of X = (x 1, x 2,.., x n ) is defined by a direct generalization from the plane and 3-space: There is no analogue of the cross product for vectors in R n when n > 3. However, the dot product readily extends to n-vectors. Dot Product of n-vectors The dot product of (x 1, x 2,.., x n ) and (y 1, y 2,.., y n ) is defined as (x 1, x 2,.., x n ).(y 1, y 2,.., y n ) = x 1 y 1 + x 2 y x n y n Subspace: A set of n-vectors containing the zero vector, as well as sums of vectors in the set an d scalar multiples of vectors in the set, is called a subspace of R n. A set S of n-vectors is a subspace of R n if: 0 is in S. The sum of any vectors in S is in S. The product of any vector in S with any real number is also in S. Example: Let K consist of all scalar multiples of (-1, 4, 2, 0) in R 4. We want to know if K is a subspace of R 4. First, 0 is in K, because 0 = 0(-1, 4, 2, 0) = (0, 0, 0, 0). Next, if F and G are in K, then F = (-1, 4, 2, 0) for some and G = (-1, 4, 2, 0) for some, so F + G = ( + ) (-l, 4, 2, 0) is a scalar multiple of (-1, 4, 2, 0) and therefore is in K. Finally, if F = (-1, 4, 2, 0) is any vector in K, and is any scalar, then F = ( ) (-1, 4, 2, 0) is a scalar multiple of (-1, 4, 2, 0), and hence is in K. Thus K is a subspace of R 4. 28

29 Cauchy Inequality: X Y X Y if X, Y R n Orthogonal Vectors Orthogonal and Orthonormal Sets Example: 29

30 Linear Independence In dependence Let S = {X 1,X 2,...,X k } be a set of k vectors in R n, let a 1, a 2,..., a k be scalars, and suppose a 1 X 1 + a 2 X a k X k = O. If the only solution for the scalars are a 1 = 0, a 2 = 0,..., a k = 0, then the set S is called a linearly independent set, and we say that the vectors X 1, X 2,..., X k are linearly independent. Purely symbolically: means the vectors X 1, X 2,..., X k are linearly independent. Example: 30

31 Example: Linear Dependence If S = {X 1,X 2,...,X k } is not linearly independent, it is called linearly dependent, and we say that the vectors X 1,X 2,...,X k are linearly dependent. That is, there are scalars a 1, a 2,..., a k, not all zero, such that a 1 X 1 + a 2 X a k X k = O. Equivalently: if a set of vectors is linearly dependent, then one of the vectors is a linear combination of the others. For example, if the relation between vectors is 2X 1 X 2 + X 3 = 0 X 2 = 2X 1 + X 3. On the other hand, if a set of vectors is linearly independent, then none of the vectors is a linear combination of the others. 31

32 Example: Example: n Vectors in R n 32

33 Example: Basis: 33

34 Example: Example: References: 1. Mathematical methods for physics and engineering, K.F. Riley, M.P. Hobson and S. J. Bence, 3th edition Advanced Engineering Mathematics, K.A. Stroud, 4th edition. 4. Mathematical Methods in the Physical Sciences, Mary L. Boas, 2 nd edition. 34

Multiple Integrals and Vector Calculus (Oxford Physics) Synopsis and Problem Sets; Hilary 2015

Multiple Integrals and Vector Calculus (Oxford Physics) Synopsis and Problem Sets; Hilary 2015 Multiple Integrals and Vector Calculus (Oxford Physics) Ramin Golestanian Synopsis and Problem Sets; Hilary 215 The outline of the material, which will be covered in 14 lectures, is as follows: 1. Introduction

More information

Line, surface and volume integrals

Line, surface and volume integrals www.thestudycampus.com Line, surface and volume integrals In the previous chapter we encountered continuously varying scalar and vector fields and discussed the action of various differential operators

More information

MATH 332: Vector Analysis Summer 2005 Homework

MATH 332: Vector Analysis Summer 2005 Homework MATH 332, (Vector Analysis), Summer 2005: Homework 1 Instructor: Ivan Avramidi MATH 332: Vector Analysis Summer 2005 Homework Set 1. (Scalar Product, Equation of a Plane, Vector Product) Sections: 1.9,

More information

CURRENT MATERIAL: Vector Calculus.

CURRENT MATERIAL: Vector Calculus. Math 275, section 002 (Ultman) Fall 2011 FINAL EXAM REVIEW The final exam will be held on Wednesday 14 December from 10:30am 12:30pm in our regular classroom. You will be allowed both sides of an 8.5 11

More information

Multiple Integrals and Vector Calculus: Synopsis

Multiple Integrals and Vector Calculus: Synopsis Multiple Integrals and Vector Calculus: Synopsis Hilary Term 28: 14 lectures. Steve Rawlings. 1. Vectors - recap of basic principles. Things which are (and are not) vectors. Differentiation and integration

More information

EE2007: Engineering Mathematics II Vector Calculus

EE2007: Engineering Mathematics II Vector Calculus EE2007: Engineering Mathematics II Vector Calculus Ling KV School of EEE, NTU ekvling@ntu.edu.sg Rm: S2-B2b-22 Ver 1.1: Ling KV, October 22, 2006 Ver 1.0: Ling KV, Jul 2005 EE2007/Ling KV/Aug 2006 EE2007:

More information

Vector Calculus, Maths II

Vector Calculus, Maths II Section A Vector Calculus, Maths II REVISION (VECTORS) 1. Position vector of a point P(x, y, z) is given as + y and its magnitude by 2. The scalar components of a vector are its direction ratios, and represent

More information

(1) Recap of Differential Calculus and Integral Calculus (2) Preview of Calculus in three dimensional space (3) Tools for Calculus 3

(1) Recap of Differential Calculus and Integral Calculus (2) Preview of Calculus in three dimensional space (3) Tools for Calculus 3 Math 127 Introduction and Review (1) Recap of Differential Calculus and Integral Calculus (2) Preview of Calculus in three dimensional space (3) Tools for Calculus 3 MATH 127 Introduction to Calculus III

More information

Chapter 2. Vector Calculus. 2.1 Directional Derivatives and Gradients. [Bourne, pp ] & [Anton, pp ]

Chapter 2. Vector Calculus. 2.1 Directional Derivatives and Gradients. [Bourne, pp ] & [Anton, pp ] Chapter 2 Vector Calculus 2.1 Directional Derivatives and Gradients [Bourne, pp. 97 104] & [Anton, pp. 974 991] Definition 2.1. Let f : Ω R be a continuously differentiable scalar field on a region Ω R

More information

Contents. MATH 32B-2 (18W) (L) G. Liu / (TA) A. Zhou Calculus of Several Variables. 1 Multiple Integrals 3. 2 Vector Fields 9

Contents. MATH 32B-2 (18W) (L) G. Liu / (TA) A. Zhou Calculus of Several Variables. 1 Multiple Integrals 3. 2 Vector Fields 9 MATH 32B-2 (8W) (L) G. Liu / (TA) A. Zhou Calculus of Several Variables Contents Multiple Integrals 3 2 Vector Fields 9 3 Line and Surface Integrals 5 4 The Classical Integral Theorems 9 MATH 32B-2 (8W)

More information

Introduction to Vector Calculus (29) SOLVED EXAMPLES. (d) B. C A. (f) a unit vector perpendicular to both B. = ˆ 2k = = 8 = = 8

Introduction to Vector Calculus (29) SOLVED EXAMPLES. (d) B. C A. (f) a unit vector perpendicular to both B. = ˆ 2k = = 8 = = 8 Introduction to Vector Calculus (9) SOLVED EXAMPLES Q. If vector A i ˆ ˆj k, ˆ B i ˆ ˆj, C i ˆ 3j ˆ kˆ (a) A B (e) A B C (g) Solution: (b) A B (c) A. B C (d) B. C A then find (f) a unit vector perpendicular

More information

Practice Problems for Exam 3 (Solutions) 1. Let F(x, y) = xyi+(y 3x)j, and let C be the curve r(t) = ti+(3t t 2 )j for 0 t 2. Compute F dr.

Practice Problems for Exam 3 (Solutions) 1. Let F(x, y) = xyi+(y 3x)j, and let C be the curve r(t) = ti+(3t t 2 )j for 0 t 2. Compute F dr. 1. Let F(x, y) xyi+(y 3x)j, and let be the curve r(t) ti+(3t t 2 )j for t 2. ompute F dr. Solution. F dr b a 2 2 F(r(t)) r (t) dt t(3t t 2 ), 3t t 2 3t 1, 3 2t dt t 3 dt 1 2 4 t4 4. 2. Evaluate the line

More information

Review of Vector Analysis in Cartesian Coordinates

Review of Vector Analysis in Cartesian Coordinates Review of Vector Analysis in Cartesian Coordinates 1 Scalar: A quantity that has magnitude, but no direction. Examples are mass, temperature, pressure, time, distance, and real numbers. Scalars are usually

More information

CURRENT MATERIAL: Vector Calculus.

CURRENT MATERIAL: Vector Calculus. Math 275, section 002 (Ultman) Spring 2012 FINAL EXAM REVIEW The final exam will be held on Wednesday 9 May from 8:00 10:00am in our regular classroom. You will be allowed both sides of two 8.5 11 sheets

More information

AN INTRODUCTION TO CURVILINEAR ORTHOGONAL COORDINATES

AN INTRODUCTION TO CURVILINEAR ORTHOGONAL COORDINATES AN INTRODUCTION TO CURVILINEAR ORTHOGONAL COORDINATES Overview Throughout the first few weeks of the semester, we have studied vector calculus using almost exclusively the familiar Cartesian x,y,z coordinate

More information

ENGI Gradient, Divergence, Curl Page 5.01

ENGI Gradient, Divergence, Curl Page 5.01 ENGI 94 5. - Gradient, Divergence, Curl Page 5. 5. The Gradient Operator A brief review is provided here for the gradient operator in both Cartesian and orthogonal non-cartesian coordinate systems. Sections

More information

Vector Analysis. Electromagnetic Theory PHYS 401. Fall 2017

Vector Analysis. Electromagnetic Theory PHYS 401. Fall 2017 Vector Analysis Electromagnetic Theory PHYS 401 Fall 2017 1 Vector Analysis Vector analysis is a mathematical formalism with which EM concepts are most conveniently expressed and best comprehended. Many

More information

Chapter 6: Vector Analysis

Chapter 6: Vector Analysis Chapter 6: Vector Analysis We use derivatives and various products of vectors in all areas of physics. For example, Newton s 2nd law is F = m d2 r. In electricity dt 2 and magnetism, we need surface and

More information

f. D that is, F dr = c c = [2"' (-a sin t)( -a sin t) + (a cos t)(a cost) dt = f2"' dt = 2

f. D that is, F dr = c c = [2' (-a sin t)( -a sin t) + (a cos t)(a cost) dt = f2' dt = 2 SECTION 16.4 GREEN'S THEOREM 1089 X with center the origin and radius a, where a is chosen to be small enough that C' lies inside C. (See Figure 11.) Let be the region bounded by C and C'. Then its positively

More information

EE2007: Engineering Mathematics II Vector Calculus

EE2007: Engineering Mathematics II Vector Calculus EE2007: Engineering Mathematics II Vector Calculus Ling KV School of EEE, NTU ekvling@ntu.edu.sg Rm: S2-B2a-22 Ver: August 28, 2010 Ver 1.6: Martin Adams, Sep 2009 Ver 1.5: Martin Adams, August 2008 Ver

More information

MA 441 Advanced Engineering Mathematics I Assignments - Spring 2014

MA 441 Advanced Engineering Mathematics I Assignments - Spring 2014 MA 441 Advanced Engineering Mathematics I Assignments - Spring 2014 Dr. E. Jacobs The main texts for this course are Calculus by James Stewart and Fundamentals of Differential Equations by Nagle, Saff

More information

Differential Operators and the Divergence Theorem

Differential Operators and the Divergence Theorem 1 of 6 1/15/2007 6:31 PM Differential Operators and the Divergence Theorem One of the most important and useful mathematical constructs is the "del operator", usually denoted by the symbol Ñ (which is

More information

Differential Vector Calculus

Differential Vector Calculus Contents 8 Differential Vector Calculus 8. Background to Vector Calculus 8. Differential Vector Calculus 7 8.3 Orthogonal Curvilinear Coordinates 37 Learning outcomes In this Workbook you will learn about

More information

Created by T. Madas VECTOR OPERATORS. Created by T. Madas

Created by T. Madas VECTOR OPERATORS. Created by T. Madas VECTOR OPERATORS GRADIENT gradϕ ϕ Question 1 A surface S is given by the Cartesian equation x 2 2 + y = 25. a) Draw a sketch of S, and describe it geometrically. b) Determine an equation of the tangent

More information

Vectors and Fields. Vectors versus scalars

Vectors and Fields. Vectors versus scalars C H A P T E R 1 Vectors and Fields Electromagnetics deals with the study of electric and magnetic fields. It is at once apparent that we need to familiarize ourselves with the concept of a field, and in

More information

52. The Del Operator: Divergence and Curl

52. The Del Operator: Divergence and Curl 52. The Del Operator: Divergence and Curl Let F(x, y, z) = M(x, y, z), N(x, y, z), P(x, y, z) be a vector field in R 3. The del operator is represented by the symbol, and is written = x, y, z, or = x,

More information

UNIT 1. INTRODUCTION

UNIT 1. INTRODUCTION UNIT 1. INTRODUCTION Objective: The aim of this chapter is to gain knowledge on Basics of electromagnetic fields Scalar and vector quantities, vector calculus Various co-ordinate systems namely Cartesian,

More information

Exercises for Multivariable Differential Calculus XM521

Exercises for Multivariable Differential Calculus XM521 This document lists all the exercises for XM521. The Type I (True/False) exercises will be given, and should be answered, online immediately following each lecture. The Type III exercises are to be done

More information

Calculus III. Math 233 Spring Final exam May 3rd. Suggested solutions

Calculus III. Math 233 Spring Final exam May 3rd. Suggested solutions alculus III Math 33 pring 7 Final exam May 3rd. uggested solutions This exam contains twenty problems numbered 1 through. All problems are multiple choice problems, and each counts 5% of your total score.

More information

Line and Surface Integrals. Stokes and Divergence Theorems

Line and Surface Integrals. Stokes and Divergence Theorems Math Methods 1 Lia Vas Line and urface Integrals. tokes and Divergence Theorems Review of urves. Intuitively, we think of a curve as a path traced by a moving particle in space. Thus, a curve is a function

More information

Course Outline. 2. Vectors in V 3.

Course Outline. 2. Vectors in V 3. 1. Vectors in V 2. Course Outline a. Vectors and scalars. The magnitude and direction of a vector. The zero vector. b. Graphical vector algebra. c. Vectors in component form. Vector algebra with components.

More information

1 + f 2 x + f 2 y dy dx, where f(x, y) = 2 + 3x + 4y, is

1 + f 2 x + f 2 y dy dx, where f(x, y) = 2 + 3x + 4y, is 1. The value of the double integral (a) 15 26 (b) 15 8 (c) 75 (d) 105 26 5 4 0 1 1 + f 2 x + f 2 y dy dx, where f(x, y) = 2 + 3x + 4y, is 2. What is the value of the double integral interchange the order

More information

Before seeing some applications of vector calculus to Physics, we note that vector calculus is easy, because... There s only one Theorem!

Before seeing some applications of vector calculus to Physics, we note that vector calculus is easy, because... There s only one Theorem! 16.10 Summary and Applications Before seeing some applications of vector calculus to Physics, we note that vector calculus is easy, because... There s only one Theorem! Green s, Stokes, and the Divergence

More information

Archive of Calculus IV Questions Noel Brady Department of Mathematics University of Oklahoma

Archive of Calculus IV Questions Noel Brady Department of Mathematics University of Oklahoma Archive of Calculus IV Questions Noel Brady Department of Mathematics University of Oklahoma This is an archive of past Calculus IV exam questions. You should first attempt the questions without looking

More information

ENGI Duffing s Equation Page 4.65

ENGI Duffing s Equation Page 4.65 ENGI 940 4. - Duffing s Equation Page 4.65 4. Duffing s Equation Among the simplest models of damped non-linear forced oscillations of a mechanical or electrical system with a cubic stiffness term is Duffing

More information

Math 233. Practice Problems Chapter 15. i j k

Math 233. Practice Problems Chapter 15. i j k Math 233. Practice Problems hapter 15 1. ompute the curl and divergence of the vector field F given by F (4 cos(x 2 ) 2y)i + (4 sin(y 2 ) + 6x)j + (6x 2 y 6x + 4e 3z )k olution: The curl of F is computed

More information

MAT 211 Final Exam. Spring Jennings. Show your work!

MAT 211 Final Exam. Spring Jennings. Show your work! MAT 211 Final Exam. pring 215. Jennings. how your work! Hessian D = f xx f yy (f xy ) 2 (for optimization). Polar coordinates x = r cos(θ), y = r sin(θ), da = r dr dθ. ylindrical coordinates x = r cos(θ),

More information

(a) The points (3, 1, 2) and ( 1, 3, 4) are the endpoints of a diameter of a sphere.

(a) The points (3, 1, 2) and ( 1, 3, 4) are the endpoints of a diameter of a sphere. MATH 4 FINAL EXAM REVIEW QUESTIONS Problem. a) The points,, ) and,, 4) are the endpoints of a diameter of a sphere. i) Determine the center and radius of the sphere. ii) Find an equation for the sphere.

More information

One side of each sheet is blank and may be used as scratch paper.

One side of each sheet is blank and may be used as scratch paper. Math 244 Spring 2017 (Practice) Final 5/11/2017 Time Limit: 2 hours Name: No calculators or notes are allowed. One side of each sheet is blank and may be used as scratch paper. heck your answers whenever

More information

1. If the line l has symmetric equations. = y 3 = z+2 find a vector equation for the line l that contains the point (2, 1, 3) and is parallel to l.

1. If the line l has symmetric equations. = y 3 = z+2 find a vector equation for the line l that contains the point (2, 1, 3) and is parallel to l. . If the line l has symmetric equations MA 6 PRACTICE PROBLEMS x = y = z+ 7, find a vector equation for the line l that contains the point (,, ) and is parallel to l. r = ( + t) i t j + ( + 7t) k B. r

More information

ENGI Gradient, Divergence, Curl Page 5.01

ENGI Gradient, Divergence, Curl Page 5.01 ENGI 940 5.0 - Gradient, Divergence, Curl Page 5.0 5. e Gradient Operator A brief review is provided ere for te gradient operator in bot Cartesian and ortogonal non-cartesian coordinate systems. Sections

More information

EKC314: TRANSPORT PHENOMENA Core Course for B.Eng.(Chemical Engineering) Semester II (2008/2009)

EKC314: TRANSPORT PHENOMENA Core Course for B.Eng.(Chemical Engineering) Semester II (2008/2009) EKC314: TRANSPORT PHENOMENA Core Course for B.Eng.(Chemical Engineering) Semester II (2008/2009) Dr. Mohamad Hekarl Uzir-chhekarl@eng.usm.my School of Chemical Engineering Engineering Campus, Universiti

More information

Vector Calculus - GATE Study Material in PDF

Vector Calculus - GATE Study Material in PDF Vector Calculus - GATE Study Material in PDF In previous articles, we have already seen the basics of Calculus Differentiation and Integration and applications. In GATE 2018 Study Notes, we will be introduced

More information

Unit-1 Electrostatics-1

Unit-1 Electrostatics-1 1. Describe about Co-ordinate Systems. Co-ordinate Systems Unit-1 Electrostatics-1 In order to describe the spatial variations of the quantities, we require using appropriate coordinate system. A point

More information

Gradient, Divergence and Curl in Curvilinear Coordinates

Gradient, Divergence and Curl in Curvilinear Coordinates Gradient, Divergence and Curl in Curvilinear Coordinates Although cartesian orthogonal coordinates are very intuitive and easy to use, it is often found more convenient to work with other coordinate systems.

More information

PRACTICE PROBLEMS. Please let me know if you find any mistakes in the text so that i can fix them. 1. Mixed partial derivatives.

PRACTICE PROBLEMS. Please let me know if you find any mistakes in the text so that i can fix them. 1. Mixed partial derivatives. PRACTICE PROBLEMS Please let me know if you find any mistakes in the text so that i can fix them. 1.1. Let Show that f is C 1 and yet How is that possible? 1. Mixed partial derivatives f(x, y) = {xy x

More information

EE2007: Engineering Mathematics II Vector Calculus

EE2007: Engineering Mathematics II Vector Calculus EE2007: Engineering Mathematics II Vector Calculus Ling KV School of EEE, NTU ekvling@ntu.edu.sg Rm: S2-B2b-22 Ver 1.1: Ling KV, October 22, 2006 Ver 1.0: Ling KV, Jul 2005 EE2007/Ling KV/Aug 2006 My part:

More information

Mathematical Tripos Part IA Lent Term Example Sheet 1. Calculate its tangent vector dr/du at each point and hence find its total length.

Mathematical Tripos Part IA Lent Term Example Sheet 1. Calculate its tangent vector dr/du at each point and hence find its total length. Mathematical Tripos Part IA Lent Term 205 ector Calculus Prof B C Allanach Example Sheet Sketch the curve in the plane given parametrically by r(u) = ( x(u), y(u) ) = ( a cos 3 u, a sin 3 u ) with 0 u

More information

Name: SOLUTIONS Date: 11/9/2017. M20550 Calculus III Tutorial Worksheet 8

Name: SOLUTIONS Date: 11/9/2017. M20550 Calculus III Tutorial Worksheet 8 Name: SOLUTIONS Date: /9/7 M55 alculus III Tutorial Worksheet 8. ompute R da where R is the region bounded by x + xy + y 8 using the change of variables given by x u + v and y v. Solution: We know R is

More information

SOLUTIONS TO THE FINAL EXAM. December 14, 2010, 9:00am-12:00 (3 hours)

SOLUTIONS TO THE FINAL EXAM. December 14, 2010, 9:00am-12:00 (3 hours) SOLUTIONS TO THE 18.02 FINAL EXAM BJORN POONEN December 14, 2010, 9:00am-12:00 (3 hours) 1) For each of (a)-(e) below: If the statement is true, write TRUE. If the statement is false, write FALSE. (Please

More information

6. Vector Integral Calculus in Space

6. Vector Integral Calculus in Space 6. Vector Integral alculus in pace 6A. Vector Fields in pace 6A-1 Describegeometricallythefollowingvectorfields: a) xi +yj +zk ρ b) xi zk 6A-2 Write down the vector field where each vector runs from (x,y,z)

More information

Three-Dimensional Coordinate Systems. Three-Dimensional Coordinate Systems. Three-Dimensional Coordinate Systems. Three-Dimensional Coordinate Systems

Three-Dimensional Coordinate Systems. Three-Dimensional Coordinate Systems. Three-Dimensional Coordinate Systems. Three-Dimensional Coordinate Systems To locate a point in a plane, two numbers are necessary. We know that any point in the plane can be represented as an ordered pair (a, b) of real numbers, where a is the x-coordinate and b is the y-coordinate.

More information

Jim Lambers MAT 280 Summer Semester Practice Final Exam Solution. dy + xz dz = x(t)y(t) dt. t 3 (4t 3 ) + e t2 (2t) + t 7 (3t 2 ) dt

Jim Lambers MAT 280 Summer Semester Practice Final Exam Solution. dy + xz dz = x(t)y(t) dt. t 3 (4t 3 ) + e t2 (2t) + t 7 (3t 2 ) dt Jim Lambers MAT 28 ummer emester 212-1 Practice Final Exam olution 1. Evaluate the line integral xy dx + e y dy + xz dz, where is given by r(t) t 4, t 2, t, t 1. olution From r (t) 4t, 2t, t 2, we obtain

More information

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t)

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t) IV. DIFFERENTIAL RELATIONS FOR A FLUID PARTICLE This chapter presents the development and application of the basic differential equations of fluid motion. Simplifications in the general equations and common

More information

vector calculus 1 Learning outcomes

vector calculus 1 Learning outcomes 8 Contents vector calculus. Background to Vector Calculus. Differential Vector Calculus 3. Orthogonal curvilinear coordinates Learning outcomes In this Workbook, you will learn about scalar and vector

More information

SOME PROBLEMS YOU SHOULD BE ABLE TO DO

SOME PROBLEMS YOU SHOULD BE ABLE TO DO OME PROBLEM YOU HOULD BE ABLE TO DO I ve attempted to make a list of the main calculations you should be ready for on the exam, and included a handful of the more important formulas. There are no examples

More information

Integral Vector Calculus

Integral Vector Calculus ontents 29 Integral Vector alculus 29.1 Line Integrals Involving Vectors 2 29.2 Surface and Volume Integrals 34 29.3 Integral Vector Theorems 54 Learning outcomes In this Workbook you will learn how to

More information

example consider flow of water in a pipe. At each point in the pipe, the water molecule has a velocity

example consider flow of water in a pipe. At each point in the pipe, the water molecule has a velocity Module 1: A Crash Course in Vectors Lecture 1: Scalar and Vector Fields Objectives In this lecture you will learn the following Learn about the concept of field Know the difference between a scalar field

More information

The Divergence Theorem

The Divergence Theorem The Divergence Theorem 5-3-8 The Divergence Theorem relates flux of a vector field through the boundary of a region to a triple integral over the region. In particular, let F be a vector field, and let

More information

MATH 52 FINAL EXAM SOLUTIONS

MATH 52 FINAL EXAM SOLUTIONS MAH 5 FINAL EXAM OLUION. (a) ketch the region R of integration in the following double integral. x xe y5 dy dx R = {(x, y) x, x y }. (b) Express the region R as an x-simple region. R = {(x, y) y, x y }

More information

x + ye z2 + ze y2, y + xe z2 + ze x2, z and where T is the

x + ye z2 + ze y2, y + xe z2 + ze x2, z and where T is the 1.(8pts) Find F ds where F = x + ye z + ze y, y + xe z + ze x, z and where T is the T surface in the pictures. (The two pictures are two views of the same surface.) The boundary of T is the unit circle

More information

Review Sheet for the Final

Review Sheet for the Final Review Sheet for the Final Math 6-4 4 These problems are provided to help you study. The presence of a problem on this handout does not imply that there will be a similar problem on the test. And the absence

More information

송석호 ( 물리학과 )

송석호 ( 물리학과 ) http://optics.hanyang.ac.kr/~shsong 송석호 ( 물리학과 ) Introduction to Electrodynamics, David J. Griffiths Review: 1. Vector analysis 2. Electrostatics 3. Special techniques 4. Electric fields in mater 5. Magnetostatics

More information

Lecture 11: Vector Calculus I

Lecture 11: Vector Calculus I 1. Key points Scalar and vector fields Gradient and directional derivative Laplacian Maple Derivatives VectorCalculus package SetCoordinates Vector Norm DotProduct Gradient, Del, Nabla Laplacian evalvf

More information

Solutions for the Practice Final - Math 23B, 2016

Solutions for the Practice Final - Math 23B, 2016 olutions for the Practice Final - Math B, 6 a. True. The area of a surface is given by the expression d, and since we have a parametrization φ x, y x, y, f x, y with φ, this expands as d T x T y da xy

More information

Introduction and Vectors Lecture 1

Introduction and Vectors Lecture 1 1 Introduction Introduction and Vectors Lecture 1 This is a course on classical Electromagnetism. It is the foundation for more advanced courses in modern physics. All physics of the modern era, from quantum

More information

Corrections to the First Printing: Chapter 6. This list includes corrections and clarifications through November 6, 1999.

Corrections to the First Printing: Chapter 6. This list includes corrections and clarifications through November 6, 1999. June 2,2 1 Corrections to the First Printing: Chapter 6 This list includes corrections and clarifications through November 6, 1999. We should have mentioned that our treatment of differential forms, especially

More information

UNIVERSITY of LIMERICK OLLSCOIL LUIMNIGH

UNIVERSITY of LIMERICK OLLSCOIL LUIMNIGH UNIVERSITY of LIMERICK OLLSCOIL LUIMNIGH College of Informatics and Electronics END OF SEMESTER ASSESSMENT PAPER MODULE CODE: MS4613 SEMESTER: Autumn 2002/03 MODULE TITLE: Vector Analysis DURATION OF EXAMINATION:

More information

Rule ST1 (Symmetry). α β = β α for 1-forms α and β. Like the exterior product, the symmetric tensor product is also linear in each slot :

Rule ST1 (Symmetry). α β = β α for 1-forms α and β. Like the exterior product, the symmetric tensor product is also linear in each slot : 2. Metrics as Symmetric Tensors So far we have studied exterior products of 1-forms, which obey the rule called skew symmetry: α β = β α. There is another operation for forming something called the symmetric

More information

Math 302 Outcome Statements Winter 2013

Math 302 Outcome Statements Winter 2013 Math 302 Outcome Statements Winter 2013 1 Rectangular Space Coordinates; Vectors in the Three-Dimensional Space (a) Cartesian coordinates of a point (b) sphere (c) symmetry about a point, a line, and a

More information

LINEAR ALGEBRA - CHAPTER 1: VECTORS

LINEAR ALGEBRA - CHAPTER 1: VECTORS LINEAR ALGEBRA - CHAPTER 1: VECTORS A game to introduce Linear Algebra In measurement, there are many quantities whose description entirely rely on magnitude, i.e., length, area, volume, mass and temperature.

More information

Mo, 12/03: Review Tu, 12/04: 9:40-10:30, AEB 340, study session

Mo, 12/03: Review Tu, 12/04: 9:40-10:30, AEB 340, study session Math 2210-1 Notes of 12/03/2018 Math 2210-1 Fall 2018 Review Remaining Events Fr, 11/30: Starting Review. No study session today. Mo, 12/03: Review Tu, 12/04: 9:40-10:30, AEB 340, study session We, 12/05:

More information

Dr. Allen Back. Dec. 3, 2014

Dr. Allen Back. Dec. 3, 2014 Dr. Allen Back Dec. 3, 2014 forms are sums of wedge products of the basis 1-forms dx, dy, and dz. They are kinds of tensors generalizing ordinary scalar functions and vector fields. They have a skew-symmetry

More information

2.20 Fall 2018 Math Review

2.20 Fall 2018 Math Review 2.20 Fall 2018 Math Review September 10, 2018 These notes are to help you through the math used in this class. This is just a refresher, so if you never learned one of these topics you should look more

More information

Summary for Vector Calculus and Complex Calculus (Math 321) By Lei Li

Summary for Vector Calculus and Complex Calculus (Math 321) By Lei Li Summary for Vector alculus and omplex alculus (Math 321) By Lei Li 1 Vector alculus 1.1 Parametrization urves, surfaces, or volumes can be parametrized. Below, I ll talk about 3D case. Suppose we use e

More information

Elements of Vector Calculus : Line and Surface Integrals

Elements of Vector Calculus : Line and Surface Integrals Elements of Vector Calculus : Line and Surface Integrals Lecture 2: Electromagnetic Theory Professor D. K. Ghosh, Physics Department, I.I.T., Bombay In this lecture we will talk about special functions

More information

Notes on Vector Calculus

Notes on Vector Calculus The University of New South Wales Math2111 Notes on Vector Calculus Last updated on May 17, 2006 1 1. Rotations Einstein Summation Convention Basis vectors: i = e 1 = 1 0, j = e 2 = 0 0 1, k = e 3 = 0

More information

Chapter 14: Vector Calculus

Chapter 14: Vector Calculus Chapter 14: Vector Calculus Introduction to Vector Functions Section 14.1 Limits, Continuity, Vector Derivatives a. Limit of a Vector Function b. Limit Rules c. Component By Component Limits d. Continuity

More information

is the ith variable and a i is the unit vector associated with the ith variable. h i

is the ith variable and a i is the unit vector associated with the ith variable. h i . Chapter 10 Vector Calculus Features Used right( ), product( ),./,.*, listúmat( ), mod( ), For...EndFor, norm( ), unitv( ),

More information

Coordinate systems and vectors in three spatial dimensions

Coordinate systems and vectors in three spatial dimensions PHYS2796 Introduction to Modern Physics (Spring 2015) Notes on Mathematics Prerequisites Jim Napolitano, Department of Physics, Temple University January 7, 2015 This is a brief summary of material on

More information

EELE 3331 Electromagnetic I Chapter 3. Vector Calculus. Islamic University of Gaza Electrical Engineering Department Dr.

EELE 3331 Electromagnetic I Chapter 3. Vector Calculus. Islamic University of Gaza Electrical Engineering Department Dr. EELE 3331 Electromagnetic I Chapter 3 Vector Calculus Islamic University of Gaza Electrical Engineering Department Dr. Talal Skaik 2012 1 Differential Length, Area, and Volume This chapter deals with integration

More information

Laplace equation in polar coordinates

Laplace equation in polar coordinates Laplace equation in polar coordinates The Laplace equation is given by 2 F 2 + 2 F 2 = 0 We have x = r cos θ, y = r sin θ, and also r 2 = x 2 + y 2, tan θ = y/x We have for the partials with respect to

More information

1.1 Single Variable Calculus versus Multivariable Calculus Rectangular Coordinate Systems... 4

1.1 Single Variable Calculus versus Multivariable Calculus Rectangular Coordinate Systems... 4 MATH2202 Notebook 1 Fall 2015/2016 prepared by Professor Jenny Baglivo Contents 1 MATH2202 Notebook 1 3 1.1 Single Variable Calculus versus Multivariable Calculus................... 3 1.2 Rectangular Coordinate

More information

Mathematical Concepts & Notation

Mathematical Concepts & Notation Mathematical Concepts & Notation Appendix A: Notation x, δx: a small change in x t : the partial derivative with respect to t holding the other variables fixed d : the time derivative of a quantity that

More information

Lecture 2 : Curvilinear Coordinates

Lecture 2 : Curvilinear Coordinates Lecture 2 : Curvilinear Coordinates Fu-Jiun Jiang October, 200 I. INTRODUCTION A. Definition and Notations In 3-dimension Euclidean space, a vector V can be written as V = e x V x + e y V y + e z V z with

More information

Math 304, Differential Forms, Lecture 1 May 26, 2011

Math 304, Differential Forms, Lecture 1 May 26, 2011 Math 304, Differential Forms, Lecture 1 May 26, 2011 Differential forms were developed and applied to vector fields in a decisive way by the French Mathematician Élie artan (1869 1951) in the first quarter

More information

Brief Review of Vector Algebra

Brief Review of Vector Algebra APPENDIX Brief Review of Vector Algebra A.0 Introduction Vector algebra is used extensively in computational mechanics. The student must thus understand the concepts associated with this subject. The current

More information

Ma 1c Practical - Solutions to Homework Set 7

Ma 1c Practical - Solutions to Homework Set 7 Ma 1c Practical - olutions to omework et 7 All exercises are from the Vector Calculus text, Marsden and Tromba (Fifth Edition) Exercise 7.4.. Find the area of the portion of the unit sphere that is cut

More information

Instructions: No books. No notes. Non-graphing calculators only. You are encouraged, although not required, to show your work.

Instructions: No books. No notes. Non-graphing calculators only. You are encouraged, although not required, to show your work. Exam 3 Math 850-007 Fall 04 Odenthal Name: Instructions: No books. No notes. Non-graphing calculators only. You are encouraged, although not required, to show your work.. Evaluate the iterated integral

More information

Sections minutes. 5 to 10 problems, similar to homework problems. No calculators, no notes, no books, no phones. No green book needed.

Sections minutes. 5 to 10 problems, similar to homework problems. No calculators, no notes, no books, no phones. No green book needed. MTH 34 Review for Exam 4 ections 16.1-16.8. 5 minutes. 5 to 1 problems, similar to homework problems. No calculators, no notes, no books, no phones. No green book needed. Review for Exam 4 (16.1) Line

More information

9.7 Gradient of a Scalar Field. Directional Derivative. Mean Value Theorem. Special Cases

9.7 Gradient of a Scalar Field. Directional Derivative. Mean Value Theorem. Special Cases SEC. 9.7 Gradient of a Scalar Field. Directional Derivative 395 Mean Value Theorems THEOREM Mean Value Theorem Let f(x, y, z) be continuous and have continuous first partial derivatives in a domain D in

More information

Vector Calculus handout

Vector Calculus handout Vector Calculus handout The Fundamental Theorem of Line Integrals Theorem 1 (The Fundamental Theorem of Line Integrals). Let C be a smooth curve given by a vector function r(t), where a t b, and let f

More information

MULTIVARIABLE INTEGRATION

MULTIVARIABLE INTEGRATION MULTIVARIABLE INTEGRATION (SPHERICAL POLAR COORDINATES) Question 1 a) Determine with the aid of a diagram an expression for the volume element in r, θ, ϕ. spherical polar coordinates, ( ) [You may not

More information

Physics 6303 Lecture 2 August 22, 2018

Physics 6303 Lecture 2 August 22, 2018 Physics 6303 Lecture 2 August 22, 2018 LAST TIME: Coordinate system construction, covariant and contravariant vector components, basics vector review, gradient, divergence, curl, and Laplacian operators

More information

Gradient operator. In our calculation of dφ along the vector ds, we see that it can be described as the scalar product

Gradient operator. In our calculation of dφ along the vector ds, we see that it can be described as the scalar product Gradient operator In our calculation of dφ along the vector ds, we see that it can be described as the scalar product ( φ dφ = x î + φ y ĵ + φ ) z ˆk ( ) u x dsî + u y dsĵ + u z dsˆk We take dφ = φ ds

More information

Figure 25:Differentials of surface.

Figure 25:Differentials of surface. 2.5. Change of variables and Jacobians In the previous example we saw that, once we have identified the type of coordinates which is best to use for solving a particular problem, the next step is to do

More information

Chapter 3 - Vector Calculus

Chapter 3 - Vector Calculus Chapter 3 - Vector Calculus Gradient in Cartesian coordinate system f ( x, y, z,...) dr ( dx, dy, dz,...) Then, f f f f,,,... x y z f f f df dx dy dz... f dr x y z df 0 (constant f contour) f dr 0 or f

More information

ELE3310: Basic ElectroMagnetic Theory

ELE3310: Basic ElectroMagnetic Theory A summary for the final examination EE Department The Chinese University of Hong Kong November 2008 Outline Mathematics 1 Mathematics Vectors and products Differential operators Integrals 2 Integral expressions

More information

MATHS 267 Answers to Stokes Practice Dr. Jones

MATHS 267 Answers to Stokes Practice Dr. Jones MATH 267 Answers to tokes Practice Dr. Jones 1. Calculate the flux F d where is the hemisphere x2 + y 2 + z 2 1, z > and F (xz + e y2, yz, z 2 + 1). Note: the surface is open (doesn t include any of the

More information

Mathematics for Physical Sciences III

Mathematics for Physical Sciences III Mathematics for Physical Sciences III Change of lecturer: First 4 weeks: myself again! Remaining 8 weeks: Dr Stephen O Sullivan Continuous Assessment Test Date to be announced (probably Week 7 or 8) -

More information