3. Interpolation. Closing the Gaps of Discretization... Beyond Polynomials

Size: px
Start display at page:

Download "3. Interpolation. Closing the Gaps of Discretization... Beyond Polynomials"

Transcription

1 3. Interpolation Closing the Gaps of Discretization... Beyond Polynomials Closing the Gaps of Discretization... Beyond Polynomials, December 19,

2 3.3. Polynomial Splines Idea of Polynomial Splines Remember the main disadvantages of polynomial interpolation: Number of data points and polynomial degree are functionally related. For bigger n (and therefore for a bigger number of nodes, which frequently occurs in practice), polynomial interpolation is useless just because of matters of condition. Idea for remedy: Do something similar as ship builders did to define harmonic curves with the help of an elastic wooden slat (spline) fixed at an arbitrary number of support points. The resulting shape minimizes energy. wikipedia Closing the Gaps of Discretization... Beyond Polynomials, December 19,

3 Definition of Polynomial Splines Glue together pieces of polynomials of lower degree to form a global interpolant for a big number of nodes as well. This is exactly what polynomial splines or, in short, splines do, which we introduce in a general way, without specific references to interpolation problems. Let again be a = x 0 < x 1 <... < x n = b and m N. The x i are called knots. We only examine the special case of simple knots i.e. x i x j for i j. A function s : [a, b] R is called spline of order m or of degree m 1, if the following holds: s(x) = p i (x) on [x i, x i+1 ] with p i P m 1, i = 0, 1,..., n 1, s C m 2 ([a, b]). Between two neighboring knots s is a polynomial of degree m 1 and globally (particularly in the knots themselves) s is m 2 times continuously differentiable. s is also called piecewise polynomial. Closing the Gaps of Discretization... Beyond Polynomials, December 19,

4 Examples, Characteristics, and Applications What does a polynomial spline look like? For this, we examine the simplest cases: m = 1: s is a step function (piecewise continuous, continuity is not even given in knots) m = 2: s is a polygonal chain (piecewise linear, continuous in knots) m = 3: quadratic spline (piecewise quadratic, globally one time continuously differentiable) m = 4: cubic spline (piecewise cubic, globally twice continuously differentiable) Evidently, with fixed knots and fixed degree, the set of all splines forms a vector space with dimension n + m 1: a polygon p 0 P m 1 has m degrees of freedom our slpine consists of n such polynomials the spline is m 2 times continuously differentiable, this results in m 1 conditions per inner node we have n 1 inner nodes m n (m 1) (n 1) = n + m 1. Closing the Gaps of Discretization... Beyond Polynomials, December 19,

5 Examples, Characteristics, and Applications fourth order interpolating polynomial for five support points linear spline (m = 2) euclid.colorado.edu Closing the Gaps of Discretization... Beyond Polynomials, December 19,

6 Examples, Characteristics, and Applications fourth order interpolating polynomial for five support points quadratic spline (m = 3) euclid.colorado.edu Closing the Gaps of Discretization... Beyond Polynomials, December 19,

7 Examples, Characteristics, and Applications fourth order interpolating polynomial for five support points quadratic spline (m = 3) euclid.colorado.edu Closing the Gaps of Discretization... Beyond Polynomials, December 19,

8 Examples, Characteristics, and Applications fourth order interpolating polynomial for five support points quadratic spline (m = 3) euclid.colorado.edu Closing the Gaps of Discretization... Beyond Polynomials, December 19,

9 Examples, Characteristics, and Applications fourth order interpolating polynomial for five support points natural cubic spline (m = 4, zero second derivative at end points) euclid.colorado.edu Closing the Gaps of Discretization... Beyond Polynomials, December 19,

10 Examples, Characteristics, and Applications fourth order interpolating polynomial for five support points clamped cubic spline (m = 4, zero first derivative at end points) euclid.colorado.edu Closing the Gaps of Discretization... Beyond Polynomials, December 19,

11 Main fields of application for splines: Interpolation: A spline is to be constructed in a way such that it fulfills n + m 1 interpolation constraints according to the number of its degrees of freedom. The nodes of the interpolation can but do not have to be knots. CAGD: Here the spline is to be constructed in a way that it takes the shape of the curve defined by control points (important in context with free form curves and surfaces). Closing the Gaps of Discretization... Beyond Polynomials, December 19,

12 Interpolation with Cubic Splines Now we actually use splines for interpolation. Cubic splines, the case of m = 4, are widespread for interpolation purposes. Moreover, they are easy to construct and to analyze. Examine the following special case: simpe knots: a = x 0 < x 1 <... < x n = b locally: spline s P 3 on every subinterval [x i, x i+1 ], i = 0, 1,..., n 1 globally: spline s C 2 ([a, b]) Let the nodes be exactly the knots, then the interpolation constraints are With this, we get: s(x i ) = y i, i = 0, 1,..., n. We have n + m 1 = n + 3 degrees of freedom for the determination of the concrete spline (dimension of the underlying vector space, see above) Of those, n + 1 are needed for the above interpolation constraints. With this, 2 degrees of freedom remain, which we can use for further conditions to s. More on this later. Firstly, we set about building our cubic spline. Closing the Gaps of Discretization... Beyond Polynomials, December 19,

13 The Local Polynomial Segments For every subinterval [x i, x i+1 ] compute the local cubic polynomial: s(x) = p i (x) = at 3 + bt 2 + ct + d with t = x x i x i+1 x i Using the function values y i and y i+1 at the support points and given derivatives y i and y i+1 d = y i c = (x i+1 x i )y i, a + b + c + d = y i+1 3a + 2b + c = (x i+1 x i )y i+1 This gives the solution d = y i, c = (x i+1 x i )y i, b = 3(y i+1 y i ) 2h i y i h i y i+1, a = 2(y i+1 y i ) + h i y i + h i y i+1 with h i = x i+1 x i and, finally, the cubic polynomial p i (x) = (1 3t 2 + 2t 3 )y i + (3t 2 2t 3 )y i+1 + (t 2t 2 + t 3 )h i y i + ( t 2 + t 3 )h i y i+1. Closing the Gaps of Discretization... Beyond Polynomials, December 19,

14 The Global Gluing Together In the representation using local polynomials p i (x) = (1 3t 2 + 2t 3 )y i + (3t 2 2t 3 )y i+1 + (t 2t 2 + t 3 )h i y i + ( t 2 + t 3 )h i y i+1, the knot values y 0,..., y n are given by the constraints of interpolation. The continuity of the spline and the continuity of the first derivative are already included in our representation. Therefore, we have n + 1 degrees of freedom (y 0,..., y n ) left to ensure continuity of the second derivative at the n 1 interior knots. This means, we need two additional conditions to get a unique solution. We differentiate all local polynomials twice and obtain continuity at the n 1 glued points by equating the second derivative of p i 1 in t = 1 and the second derivative of p i in t = 0: ( y i y i + 2 h i 1 h i 1 h i ) + y ( 1 yi y i 1 i+1 = 3 h i hi y i+1 y i h 2 i ). Closing the Gaps of Discretization... Beyond Polynomials, December 19,

15 Obviously, the equations for the continuity of the second derivative establish a tridiagonal system of linear equations h 0 h 0 h 1 h h n 2 h n 2 h n 1 h n 1 y 0... y n = ( ) y of dimension (n 1) (n + 1) with rhs i = 3 i y i 1 + y i+1 y i a first h i 1 2 h i 2 motivation to intensely deal with the numerical solution of systems of linear equations in chapters 5 and 6. rhs 1.. rhs n 1 Closing the Gaps of Discretization... Beyond Polynomials, December 19,

16 How should the conditions for the two spare degrees of freedom be defined? Usually, boundary conditions are being set. In this case, three methods are common: providing the slope at the boundaries, i.e. of y 0 and y n providing the second derivatives at the boundaries (natural boundary conditions) periodic boundary conditions: The first and second derivatives at both boundary points respectively have to be equal, thus y 0 = y n and s (x 0 ) = s (x n). For natural boundary conditions, e.g., we get the quadratic system of linear equations h 0 h h 0 h 0 h 1 h h n 2 h n 2 h n 1 h n h n 1 h n 1 y 0... y n = 3 y 1 y 0 h 0 2 rhs 1.. rhs n 1 3 yn y n 1 h 2 n 1. Closing the Gaps of Discretization... Beyond Polynomials, December 19,

17 Costs and Performance How much does cubic spline interpolation cost? A (depending on the choice of boundary conditions possibly slightly perturbed) tridiagonal system of equations has to be solved. It s easy to realize that this can be done with O(n) arithmetic operations (e.g. by Gaussian elimination known from linear algebra). This is to be compared with the O(n 3 ) arithmetic operations (reminiscence to linear algebra or see chapter 4) used for solving a full system of equations at the incidence sample or rather with the quadratic computational effort of the scheme of Aitken and Neville. Which accuracy does the spline operation provide? As we are using local polynomials of third degree and the nodes have distance h := x i+1 x i, the error estimation delivers (analogously to section 3.2) f (x) s(x) = O(h 4 ). This has to be compared with the order of error O(h n+1 ) of polynomial interpolation. However, there, an extremely high differentiability is assumed and, for bigger n, the problems of condition detected earlier occur. Closing the Gaps of Discretization... Beyond Polynomials, December 19,

18 3.4. Trigonometric Interpolation The Principle of Trigonometric Interpolation trigonometric interpolation is used to interpolate periodoc functions f with (after suitable scaling) f (t + 1) = f (t). We use sinus and cosinus functions with different frequencies k N 0 as a basis for the space of our interpolating functions. In the complex plane, these are A representation of a function p as z(t) k with z(t) = e 2πit = cos(2πkt) + i sin(2πkt). p(t) = n c k z(t) k = k=0 n c k (cos(2πkt) + i sin(2πkt)) k=0 is also called representation in frequency space. Closing the Gaps of Discretization... Beyond Polynomials, December 19,

19 As an example consider the function plottet in these graphs: The function can be written as a combination of three frequency modes (k = 1, 3, 6): ( ) p(t) = 4 sin(2πt) + 2 sin(6πt) sin(12πt) = Im 4e 2πit + 2e 6πit e 12πit. Closing the Gaps of Discretization... Beyond Polynomials, December 19,

20 Similar to polynomial interpolation, we use n support points ( t j = j ) n, v j, j = 0,..., n 1. To be found is the interpolant p(z) = n 1 c k z k with z = e 2πit, t [0, 1] k=0 fulfilling the interpolation constraints p(z j ) = v j for j = 0, 1,..., n 1 with z j = e 2πij n. To find this p means de facto to calculate the coefficients c k, those being nothing else but the coefficients of the (discrete) Fourier transform. For this problem, we discuss an almost legendary algorithm, the fast Fourier transform (FFT), in the following. Closing the Gaps of Discretization... Beyond Polynomials, December 19,

21 The Discrete Fourier Transform With the p introduced earlier and the abbreviation ω := e 2πi n the following problem has to be solved: Find n complex numbers c 0,..., c n 1, which fulfill v j = p(ω j ) = n 1 c k ω jk for j = 0, 1,..., n 1. k=0 With a bit of calculus ( ω complex conjugate to ω), it can be shown that c k = 1 n 1 v j ω jk for k = 0, 1,..., n 1. n j=0 We denote by c and v the n-dimensional vectors of the discrete Fourier coefficients or of the DFT input, respectively. Furthermore, let the matrix M be given as M = (ω jk ) 0 j,k n 1. Then, in matrix vector notation, we have v = M c, c = 1 n M v. Closing the Gaps of Discretization... Beyond Polynomials, December 19,

22 The formula for calculating the coefficients is given by the discrete Fourier transform (DFT) of the input data v k. The formula for calculating the values v j out of the Fourier coefficients c k is called inverse discrete Fourier transform (IDFT). Obviously, the number of arithmetic operations needed for DFT and IDFT is of order O(n 2 ). In contrast, the FFT algorithm does with O(n log n) operations for suitable n. Closing the Gaps of Discretization... Beyond Polynomials, December 19,

23 The FFT Algorithm Basic Principle (1) Basic idea: Break down sums of length n into two partial sums of half length and continue recursively until reaching the trivial sum of length 1. For this purpose, we confine ourselves to the case of n = 2 p, i.e. to powers of 2, from the outset. In the following, we examine the inverse discrete Fourier transform (IDFT). The method for the actual DFT follows from this clearly through transitioning to the complex conjugate and dividing by n: v = IDFT (c), c = DFT (v) = 1 IDFT ( v). n Closing the Gaps of Discretization... Beyond Polynomials, December 19,

24 The FFT Algorithm Basic Principle (2) For v = IDFT (c), we get with n = 2m for j = 0, 1,..., m 1 v j = n 1 c k e 2πijk n = k=0 = n/2 1 k=0 m 1 k=0 n/2 1 c 2k e 2πij2k n + k=0 c 2k e 2πijk m 1 m + ω j k=0 c 2k+1 e 2πij(2k+1) n c 2k+1 e 2πijk m. The entries still missing v m,..., v n 1 (the upper half of the indices) emerge, following the same principle, according to v m+j = = for j = 0, 1,..., m 1, as m 1 k=0 m 1 k=0 e 2πi(j+m) n c 2k e 2πi(j+m)2k m 1 n + k=0 c 2k e 2πijk m 1 m ω j = e πi e πij m k=0 c 2k+1 e 2πi(j+m)(2k+1) n c 2k+1 e 2πijk m = e πij m = ω j. Closing the Gaps of Discretization... Beyond Polynomials, December 19,

25 The FFT Algorithm Basic Principle (3) This corresponds to a structure v j = A + ω j B, v m+j = A ω j B, where the components A and B themselves are Fourier sums of half length. We can reduce the computation of v = IDFT (c) to IDFT (c 0, c 2,..., c n 2 ) and IDFT (c 1, c 3,..., c n 1 ), which then have to be linearly combined appropriately to get the first and second half of v. Combining appropriately is to say combining with the aid of the so called Butterfly scheme. Closing the Gaps of Discretization... Beyond Polynomials, December 19,

26 The FFT Algorithm Basic Principle (4) This procedure will now be repeated recursively. With this, we can give a first recursive program in pseudocode: funct IDFT(c[0],...,c[n-1],n); if (n=1) then do v[0]:=c[0] od; else do m:=n/2; z1:=idft(c[0],c[2],...,c[n-2],m); z2:=idft(c[1],c[3],...,c[n-1],m); omega:=exp(2*pi*i/n); for j:=0 to m-1 do v[j]:=z1[j]+omegaˆj*z2[j]; v[m+j]:=z1[j]-omegaˆj*z2[j]; od; return(v[0],...,v[n-1]); od; Closing the Gaps of Discretization... Beyond Polynomials, December 19,

27 Analysis of the FFT Algorithm The basic algorithm above is recursive; for better runtime and memory efficiency, iterative variations were developed. The FFT algorithm naturally breaks down into a sorting phase (rearranging of the c[k]) and a combining phase (butterfly operation). This can be demonstrated for the example of n = 8: Closing the Gaps of Discretization... Beyond Polynomials, December 19,

28 Here, the butterfly operation stands for From this picture, we intuitively learn two things: The underlying principles of the FFT algorithm can be found again in completely different places such as dynamic networks such as Shuffle-Exchange. The computing complexity of the FFT algorithm is of order O(n log(n)). Closing the Gaps of Discretization... Beyond Polynomials, December 19,

29 An Application: Compression of Picture Data Let a gray scale picture be considered as a matrix of gray scale values. Every matrix entry g i,j then corresponds to the gray scale value of the pixel in row i and column j of the picture. To stay independent of the number of the gray scales available, we allow g i,j [0, 1], where zero is equal to the color black. The JPEG method uses the special frequency distribution of natural images to store them at a high compression rate. Losses occurring due to compression are accepted the compression is lossy. The compression is done in the following way: Color images are transformed into the YUV color model (Y stands for intensity, U and V identify hue and saturation). The picture is divided into blocks of 8 8 pixels. In each of those blocks, a fast cosine transform FCT is done which is explained on the next slide. The frequency values are quantized only a certain number of discrete color values is accepted, intermediate values have to be rounded accordingly. This step is mainly responsible for the occurring loss of quality. Finally, the quantized data get compressed appropriately. Closing the Gaps of Discretization... Beyond Polynomials, December 19,

30 The Cosine Transform Image data is neither periodic nor does it have complex parts. Therefore, the conventional Fourier transform is useless here. The JPEG method uses the following variation, the so called Cosine transform: transformation: F k := ( N 1 πk(j f j cos ) ) N j=0 k = 0, 1,..., N 1 inverse transformation: ( f j := 2 N 1 πk(j F k cos ) ) N N k=0 ( := 2 F N 1 0 N 2 + πk(j F k cos ) ) N k=1 j = 0,..., N 1 Instead of the complex exponential terms as basic components, here, only real cosine terms appear. Closing the Gaps of Discretization... Beyond Polynomials, December 19,

31 For 2 D the relevant case for image data processing the following representation results: F k1,k 2 := f j1,j 2 := N 1 1 j 1 =0 4 N 1 N 2 N 2 1 j 2 =0 N 1 1 k 1 =0 ( πk1 (j f j1,j 2 cos ) ) ( πk2 (j cos ) ) N 1 N 2 N 2 1 k 2 =0 ( πk1 (j F k1,k 2 cos ) ) cos N 1 ( πk2 (j ) ) N 2 Closing the Gaps of Discretization... Beyond Polynomials, December 19,

32 Reduction to FFT: We want to use our FFT knowledge in the search for a faster algorithm for solving the discrete cosine transform. For this, we reduce the 2D cosine transform above to the familiar FFT in three steps: The 2D cosine transform can be realized by composing 1D cosine transforms. By mirroring the values of F k or rather f j the cosine transform can be transferred into a modified Fourier transform of double length. With { fj j = 0,..., N 1, fj := and we get fj = 1 2N 2N 1 k=0 F k := F k e ( f 2N j 1 j = N,..., 2N 1 2F k k = 0,..., N 1, 0 k = N, 2F 2N k k = N + 1,..., 2N 1 ) 2πi(j+ 1 2 )k 2N, and Fk = 2N 1 j=0 fj e ( 2πi(j+ 2 1 ) )k 2N. By scaling F k and f j adequately, the introduced standard representation of the (I)DFT results. Closing the Gaps of Discretization... Beyond Polynomials, December 19,

33 3.5. Examples for Applications of Interpolation Interpolation in Computer Science Tables formerly indispensable for functions such as the logarithm or trigonometric functions, today they are actually only used for distribution functions such as the normal distribution print function values at discrete nodes. If intermediate values are wanted, interpolation is necessary. In every function plot discrete points have to be interpolated. Arbitrary nonlinear curves and surfaces so called freeform curves or freeform surfaces play a big role in geometric modeling and computer graphics. For the creation of computer animations, e.g. of cartoon sequences, the explicit creation of every single frame usually is too costly computationally for real-time applications after all, about 25 images per second are needed for a visually appealing (i.e. especially jerk free) animation. For this reason, often only certain keyframes are computed and certain interim frames are interpolated, which is also called inbetweening in this context. When robots are moving (e.g. playing soccer), discrete target points are computed the way from the momentary position to the next target is then determined by interpolation. Closing the Gaps of Discretization... Beyond Polynomials, December 19,

34 For picture reconstruction, the original has to be reconstructed as exactly as possible out of the compressed or faulty image data another case for interpolation. Eventually, the problem of interpolation occurs at every D/A conversion of a signal. Closing the Gaps of Discretization... Beyond Polynomials, December 19,

Computer Graphics. Geometric Modeling. Page 1. Copyright Gotsman, Elber, Barequet, Karni, Sheffer Computer Science - Technion. An Example.

Computer Graphics. Geometric Modeling. Page 1. Copyright Gotsman, Elber, Barequet, Karni, Sheffer Computer Science - Technion. An Example. An Example 2 3 4 Outline Objective: Develop methods and algorithms to mathematically model shape of real world objects Categories: Wire-Frame Representation Object is represented as as a set of points

More information

Piecewise Cubic Splines

Piecewise Cubic Splines 280 CHAP. 5 CURVE FITTING Piecewise Cubic Splines The fitting of a polynomial curve to a set of data points has applications in CAD (computer-assisted design), CAM (computer-assisted manufacturing), and

More information

(Refer Slide Time: 1:42)

(Refer Slide Time: 1:42) Introduction to Computer Graphics Dr. Prem Kalra Department of Computer Science and Engineering Indian Institute of Technology, Delhi Lecture - 10 Curves So today we are going to have a new topic. So far

More information

CHAPTER 1 Splines and B-splines an Introduction

CHAPTER 1 Splines and B-splines an Introduction CHAPTER 1 Splines and B-splines an Introduction In this first chapter, we consider the following fundamental problem: Given a set of points in the plane, determine a smooth curve that approximates the

More information

Figure 2.1: Center of mass of four points.

Figure 2.1: Center of mass of four points. Chapter 2 Bézier curves are named after their inventor, Dr. Pierre Bézier. Bézier was an engineer with the Renault car company and set out in the early 196 s to develop a curve formulation which would

More information

NEW YORK STATE TEACHER CERTIFICATION EXAMINATIONS

NEW YORK STATE TEACHER CERTIFICATION EXAMINATIONS NEW YORK STATE TEACHER CERTIFICATION EXAMINATIONS TEST DESIGN AND FRAMEWORK September 2014 Authorized for Distribution by the New York State Education Department This test design and framework document

More information

the points are called control points approximating curve

the points are called control points approximating curve Chapter 4 Spline Curves A spline curve is a mathematical representation for which it is easy to build an interface that will allow a user to design and control the shape of complex curves and surfaces.

More information

Essential Mathematics for Computer Graphics fast

Essential Mathematics for Computer Graphics fast John Vince Essential Mathematics for Computer Graphics fast Springer Contents 1. MATHEMATICS 1 Is mathematics difficult? 3 Who should read this book? 4 Aims and objectives of this book 4 Assumptions made

More information

EECS 556 Image Processing W 09. Interpolation. Interpolation techniques B splines

EECS 556 Image Processing W 09. Interpolation. Interpolation techniques B splines EECS 556 Image Processing W 09 Interpolation Interpolation techniques B splines What is image processing? Image processing is the application of 2D signal processing methods to images Image representation

More information

We can display an object on a monitor screen in three different computer-model forms: Wireframe model Surface Model Solid model

We can display an object on a monitor screen in three different computer-model forms: Wireframe model Surface Model Solid model CHAPTER 4 CURVES 4.1 Introduction In order to understand the significance of curves, we should look into the types of model representations that are used in geometric modeling. Curves play a very significant

More information

AN INTRODUCTION TO NUMERICAL METHODS AND ANALYSIS

AN INTRODUCTION TO NUMERICAL METHODS AND ANALYSIS AN INTRODUCTION TO NUMERICAL METHODS AND ANALYSIS Revised Edition James Epperson Mathematical Reviews BICENTENNIAL 0, 1 8 0 7 z ewiley wu 2007 r71 BICENTENNIAL WILEY-INTERSCIENCE A John Wiley & Sons, Inc.,

More information

How To Understand And Solve Algebraic Equations

How To Understand And Solve Algebraic Equations College Algebra Course Text Barnett, Raymond A., Michael R. Ziegler, and Karl E. Byleen. College Algebra, 8th edition, McGraw-Hill, 2008, ISBN: 978-0-07-286738-1 Course Description This course provides

More information

1 Cubic Hermite Spline Interpolation

1 Cubic Hermite Spline Interpolation cs412: introduction to numerical analysis 10/26/10 Lecture 13: Cubic Hermite Spline Interpolation II Instructor: Professor Amos Ron Scribes: Yunpeng Li, Mark Cowlishaw, Nathanael Fillmore 1 Cubic Hermite

More information

Mathematics (MAT) MAT 061 Basic Euclidean Geometry 3 Hours. MAT 051 Pre-Algebra 4 Hours

Mathematics (MAT) MAT 061 Basic Euclidean Geometry 3 Hours. MAT 051 Pre-Algebra 4 Hours MAT 051 Pre-Algebra Mathematics (MAT) MAT 051 is designed as a review of the basic operations of arithmetic and an introduction to algebra. The student must earn a grade of C or in order to enroll in MAT

More information

Precalculus REVERSE CORRELATION. Content Expectations for. Precalculus. Michigan CONTENT EXPECTATIONS FOR PRECALCULUS CHAPTER/LESSON TITLES

Precalculus REVERSE CORRELATION. Content Expectations for. Precalculus. Michigan CONTENT EXPECTATIONS FOR PRECALCULUS CHAPTER/LESSON TITLES Content Expectations for Precalculus Michigan Precalculus 2011 REVERSE CORRELATION CHAPTER/LESSON TITLES Chapter 0 Preparing for Precalculus 0-1 Sets There are no state-mandated Precalculus 0-2 Operations

More information

Current Standard: Mathematical Concepts and Applications Shape, Space, and Measurement- Primary

Current Standard: Mathematical Concepts and Applications Shape, Space, and Measurement- Primary Shape, Space, and Measurement- Primary A student shall apply concepts of shape, space, and measurement to solve problems involving two- and three-dimensional shapes by demonstrating an understanding of:

More information

PCHS ALGEBRA PLACEMENT TEST

PCHS ALGEBRA PLACEMENT TEST MATHEMATICS Students must pass all math courses with a C or better to advance to the next math level. Only classes passed with a C or better will count towards meeting college entrance requirements. If

More information

CSE 167: Lecture 13: Bézier Curves. Jürgen P. Schulze, Ph.D. University of California, San Diego Fall Quarter 2011

CSE 167: Lecture 13: Bézier Curves. Jürgen P. Schulze, Ph.D. University of California, San Diego Fall Quarter 2011 CSE 167: Introduction to Computer Graphics Lecture 13: Bézier Curves Jürgen P. Schulze, Ph.D. University of California, San Diego Fall Quarter 2011 Announcements Homework project #6 due Friday, Nov 18

More information

INTERPOLATION. Interpolation is a process of finding a formula (often a polynomial) whose graph will pass through a given set of points (x, y).

INTERPOLATION. Interpolation is a process of finding a formula (often a polynomial) whose graph will pass through a given set of points (x, y). INTERPOLATION Interpolation is a process of finding a formula (often a polynomial) whose graph will pass through a given set of points (x, y). As an example, consider defining and x 0 =0, x 1 = π 4, x

More information

Numerical Analysis An Introduction

Numerical Analysis An Introduction Walter Gautschi Numerical Analysis An Introduction 1997 Birkhauser Boston Basel Berlin CONTENTS PREFACE xi CHAPTER 0. PROLOGUE 1 0.1. Overview 1 0.2. Numerical analysis software 3 0.3. Textbooks and monographs

More information

Natural cubic splines

Natural cubic splines Natural cubic splines Arne Morten Kvarving Department of Mathematical Sciences Norwegian University of Science and Technology October 21 2008 Motivation We are given a large dataset, i.e. a function sampled

More information

Prentice Hall Algebra 2 2011 Correlated to: Colorado P-12 Academic Standards for High School Mathematics, Adopted 12/2009

Prentice Hall Algebra 2 2011 Correlated to: Colorado P-12 Academic Standards for High School Mathematics, Adopted 12/2009 Content Area: Mathematics Grade Level Expectations: High School Standard: Number Sense, Properties, and Operations Understand the structure and properties of our number system. At their most basic level

More information

South Carolina College- and Career-Ready (SCCCR) Pre-Calculus

South Carolina College- and Career-Ready (SCCCR) Pre-Calculus South Carolina College- and Career-Ready (SCCCR) Pre-Calculus Key Concepts Arithmetic with Polynomials and Rational Expressions PC.AAPR.2 PC.AAPR.3 PC.AAPR.4 PC.AAPR.5 PC.AAPR.6 PC.AAPR.7 Standards Know

More information

BookTOC.txt. 1. Functions, Graphs, and Models. Algebra Toolbox. Sets. The Real Numbers. Inequalities and Intervals on the Real Number Line

BookTOC.txt. 1. Functions, Graphs, and Models. Algebra Toolbox. Sets. The Real Numbers. Inequalities and Intervals on the Real Number Line College Algebra in Context with Applications for the Managerial, Life, and Social Sciences, 3rd Edition Ronald J. Harshbarger, University of South Carolina - Beaufort Lisa S. Yocco, Georgia Southern University

More information

The Fourth International DERIVE-TI92/89 Conference Liverpool, U.K., 12-15 July 2000. Derive 5: The Easiest... Just Got Better!

The Fourth International DERIVE-TI92/89 Conference Liverpool, U.K., 12-15 July 2000. Derive 5: The Easiest... Just Got Better! The Fourth International DERIVE-TI9/89 Conference Liverpool, U.K., -5 July 000 Derive 5: The Easiest... Just Got Better! Michel Beaudin École de technologie supérieure 00, rue Notre-Dame Ouest Montréal

More information

Higher Education Math Placement

Higher Education Math Placement Higher Education Math Placement Placement Assessment Problem Types 1. Whole Numbers, Fractions, and Decimals 1.1 Operations with Whole Numbers Addition with carry Subtraction with borrowing Multiplication

More information

Curves and Surfaces. Goals. How do we draw surfaces? How do we specify a surface? How do we approximate a surface?

Curves and Surfaces. Goals. How do we draw surfaces? How do we specify a surface? How do we approximate a surface? Curves and Surfaces Parametric Representations Cubic Polynomial Forms Hermite Curves Bezier Curves and Surfaces [Angel 10.1-10.6] Goals How do we draw surfaces? Approximate with polygons Draw polygons

More information

2x + y = 3. Since the second equation is precisely the same as the first equation, it is enough to find x and y satisfying the system

2x + y = 3. Since the second equation is precisely the same as the first equation, it is enough to find x and y satisfying the system 1. Systems of linear equations We are interested in the solutions to systems of linear equations. A linear equation is of the form 3x 5y + 2z + w = 3. The key thing is that we don t multiply the variables

More information

Thnkwell s Homeschool Precalculus Course Lesson Plan: 36 weeks

Thnkwell s Homeschool Precalculus Course Lesson Plan: 36 weeks Thnkwell s Homeschool Precalculus Course Lesson Plan: 36 weeks Welcome to Thinkwell s Homeschool Precalculus! We re thrilled that you ve decided to make us part of your homeschool curriculum. This lesson

More information

This unit will lay the groundwork for later units where the students will extend this knowledge to quadratic and exponential functions.

This unit will lay the groundwork for later units where the students will extend this knowledge to quadratic and exponential functions. Algebra I Overview View unit yearlong overview here Many of the concepts presented in Algebra I are progressions of concepts that were introduced in grades 6 through 8. The content presented in this course

More information

Credit Number Lecture Lab / Shop Clinic / Co-op Hours. MAC 224 Advanced CNC Milling 1 3 0 2. MAC 229 CNC Programming 2 0 0 2

Credit Number Lecture Lab / Shop Clinic / Co-op Hours. MAC 224 Advanced CNC Milling 1 3 0 2. MAC 229 CNC Programming 2 0 0 2 MAC 224 Advanced CNC Milling 1 3 0 2 This course covers advanced methods in setup and operation of CNC machining centers. Emphasis is placed on programming and production of complex parts. Upon completion,

More information

MATH BOOK OF PROBLEMS SERIES. New from Pearson Custom Publishing!

MATH BOOK OF PROBLEMS SERIES. New from Pearson Custom Publishing! MATH BOOK OF PROBLEMS SERIES New from Pearson Custom Publishing! The Math Book of Problems Series is a database of math problems for the following courses: Pre-algebra Algebra Pre-calculus Calculus Statistics

More information

A matrix method for degree-raising of B-spline curves *

A matrix method for degree-raising of B-spline curves * VOI. 40 NO. 1 SCIENCE IN CHINA (Series E) February 1997 A matrix method for degree-raising of B-spline curves * QIN Kaihuai (%*>/$) (Department of Computer Science and Technology, Tsinghua University,

More information

Classroom Tips and Techniques: The Student Precalculus Package - Commands and Tutors. Content of the Precalculus Subpackage

Classroom Tips and Techniques: The Student Precalculus Package - Commands and Tutors. Content of the Precalculus Subpackage Classroom Tips and Techniques: The Student Precalculus Package - Commands and Tutors Robert J. Lopez Emeritus Professor of Mathematics and Maple Fellow Maplesoft This article provides a systematic exposition

More information

Content. Chapter 4 Functions 61 4.1 Basic concepts on real functions 62. Credits 11

Content. Chapter 4 Functions 61 4.1 Basic concepts on real functions 62. Credits 11 Content Credits 11 Chapter 1 Arithmetic Refresher 13 1.1 Algebra 14 Real Numbers 14 Real Polynomials 19 1.2 Equations in one variable 21 Linear Equations 21 Quadratic Equations 22 1.3 Exercises 28 Chapter

More information

Computer Networks and Internets, 5e Chapter 6 Information Sources and Signals. Introduction

Computer Networks and Internets, 5e Chapter 6 Information Sources and Signals. Introduction Computer Networks and Internets, 5e Chapter 6 Information Sources and Signals Modified from the lecture slides of Lami Kaya (LKaya@ieee.org) for use CECS 474, Fall 2008. 2009 Pearson Education Inc., Upper

More information

Solution of Linear Systems

Solution of Linear Systems Chapter 3 Solution of Linear Systems In this chapter we study algorithms for possibly the most commonly occurring problem in scientific computing, the solution of linear systems of equations. We start

More information

MATH. ALGEBRA I HONORS 9 th Grade 12003200 ALGEBRA I HONORS

MATH. ALGEBRA I HONORS 9 th Grade 12003200 ALGEBRA I HONORS * Students who scored a Level 3 or above on the Florida Assessment Test Math Florida Standards (FSA-MAFS) are strongly encouraged to make Advanced Placement and/or dual enrollment courses their first choices

More information

DIEF, Department of Engineering Enzo Ferrari University of Modena e Reggio Emilia Italy Online Trajectory Planning for robotic systems

DIEF, Department of Engineering Enzo Ferrari University of Modena e Reggio Emilia Italy Online Trajectory Planning for robotic systems DIEF, Department of Engineering Enzo Ferrari University of Modena e Reggio Emilia Italy Online Trajectory Planning for robotic systems Luigi Biagiotti Luigi Biagiotti luigi.biagiotti@unimore.it Introduction

More information

Algebra 1 2008. Academic Content Standards Grade Eight and Grade Nine Ohio. Grade Eight. Number, Number Sense and Operations Standard

Algebra 1 2008. Academic Content Standards Grade Eight and Grade Nine Ohio. Grade Eight. Number, Number Sense and Operations Standard Academic Content Standards Grade Eight and Grade Nine Ohio Algebra 1 2008 Grade Eight STANDARDS Number, Number Sense and Operations Standard Number and Number Systems 1. Use scientific notation to express

More information

Computer Graphics CS 543 Lecture 12 (Part 1) Curves. Prof Emmanuel Agu. Computer Science Dept. Worcester Polytechnic Institute (WPI)

Computer Graphics CS 543 Lecture 12 (Part 1) Curves. Prof Emmanuel Agu. Computer Science Dept. Worcester Polytechnic Institute (WPI) Computer Graphics CS 54 Lecture 1 (Part 1) Curves Prof Emmanuel Agu Computer Science Dept. Worcester Polytechnic Institute (WPI) So Far Dealt with straight lines and flat surfaces Real world objects include

More information

Mathematics Course 111: Algebra I Part IV: Vector Spaces

Mathematics Course 111: Algebra I Part IV: Vector Spaces Mathematics Course 111: Algebra I Part IV: Vector Spaces D. R. Wilkins Academic Year 1996-7 9 Vector Spaces A vector space over some field K is an algebraic structure consisting of a set V on which are

More information

DRAFT. Algebra 1 EOC Item Specifications

DRAFT. Algebra 1 EOC Item Specifications DRAFT Algebra 1 EOC Item Specifications The draft Florida Standards Assessment (FSA) Test Item Specifications (Specifications) are based upon the Florida Standards and the Florida Course Descriptions as

More information

December 4, 2013 MATH 171 BASIC LINEAR ALGEBRA B. KITCHENS

December 4, 2013 MATH 171 BASIC LINEAR ALGEBRA B. KITCHENS December 4, 2013 MATH 171 BASIC LINEAR ALGEBRA B KITCHENS The equation 1 Lines in two-dimensional space (1) 2x y = 3 describes a line in two-dimensional space The coefficients of x and y in the equation

More information

Math 1B Syllabus. Course Description. Text. Course Assignments. Exams. Course Grade

Math 1B Syllabus. Course Description. Text. Course Assignments. Exams. Course Grade Course Description Math 1B Syllabus This Pre-Calculus course is designed to prepare students for a Calculus course. This course is taught so that students will acquire a solid foundation in algebra and

More information

Nonlinear Iterative Partial Least Squares Method

Nonlinear Iterative Partial Least Squares Method Numerical Methods for Determining Principal Component Analysis Abstract Factors Béchu, S., Richard-Plouet, M., Fernandez, V., Walton, J., and Fairley, N. (2016) Developments in numerical treatments for

More information

Constrained curve and surface fitting

Constrained curve and surface fitting Constrained curve and surface fitting Simon Flöry FSP-Meeting Strobl (June 20, 2006), floery@geoemtrie.tuwien.ac.at, Vienna University of Technology Overview Introduction Motivation, Overview, Problem

More information

Mean value theorem, Taylors Theorem, Maxima and Minima.

Mean value theorem, Taylors Theorem, Maxima and Minima. MA 001 Preparatory Mathematics I. Complex numbers as ordered pairs. Argand s diagram. Triangle inequality. De Moivre s Theorem. Algebra: Quadratic equations and express-ions. Permutations and Combinations.

More information

POLYNOMIAL FUNCTIONS

POLYNOMIAL FUNCTIONS POLYNOMIAL FUNCTIONS Polynomial Division.. 314 The Rational Zero Test.....317 Descarte s Rule of Signs... 319 The Remainder Theorem.....31 Finding all Zeros of a Polynomial Function.......33 Writing a

More information

Arithmetic and Algebra of Matrices

Arithmetic and Algebra of Matrices Arithmetic and Algebra of Matrices Math 572: Algebra for Middle School Teachers The University of Montana 1 The Real Numbers 2 Classroom Connection: Systems of Linear Equations 3 Rational Numbers 4 Irrational

More information

Point Lattices in Computer Graphics and Visualization how signal processing may help computer graphics

Point Lattices in Computer Graphics and Visualization how signal processing may help computer graphics Point Lattices in Computer Graphics and Visualization how signal processing may help computer graphics Dimitri Van De Ville Ecole Polytechnique Fédérale de Lausanne Biomedical Imaging Group dimitri.vandeville@epfl.ch

More information

FFT Algorithms. Chapter 6. Contents 6.1

FFT Algorithms. Chapter 6. Contents 6.1 Chapter 6 FFT Algorithms Contents Efficient computation of the DFT............................................ 6.2 Applications of FFT................................................... 6.6 Computing DFT

More information

Image Compression and Decompression using Adaptive Interpolation

Image Compression and Decompression using Adaptive Interpolation Image Compression and Decompression using Adaptive Interpolation SUNILBHOOSHAN 1,SHIPRASHARMA 2 Jaypee University of Information Technology 1 Electronicsand Communication EngineeringDepartment 2 ComputerScience

More information

SOLVING LINEAR SYSTEMS

SOLVING LINEAR SYSTEMS SOLVING LINEAR SYSTEMS Linear systems Ax = b occur widely in applied mathematics They occur as direct formulations of real world problems; but more often, they occur as a part of the numerical analysis

More information

4.3 Lagrange Approximation

4.3 Lagrange Approximation 206 CHAP. 4 INTERPOLATION AND POLYNOMIAL APPROXIMATION Lagrange Polynomial Approximation 4.3 Lagrange Approximation Interpolation means to estimate a missing function value by taking a weighted average

More information

Diablo Valley College Catalog 2014-2015

Diablo Valley College Catalog 2014-2015 Mathematics MATH Michael Norris, Interim Dean Math and Computer Science Division Math Building, Room 267 Possible career opportunities Mathematicians work in a variety of fields, among them statistics,

More information

Creating, Solving, and Graphing Systems of Linear Equations and Linear Inequalities

Creating, Solving, and Graphing Systems of Linear Equations and Linear Inequalities Algebra 1, Quarter 2, Unit 2.1 Creating, Solving, and Graphing Systems of Linear Equations and Linear Inequalities Overview Number of instructional days: 15 (1 day = 45 60 minutes) Content to be learned

More information

Derive 5: The Easiest... Just Got Better!

Derive 5: The Easiest... Just Got Better! Liverpool John Moores University, 1-15 July 000 Derive 5: The Easiest... Just Got Better! Michel Beaudin École de Technologie Supérieure, Canada Email; mbeaudin@seg.etsmtl.ca 1. Introduction Engineering

More information

Big Ideas in Mathematics

Big Ideas in Mathematics Big Ideas in Mathematics which are important to all mathematics learning. (Adapted from the NCTM Curriculum Focal Points, 2006) The Mathematics Big Ideas are organized using the PA Mathematics Standards

More information

CS 4204 Computer Graphics

CS 4204 Computer Graphics CS 4204 Computer Graphics Computer Animation Adapted from notes by Yong Cao Virginia Tech 1 Outline Principles of Animation Keyframe Animation Additional challenges in animation 2 Classic animation Luxo

More information

Geometric Modelling & Curves

Geometric Modelling & Curves Geometric Modelling & Curves Geometric Modeling Creating symbolic models of the physical world has long been a goal of mathematicians, scientists, engineers, etc. Recently technology has advanced sufficiently

More information

Overview. Essential Questions. Precalculus, Quarter 4, Unit 4.5 Build Arithmetic and Geometric Sequences and Series

Overview. Essential Questions. Precalculus, Quarter 4, Unit 4.5 Build Arithmetic and Geometric Sequences and Series Sequences and Series Overview Number of instruction days: 4 6 (1 day = 53 minutes) Content to Be Learned Write arithmetic and geometric sequences both recursively and with an explicit formula, use them

More information

SEQUENCES ARITHMETIC SEQUENCES. Examples

SEQUENCES ARITHMETIC SEQUENCES. Examples SEQUENCES ARITHMETIC SEQUENCES An ordered list of numbers such as: 4, 9, 6, 25, 36 is a sequence. Each number in the sequence is a term. Usually variables with subscripts are used to label terms. For example,

More information

Operation Count; Numerical Linear Algebra

Operation Count; Numerical Linear Algebra 10 Operation Count; Numerical Linear Algebra 10.1 Introduction Many computations are limited simply by the sheer number of required additions, multiplications, or function evaluations. If floating-point

More information

Lecture 3: Finding integer solutions to systems of linear equations

Lecture 3: Finding integer solutions to systems of linear equations Lecture 3: Finding integer solutions to systems of linear equations Algorithmic Number Theory (Fall 2014) Rutgers University Swastik Kopparty Scribe: Abhishek Bhrushundi 1 Overview The goal of this lecture

More information

Degree Reduction of Interval SB Curves

Degree Reduction of Interval SB Curves International Journal of Video&Image Processing and Network Security IJVIPNS-IJENS Vol:13 No:04 1 Degree Reduction of Interval SB Curves O. Ismail, Senior Member, IEEE Abstract Ball basis was introduced

More information

Manifold Learning Examples PCA, LLE and ISOMAP

Manifold Learning Examples PCA, LLE and ISOMAP Manifold Learning Examples PCA, LLE and ISOMAP Dan Ventura October 14, 28 Abstract We try to give a helpful concrete example that demonstrates how to use PCA, LLE and Isomap, attempts to provide some intuition

More information

Estimated Pre Calculus Pacing Timeline

Estimated Pre Calculus Pacing Timeline Estimated Pre Calculus Pacing Timeline 2010-2011 School Year The timeframes listed on this calendar are estimates based on a fifty-minute class period. You may need to adjust some of them from time to

More information

Algebra Unpacked Content For the new Common Core standards that will be effective in all North Carolina schools in the 2012-13 school year.

Algebra Unpacked Content For the new Common Core standards that will be effective in all North Carolina schools in the 2012-13 school year. This document is designed to help North Carolina educators teach the Common Core (Standard Course of Study). NCDPI staff are continually updating and improving these tools to better serve teachers. Algebra

More information

Parametric Curves. (Com S 477/577 Notes) Yan-Bin Jia. Oct 8, 2015

Parametric Curves. (Com S 477/577 Notes) Yan-Bin Jia. Oct 8, 2015 Parametric Curves (Com S 477/577 Notes) Yan-Bin Jia Oct 8, 2015 1 Introduction A curve in R 2 (or R 3 ) is a differentiable function α : [a,b] R 2 (or R 3 ). The initial point is α[a] and the final point

More information

Survey of the Mathematics of Big Data

Survey of the Mathematics of Big Data Survey of the Mathematics of Big Data Philippe B. Laval KSU September 12, 2014 Philippe B. Laval (KSU) Math & Big Data September 12, 2014 1 / 23 Introduction We survey some mathematical techniques used

More information

Pre-Algebra 2008. Academic Content Standards Grade Eight Ohio. Number, Number Sense and Operations Standard. Number and Number Systems

Pre-Algebra 2008. Academic Content Standards Grade Eight Ohio. Number, Number Sense and Operations Standard. Number and Number Systems Academic Content Standards Grade Eight Ohio Pre-Algebra 2008 STANDARDS Number, Number Sense and Operations Standard Number and Number Systems 1. Use scientific notation to express large numbers and small

More information

Notes on Factoring. MA 206 Kurt Bryan

Notes on Factoring. MA 206 Kurt Bryan The General Approach Notes on Factoring MA 26 Kurt Bryan Suppose I hand you n, a 2 digit integer and tell you that n is composite, with smallest prime factor around 5 digits. Finding a nontrivial factor

More information

Algebra 2 Chapter 1 Vocabulary. identity - A statement that equates two equivalent expressions.

Algebra 2 Chapter 1 Vocabulary. identity - A statement that equates two equivalent expressions. Chapter 1 Vocabulary identity - A statement that equates two equivalent expressions. verbal model- A word equation that represents a real-life problem. algebraic expression - An expression with variables.

More information

DEFINITION 5.1.1 A complex number is a matrix of the form. x y. , y x

DEFINITION 5.1.1 A complex number is a matrix of the form. x y. , y x Chapter 5 COMPLEX NUMBERS 5.1 Constructing the complex numbers One way of introducing the field C of complex numbers is via the arithmetic of matrices. DEFINITION 5.1.1 A complex number is a matrix of

More information

3.2 Sources, Sinks, Saddles, and Spirals

3.2 Sources, Sinks, Saddles, and Spirals 3.2. Sources, Sinks, Saddles, and Spirals 6 3.2 Sources, Sinks, Saddles, and Spirals The pictures in this section show solutions to Ay 00 C By 0 C Cy D 0. These are linear equations with constant coefficients

More information

Microeconomic Theory: Basic Math Concepts

Microeconomic Theory: Basic Math Concepts Microeconomic Theory: Basic Math Concepts Matt Van Essen University of Alabama Van Essen (U of A) Basic Math Concepts 1 / 66 Basic Math Concepts In this lecture we will review some basic mathematical concepts

More information

The degree of a polynomial function is equal to the highest exponent found on the independent variables.

The degree of a polynomial function is equal to the highest exponent found on the independent variables. DETAILED SOLUTIONS AND CONCEPTS - POLYNOMIAL FUNCTIONS Prepared by Ingrid Stewart, Ph.D., College of Southern Nevada Please Send Questions and Comments to ingrid.stewart@csn.edu. Thank you! PLEASE NOTE

More information

Lecture Notes to Accompany. Scientific Computing An Introductory Survey. by Michael T. Heath. Chapter 10

Lecture Notes to Accompany. Scientific Computing An Introductory Survey. by Michael T. Heath. Chapter 10 Lecture Notes to Accompany Scientific Computing An Introductory Survey Second Edition by Michael T. Heath Chapter 10 Boundary Value Problems for Ordinary Differential Equations Copyright c 2001. Reproduction

More information

Second Order Linear Nonhomogeneous Differential Equations; Method of Undetermined Coefficients. y + p(t) y + q(t) y = g(t), g(t) 0.

Second Order Linear Nonhomogeneous Differential Equations; Method of Undetermined Coefficients. y + p(t) y + q(t) y = g(t), g(t) 0. Second Order Linear Nonhomogeneous Differential Equations; Method of Undetermined Coefficients We will now turn our attention to nonhomogeneous second order linear equations, equations with the standard

More information

The Fourier Analysis Tool in Microsoft Excel

The Fourier Analysis Tool in Microsoft Excel The Fourier Analysis Tool in Microsoft Excel Douglas A. Kerr Issue March 4, 2009 ABSTRACT AD ITRODUCTIO The spreadsheet application Microsoft Excel includes a tool that will calculate the discrete Fourier

More information

http://www.aleks.com Access Code: RVAE4-EGKVN Financial Aid Code: 6A9DB-DEE3B-74F51-57304

http://www.aleks.com Access Code: RVAE4-EGKVN Financial Aid Code: 6A9DB-DEE3B-74F51-57304 MATH 1340.04 College Algebra Location: MAGC 2.202 Meeting day(s): TR 7:45a 9:00a, Instructor Information Name: Virgil Pierce Email: piercevu@utpa.edu Phone: 665.3535 Teaching Assistant Name: Indalecio

More information

COLLEGE ALGEBRA. Paul Dawkins

COLLEGE ALGEBRA. Paul Dawkins COLLEGE ALGEBRA Paul Dawkins Table of Contents Preface... iii Outline... iv Preliminaries... Introduction... Integer Exponents... Rational Exponents... 9 Real Exponents...5 Radicals...6 Polynomials...5

More information

Polynomial Operations and Factoring

Polynomial Operations and Factoring Algebra 1, Quarter 4, Unit 4.1 Polynomial Operations and Factoring Overview Number of instructional days: 15 (1 day = 45 60 minutes) Content to be learned Identify terms, coefficients, and degree of polynomials.

More information

Vector Spaces; the Space R n

Vector Spaces; the Space R n Vector Spaces; the Space R n Vector Spaces A vector space (over the real numbers) is a set V of mathematical entities, called vectors, U, V, W, etc, in which an addition operation + is defined and in which

More information

096 Professional Readiness Examination (Mathematics)

096 Professional Readiness Examination (Mathematics) 096 Professional Readiness Examination (Mathematics) Effective after October 1, 2013 MI-SG-FLD096M-02 TABLE OF CONTENTS PART 1: General Information About the MTTC Program and Test Preparation OVERVIEW

More information

Image Compression through DCT and Huffman Coding Technique

Image Compression through DCT and Huffman Coding Technique International Journal of Current Engineering and Technology E-ISSN 2277 4106, P-ISSN 2347 5161 2015 INPRESSCO, All Rights Reserved Available at http://inpressco.com/category/ijcet Research Article Rahul

More information

Kinematical Animation. lionel.reveret@inria.fr 2013-14

Kinematical Animation. lionel.reveret@inria.fr 2013-14 Kinematical Animation 2013-14 3D animation in CG Goal : capture visual attention Motion of characters Believable Expressive Realism? Controllability Limits of purely physical simulation : - little interactivity

More information

ECE 842 Report Implementation of Elliptic Curve Cryptography

ECE 842 Report Implementation of Elliptic Curve Cryptography ECE 842 Report Implementation of Elliptic Curve Cryptography Wei-Yang Lin December 15, 2004 Abstract The aim of this report is to illustrate the issues in implementing a practical elliptic curve cryptographic

More information

We shall turn our attention to solving linear systems of equations. Ax = b

We shall turn our attention to solving linear systems of equations. Ax = b 59 Linear Algebra We shall turn our attention to solving linear systems of equations Ax = b where A R m n, x R n, and b R m. We already saw examples of methods that required the solution of a linear system

More information

PATTERN RECOGNITION AND MACHINE LEARNING CHAPTER 4: LINEAR MODELS FOR CLASSIFICATION

PATTERN RECOGNITION AND MACHINE LEARNING CHAPTER 4: LINEAR MODELS FOR CLASSIFICATION PATTERN RECOGNITION AND MACHINE LEARNING CHAPTER 4: LINEAR MODELS FOR CLASSIFICATION Introduction In the previous chapter, we explored a class of regression models having particularly simple analytical

More information

Data Storage 3.1. Foundations of Computer Science Cengage Learning

Data Storage 3.1. Foundations of Computer Science Cengage Learning 3 Data Storage 3.1 Foundations of Computer Science Cengage Learning Objectives After studying this chapter, the student should be able to: List five different data types used in a computer. Describe how

More information

Clovis Community College Core Competencies Assessment 2014 2015 Area II: Mathematics Algebra

Clovis Community College Core Competencies Assessment 2014 2015 Area II: Mathematics Algebra Core Assessment 2014 2015 Area II: Mathematics Algebra Class: Math 110 College Algebra Faculty: Erin Akhtar (Learning Outcomes Being Measured) 1. Students will construct and analyze graphs and/or data

More information

Recursive Algorithms. Recursion. Motivating Example Factorial Recall the factorial function. { 1 if n = 1 n! = n (n 1)! if n > 1

Recursive Algorithms. Recursion. Motivating Example Factorial Recall the factorial function. { 1 if n = 1 n! = n (n 1)! if n > 1 Recursion Slides by Christopher M Bourke Instructor: Berthe Y Choueiry Fall 007 Computer Science & Engineering 35 Introduction to Discrete Mathematics Sections 71-7 of Rosen cse35@cseunledu Recursive Algorithms

More information

Introduction to time series analysis

Introduction to time series analysis Introduction to time series analysis Margherita Gerolimetto November 3, 2010 1 What is a time series? A time series is a collection of observations ordered following a parameter that for us is time. Examples

More information

RELEASED. Student Booklet. Precalculus. Fall 2014 NC Final Exam. Released Items

RELEASED. Student Booklet. Precalculus. Fall 2014 NC Final Exam. Released Items Released Items Public Schools of North arolina State oard of Education epartment of Public Instruction Raleigh, North arolina 27699-6314 Fall 2014 N Final Exam Precalculus Student ooklet opyright 2014

More information

Mathematics Review for MS Finance Students

Mathematics Review for MS Finance Students Mathematics Review for MS Finance Students Anthony M. Marino Department of Finance and Business Economics Marshall School of Business Lecture 1: Introductory Material Sets The Real Number System Functions,

More information

MATH 4330/5330, Fourier Analysis Section 11, The Discrete Fourier Transform

MATH 4330/5330, Fourier Analysis Section 11, The Discrete Fourier Transform MATH 433/533, Fourier Analysis Section 11, The Discrete Fourier Transform Now, instead of considering functions defined on a continuous domain, like the interval [, 1) or the whole real line R, we wish

More information

Figure 1: Relation between codec, data containers and compression algorithms.

Figure 1: Relation between codec, data containers and compression algorithms. Video Compression Djordje Mitrovic University of Edinburgh This document deals with the issues of video compression. The algorithm, which is used by the MPEG standards, will be elucidated upon in order

More information