A VOLUME-BASED METHOD FOR DENOISING ON CURVED SURFACES

Size: px
Start display at page:

Download "A VOLUME-BASED METHOD FOR DENOISING ON CURVED SURFACES"

Transcription

1 A VOLUME-BASED METHOD FOR DENOISING ON CURVED SURFACES Harry Biddle Double Negative Visual Effects London, UK Ingrid von Glen, Colin B. Macdonald, Tomas März Matematical Institute University of Oxford Oxford, UK vonglen macdonald ABSTRACT We demonstrate a metod for removing noise from images or oter data on curved surfaces. Our approac relies on in-surface diffusion: we formulate bot te Gaussian diffusion and Perona Malik edge-preserving diffusion equations in a surface-intrinsic way. Using te Closest Point Metod, a recent tecnique for solving partial differential equations (PDEs) on general surfaces, we obtain a very simple algoritm were we merely alternate a time step of te usual Gaussian diffusion (and similarly Perona Malik) in a small 3D volume containing te surface wit an interpolation step. Te metod uses a closest point function to represent te underlying surface and can treat very general surfaces. Experimental results include image filtering on smoot surfaces, open surfaces, and general triangulated surfaces. Index Terms Image denoising, Surfaces, Partial differential equations, Numerical analysis. 1. INTRODUCTION Denoising is an important tool in image processing and often forms a crucial step in image acquisition and image analysis. On general curved surfaces, denoising and te corresponding scale space analysis of images, as well as oter image processing tasks ave seen some interest [1]. For example, Kimmel [2] studies an intrinsic scale space for images on parametrically-defined surfaces via te geodesic curvature flow. More recently, Spira and Kimmel [3] use te same flow for segmentation of images painted on parametrically-defined manifolds. Bogdanova et al. [4] perform scale space analysis as well as segmentation for omnidirectional images defined on various sapes. Our aim ere is to provide simple numerical realizations of te Gaussian diffusion filter and te nonlinear Perona Malik [5, 6, 7] edgepreserving diffusion filter for images on general surfaces. Fig. 1 sows an example comparing te two approaces. In applications, image processing on curved surfaces can occur even wen data is acquired in tree-dimensional volumes. For example, Lin and Seales [8] propose CT scanning of scrolls in order to non-destructively read text written on rolled up documents. In digital image-based elasto-tomograpy (DIET), a new metodology for non-invasive breast cancer screening, te surface and te surface data are measured from strobed ligting wit several calibrated digital cameras [9]. In suc applications, it may be useful to perform denoising and oter tecniques on surfaces embedded in tree-dimensional volumes. Denoising on surfaces is also related to Te work of all autors was partially supported by Award No KUK- C made by King Abdulla University of Science and Tecnology (KAUST). (a) (b) (c) Fig. 1. Denoising on te surface of a fis using our algoritm. Te original noisy surface data is sown in (a), Gaussian diffusion gives (b) wit blurry edges wereas (c) sows tat Perona Malik diffusion removes te noise wile maintaining sarp edges. surface fairing if te surface data is a eigt-field wic gives a perturbed surface of interest as a function on a reference surface [10]. In tis context te Perona-Malik model and variations of it ave already been considered in te literature [10, 11, 12]. A common teme in many tecniques (e.g., [2, 3, 4] above) is te use of models based on partial differential equations (PDEs). Applying PDE-based models on surfaces requires some representation of te geometry and tis coice is significant in te complexity of te resulting algoritm. A common coice is a parameterization of te surface; owever tis introduces artificial distortions and singularities into te model, even for te simplest surfaces suc as speres. On more complex geometry, joining up small patces is typically required. On a triangulated surface, PDEs can be discretized using finite element metods, e.g., [13]. Alternatively, implicit representations suc as level sets (e.g., [14]) or te closest point representation employed ere can be used. Tese tend to be flexible wit respect to te geometry altoug level sets do not give an obvious way to treat open surfaces. Using level set metods in a 3D neigbourood of te surface also requires introducing artificial boundary conditions at te boundary of te computational band. In tis work we use te Closest Point Metod [15] for solving bot te Gaussian and Perona Malik diffusion models on surfaces. Using tis tecnique, we keep te resulting evolution as simple as possible by alternating between two straigtforward steps: 1. A time step of te model in tree dimensions using entirely standard finite difference metods. 2. An interpolation step, wic encodes surface geometry and makes te 3D calculation consistent wit te surface problem. One benefit is tat te Closest Point Metod uses a closest point function [15, 16] to represent te surface, and terefore does not require modification of te model via a parameterization nor does

2 (a) (b) (c) Fig. 2. Our computational tecnique, illustrated ere in two dimensions, is based on a volume representation of a surface (a) were eac grid point (voxel) knows te closest point on te surface. On a uniform grid of points surrounding te surface, we ten alternate between two steps: (b) evolving te Perona Malik equation using a finite difference stencil at eac grid point; and (c) replacing te value at eac grid point wit te value at its closest point, using bi-cubic interpolation. it require te surface to be closed or orientable. Te Closest Point Metod as already been used successfully in PDE-based image segmentation [17] and PDE-based visual effects [18]. In 2, we demonstrate te Closest Point Metod by applying it to te standard diffusion equation. Tis gives a metod for Gaussian filtering on surfaces. 3 reviews te Perona Malik model for edge-preserving diffusion and adapts it to te Closest Point Metod. Tis is followed by numerical experiments in SOLVING DIFFERENTIAL EQUATIONS ON SURFACES We begin by demonstrating our approac on te Gaussian diffusion equation using te Closest Point Metod [15]. Tis flow does indeed remove noise from te image but it also results in considerable blurring of edges. In order to preserve edges we extend te approac to te nonlinear Perona Malik model in 3. Te tecnique presented ere is more general tan eiter equation and can be applied to a wide variety of surface differential equations Surface functions and images Suppose we ave a surface function u 0 : S R wic takes eac point on te surface S and returns a real number. We will tink of tis function as representing image data on te surface were te values of u 0 encode intensity (for colour images, we could replace u 0 wit a vector function u 0 : S R 3 ). We can blur suc a surface image by solving te surface PDE t = Su, (1) for a finite time from initial conditions consisting of our image u 0. Here S is te Laplace Beltrami operator, te surface intrinsic analogue of te Laplacian diffusion operator. We solve (1) by embedding te surface in a iger dimensional space (typically a treedimensional volume) Representing te surface We represent te surface S using a closest point representation: eac point x R 3 is associated wit its geometrically closest point on te surface cp(x) S. Fig. 2a sows a closest point representation of a curve (an example of a one-dimensional surface embedded in two dimensions). Using tis representation, we can extend values of a surface function u into te surrounding volume by defining v : R 3 R by v(x) := u(cp(x)). (2) Notably, v will be constant in te direction normal to te surface. Tis feature is crucial because it implies tat an application of a Cartesian differential operator (suc as te gradient or Laplacian) to v is equivalent to applying te corresponding intrinsic surface differential operator to u. Tese matematical principles are establised in [15, 16] Te Closest Point Metod We want to solve te tree-dimensional diffusion equation v t = v subject to te constraint tat v(x) = v(cp(x)) (i.e., tat v remains constant in te normal direction). One simple approac to solving tis constrained problem is to discretize in time and alternate between advancing te tree-dimensional PDE in time and reextending te results [15]. Using te forward Euler time-stepping algoritm wit step size τ, tis gives te following two-step process ṽ n+1 := v n + τ v n = v n + τ ( v n xx + v n yy + v n zz), (3a) v n+1 := ṽ n+1 (cp(x)). (3b) Note tat te temporary ṽ n+1 contains te result of a forward Euler step using te Cartesian Laplacian, but tis migt not be constant in te normal direction, so we re-extend to obtain v n+1. For additional accuracy, tis can easily be extended to igerorder Runge Kutta or multistep metods [15]. Implicit metods are also practical [19, 20] and useful if te problem is stiff Te role of voxels We discretize te tree-dimensional embedding volume, typically wit a uniform Cartesian grid as tis makes te algoritm straigtforward to implement and analyze. We will tink of tis treedimensional voxel grid as our discrete image wit te voxel size parameter specifying scale. Tis could be appropriate if te surface and image data were acquired in tree dimensions using e.g., CT scans [8]. In tat case, te grid parameter could be naturally cosen by te resolution of te CT macine. In oter cases, may simply be a numerical parameter. Acquiring closest point representations is a researc area in its infancy and for now we assume suc a representation is given. However, it is straigtforward to convert triangulations into tis formation [21] or to perform steepest descent on level-set representations [16] Interpolation Because we are working on a discrete grid, cp(x) is likely not a grid point and tus we need a way to approximate te extension operation of (3b). One approac is to use interpolation on a stencil consisting of te surrounding grid points nearby cp(x) [15]. We use a standard tri-cubic interpolant wic gives good accuracy and stability; a scematic of te extension is sown in Fig. 2c. Te numerical properties of te Closest Point Metod are fairly well-understood [15, 16, 19, 20, 22] and igly accurate computations ave been done up to fift-order accuracy [21]. In some cases, stability analysis as also been performed [22, 23]. Te operations can also be accelerated using a multigrid strategy [23] altoug we do not do so ere.

3 2.6. Banding We ave described te algoritm as taking place on te voxel grid of a full cube. Tis will work fine in practice but many of te grid points are not required and tus te code can be made more efficient by working on a narrow band of points surrounding te surface. For any particular discretization, te minimum bandwidt is easily computed as a small multiple of and using a wider band will ave no effect on te solution. Notably, no artificial boundary condition need be imposed at te edges of te band [15]. 3. PERONA MALIK DENOISING Te Perona Malik equation [5, 6] is a classic modification of Gaussian diffusion tat employs edge preservation by varying te diffusion coefficient across te image, penalising it at edges and structures tat sould be preserved in te image. Te equation in its general form is t = div ( g( u ) u ), (4) were te image is defined on a finite rectangle Ω R 2 via a function u : R 2 R tat describes te pixel intensity at any given point, for example were one is wite and zero is black. If te diffusion coefficient g : R R is taken to be a constant, we recover te Gaussian diffusion equation. Instead, we take te popular coice 1 g(s) =. (5) 1 + s2 λ 2 Edges are detected via te gradient: a large gradient u λ means tat we are close to an edge and te diffusion almost stops, since g 0. A small gradient u λ means tat we are away from edges, ence we filter (locally) wit Gaussian diffusion, since g 1. Here λ is a tunable parameter tat controls te sensitivity of te sceme to visual edges; it gives a tresold to separate noise from edges Perona Malik on surfaces To formulate Perona Malik diffusion on a surface S, we simply replace operators wit in-surface operators: t = divs ( g( Su ) Su ). (6) Te original noisy surface image is te initial condition u 0 : S R. We solve tis equation for t [0, t final], were te final time is a second parameter wic controls te amount of denoising Numerical discretization We start wit te tree-dimensional Cartesian form of (4) v t = x y [ ( ) ] g vx 2 + vy 2 + vz 2 v x + ] [g(...) v y + ] [g(...) v z, z and discretize wit a textbook-standard finite difference sceme for parabolic equations. Combined wit forward Euler, te timeevolution in 3D is tus given by ṽ n+1 ijk = v n ijk + τ [ g n i+1/2,j,k D+v x ijk n g n i 1/2,j,k D v x ijk n + g n i,j+1/2,k D y + vn ijk g n i,j 1/2,k D y vn ijk + g n i,j,k+1/2 D+v z ijk n g n i,j,k 1/2 D v z ijk n ]. (7a) Here D α + and D α indicate forward and backward finite differences, in te direction indicated by te superscript α, on a grid spacing of. Te expressions involving g between grid points are calculated as te average of te values at te two neigbouring grid points, e.g., g n i+1/2,j,k = 1 2 (gn i+1,j,k + g n ijk), g n i 1/2,j,k = 1 2 (gn i 1,j,k + g n ijk), (7b) were te nodal gijk n are computed using central finite differences Dc α applied to g( u ) ) gijk n = g ( (D c x v nijk )2 + (Dc y v nijk )2 + (Dc z v nijk )2. (7c) As in (3), after advancing te solution in time using te above sceme, we perform a re-extension of te surface values v n+1 ijk = ṽ n+1 (cp(x ijk )), (8) were ṽ n+1 (cp(x ijk )) is approximated wit tri-cubic interpolation on te surrounding grid points (see Fig. 2c). Te numerical sceme (7) uses a stencil sown in Fig. 2b. Te extension (8) uses te tri-cubic interpolation stencil sown in Fig. 2c. To determine te minimal computational band 2.6, we must be able to apply former stencil at eac point in te latter [15]. In 3D, tis results in a band wit a widt of 4.9. We note tat te computational band scales wit te area of te surface and not wit te volume of te embedding space. In practical computations, we find tis band contains less tan 10% of te (teoretical) voxels of te bounding box of te surface (and te difference is even more significant in igly-resolved calculations). For a cosen number of time-steps, te running time scales linearly wit te number of voxels in te computational band. 4. RESULTS Te results of our algoritm are demonstrated in Fig. 1, wic sows denoising on te surface of a triangulated fis [24]. Gaussian diffusion blurs te image, wile Perona Malik diffusion removes noise wile preserving sarp edges. Our implementation uses MATLAB. Parameters used were = 0.002, λ = 5, and 100 time steps of size τ = = Te fis is about 1 unit long. Te computational band consists of voxels surrounding te fis. Eac of te 100 time-steps takes about 1 second on an Intel Core i7 CPU running at 3.20 GHz. Our surface images ave a range of [0, 1]. In our experiments, we apply additive noise in te embedding volume, normally distributed wit amplitude 0.3, mean 0 and standard deviation 1. However, Perona Malik is not limited to tis noise model. Fig. 3 sows an example of computing on te surface of a globe. In Fig. 3c we sow tat our approac results in a uniform application of denoising over te surface. We also demonstrate tat if one first maps te surface image data onto a plane (easy enoug ere wit a spere but quite ard in general), and naively applies te standard

4 (a) (b) (c) Fig. 3. Denoising on a unit globe. (a) Original noisy surface data. In (b) te data was projected to a 2D image were Perona Malik denoising was performed. We note artifacts near te pole, wile (c) sows Perona Malik diffusion on te surface using our approac gives a uniform treatment all over te surface. We use = 0.01, λ = 5 and 100 time steps of size τ = Te computational band consists of voxels surrounding te surface. Eac time step takes about 0.4 seconds. (a) (b) Fig. 5. Perona Malik denoising of an image texture-mapped onto an open fisbowl of unit radius. (a) Noise added in te embedding volume. (b) Denoised image, using = 0.007, λ = 5, and 109 time steps of τ Te computational band consists of voxels and eac time step takes about 0.6 seconds. (Potograp by te first autor.) 1.2 total average area 1 area 2 area 3 average intensity timesteps Fig. 4. Te average grey level over te image is preserved using Perona Malik denoising. Te average grey level over te small regions sown is also preserved. planar Perona Malik, distortions from te parameterization appear in te image. In particular, if te noise is added in te 3D embedded volume, ten projection onto a 2D plane can easily distort te noise so muc as to make denoising wit te (standard) planar Perona Malik impractical (see Fig. 3b). Altoug tis approac can be ameliorated by a significant modification of te PDE (involving te metric tensor and artificial boundary conditions), tis must be done for eac surface. Tis contrasts wit our approac were te standard 3D Perona Malik PDE is applied independent of te specific geometry. Te average intensity of te entire surface image sould be constant (as can be seen from te divergence teorem on (6)). Fig. 4 sows tis is te case using our algoritm. Additionally, in cartoonlike images, we can expect te average intensity in certain smaller subregions to be invariant. Fig. 4 also sows tis form of contrast preservation. Fig. 5 sows anoter example were an image as been texture mapped onto a curved surface. Te denoising algoritm is performed in te embedding volume. Te surface in tis case is open, wic is easily andled by our algoritm a omogeneous Neumann condition is automatically applied by te re-extension [15]. 5. SUMMARY AND CONCLUSIONS In tis paper, we describe a numerical realization of nonlinear diffusion filters for images on general surfaces. We obtain our filters by combining te in-surface PDE models of Gaussian or Perona Malik edge-preserving diffusion wit te Closest Point Metod. Te re- sulting filter is simple: it alternates a time step of te corresponding diffusion PDE in a 3D volume surrounding te surface wit a reextension step. In tis approac we use te closest point function to represent te surface. Notably, only te re-extension step evaluates te closest point function, and te PDE need not be transformed as in oter approaces to surface PDEs. Te fully discrete algoritm uses standard finite difference tecniques on a voxel grid to approximate te diffusion operators and tri-cubic interpolation to do te re-extension. Our experiments demonstrate tat te filter works well and tat we can andle complex geometries. Here we ave considered Gaussian and Perona Malik diffusion on surfaces but te Closest Point Metod is not limited to tese two models. Indeed, te Closest Point Metod applies generally to surface PDEs and could be useful in oter surface image processing tasks. Applications oter tan denoising include deblurring and inpainting and are part of ongoing researc. 6. REFERENCES [1] R.-J. Lai and T.F. Can, A framework for intrinsic image processing on surfaces, Comput. Vis. Image Und., vol. 115, no. 12, pp , [2] R. Kimmel, Intrinsic scale space for images on surfaces: Te geodesic curvature flow, in Grapical Models and Image Processing. 1997, Springer-Verlag. [3] A. Spira and R. Kimmel, Geometric curve flows on parametric manifolds, J. Comput. Pys., vol. 223, [4] I. Bogdanova, X. Bresson, J.-P. Tiran, and P. Vandergeynst, Scale-space analysis and active contours for omnidirectional images, IEEE Trans. Image Process., vol. 16, no. 7, [5] P. Perona and J. Malik, Scale-space and edge detection using anisotropic diffusion, in Proceedings of IEEE Computer Society Worksop on Computer Vision, [6] P. Perona and J. Malik, Scale-space and edge detection using anisotropic diffusion, IEEE Trans. on Pattern Analysis and Macine Intelligence, vol. 12, [7] J. Weickert, Anisotropic Diffusion in Image Processing, B.G. Teubner Stuttgart, 1998.

5 [8] Y. Lin and W.B. Seales, Opaque document imaging: Building images of inaccessible texts, in Proc. ICCV 05, 10t IEEE International Conference on Computer Vision vol. 1, [9] R.G. Brown, C.E. Hann, and J.G. Case, Vision-based 3D surface motion capture for te DIET breast cancer screening system, Int. J. Comput. Appl. T., vol. 39, no. 1, pp , [10] M. Desbrun, M. Meyer, P. Scröder, and A.H. Barr, Anisotropic feature-preserving denoising of eigt fields and bivariate data, in Grapics Interface, 2000, pp [11] U. Clarenz, U. Diewald, and M. Rumpf, Processing textured surfaces via anisotropic geometric diffusion, IEEE Trans. Image Process., vol. 13, no. 2, pp , [12] C.L. Bajaj and G. Xu, Anisotropic diffusion of surfaces and functions on surfaces, ACM Trans. Grapic., vol. 22, no. 1, pp. 4 32, [13] G. Dziuk and C.M. Elliott, Surface finite elements for parabolic equations, J. Comp. Mat., vol. 25, no. 4, [14] M. Bertalmìo, L.-T. Ceng, S. Oser, and G. Sapiro, Variational problems and partial differential equations on implicit surfaces, J. Comp. Pys., vol. 174, no. 2, [15] S.J. Ruut and B. Merriman, A simple embedding metod for solving partial differential equations on surfaces, J. Comput. Pys., vol. 227, no. 3, [16] T. März and C.B. Macdonald, Calculus on surfaces wit general closest point functions, SIAM J. Numer. Anal., vol. 50, no. 6, [17] L. Tian, C.B. Macdonald, and S.J. Ruut, Segmentation on surfaces wit te Closest Point Metod, in Proc. ICIP09, 16t IEEE International Conference on Image Processing, [18] S. Auer, C.B. Macdonald, M. Treib, J. Scneider, and R. Westermann, Real-time fluid effects on surfaces using te Closest Point Metod, Comput. Grap. Forum, vol. 31, no. 6, [19] C.B. Macdonald and S.J. Ruut, Te implicit Closest Point Metod for te numerical solution of partial differential equations on surfaces, SIAM J. Sci. Comput., vol. 31, no. 6, [20] I. von Glen, T. März, and C.B. Macdonald, An embedded metod-of-lines approac to solving PDEs on surfaces, submitted, [21] C.B. Macdonald and S.J. Ruut, Level set equations on surfaces via te Closest Point Metod, J. Sci. Comput., vol. 35, no. 2 3, [22] T. März and C.B. Macdonald, Consistency and stability of closest point iterations, in prep., [23] Y.-J. Cen and C.B. Macdonald, Te Closest Point Metod and multigrid solvers for elliptic equations on surfaces, submitted, [24] M. Attene and C. Pizzi, Fis, in te AIM@SHAPE repository ttp://sapes.aimatsape.net/view.pp? id=262, 2005.

Vector Processing Contours

Vector Processing Contours Vector Processing Contours Andrey Kirsanov Department of Automation and Control Processes MAMI Moscow State Tecnical University Moscow, Russia AndKirsanov@yandex.ru A.Vavilin and K-H. Jo Department of

More information

Numerical Derivatives

Numerical Derivatives Lab 15 Numerical Derivatives Lab Objective: Understand and implement finite difference approximations of te derivative in single and multiple dimensions. Evaluate te accuracy of tese approximations. Ten

More information

Two Modifications of Weight Calculation of the Non-Local Means Denoising Method

Two Modifications of Weight Calculation of the Non-Local Means Denoising Method Engineering, 2013, 5, 522-526 ttp://dx.doi.org/10.4236/eng.2013.510b107 Publised Online October 2013 (ttp://www.scirp.org/journal/eng) Two Modifications of Weigt Calculation of te Non-Local Means Denoising

More information

Fast Calculation of Thermodynamic Properties of Water and Steam in Process Modelling using Spline Interpolation

Fast Calculation of Thermodynamic Properties of Water and Steam in Process Modelling using Spline Interpolation P R E P R N T CPWS XV Berlin, September 8, 008 Fast Calculation of Termodynamic Properties of Water and Steam in Process Modelling using Spline nterpolation Mattias Kunick a, Hans-Joacim Kretzscmar a,

More information

Piecewise Polynomial Interpolation, cont d

Piecewise Polynomial Interpolation, cont d Jim Lambers MAT 460/560 Fall Semester 2009-0 Lecture 2 Notes Tese notes correspond to Section 4 in te text Piecewise Polynomial Interpolation, cont d Constructing Cubic Splines, cont d Having determined

More information

Implementation of Integral based Digital Curvature Estimators in DGtal

Implementation of Integral based Digital Curvature Estimators in DGtal Implementation of Integral based Digital Curvature Estimators in DGtal David Coeurjolly 1, Jacques-Olivier Lacaud 2, Jérémy Levallois 1,2 1 Université de Lyon, CNRS INSA-Lyon, LIRIS, UMR5205, F-69621,

More information

Mean Shifting Gradient Vector Flow: An Improved External Force Field for Active Surfaces in Widefield Microscopy.

Mean Shifting Gradient Vector Flow: An Improved External Force Field for Active Surfaces in Widefield Microscopy. Mean Sifting Gradient Vector Flow: An Improved External Force Field for Active Surfaces in Widefield Microscopy. Margret Keuper Cair of Pattern Recognition and Image Processing Computer Science Department

More information

Computing geodesic paths on manifolds

Computing geodesic paths on manifolds Proc. Natl. Acad. Sci. USA Vol. 95, pp. 8431 8435, July 1998 Applied Matematics Computing geodesic pats on manifolds R. Kimmel* and J. A. Setian Department of Matematics and Lawrence Berkeley National

More information

3.6 Directional Derivatives and the Gradient Vector

3.6 Directional Derivatives and the Gradient Vector 288 CHAPTER 3. FUNCTIONS OF SEVERAL VARIABLES 3.6 Directional Derivatives and te Gradient Vector 3.6.1 Functions of two Variables Directional Derivatives Let us first quickly review, one more time, te

More information

PYRAMID FILTERS BASED ON BILINEAR INTERPOLATION

PYRAMID FILTERS BASED ON BILINEAR INTERPOLATION PYRAMID FILTERS BASED ON BILINEAR INTERPOLATION Martin Kraus Computer Grapics and Visualization Group, Tecnisce Universität Müncen, Germany krausma@in.tum.de Magnus Strengert Visualization and Interactive

More information

Linear Interpolating Splines

Linear Interpolating Splines Jim Lambers MAT 772 Fall Semester 2010-11 Lecture 17 Notes Tese notes correspond to Sections 112, 11, and 114 in te text Linear Interpolating Splines We ave seen tat ig-degree polynomial interpolation

More information

UUV DEPTH MEASUREMENT USING CAMERA IMAGES

UUV DEPTH MEASUREMENT USING CAMERA IMAGES ABCM Symposium Series in Mecatronics - Vol. 3 - pp.292-299 Copyrigt c 2008 by ABCM UUV DEPTH MEASUREMENT USING CAMERA IMAGES Rogerio Yugo Takimoto Graduate Scool of Engineering Yokoama National University

More information

MAPI Computer Vision

MAPI Computer Vision MAPI Computer Vision Multiple View Geometry In tis module we intend to present several tecniques in te domain of te 3D vision Manuel Joao University of Mino Dep Industrial Electronics - Applications -

More information

All truths are easy to understand once they are discovered; the point is to discover them. Galileo

All truths are easy to understand once they are discovered; the point is to discover them. Galileo Section 7. olume All truts are easy to understand once tey are discovered; te point is to discover tem. Galileo Te main topic of tis section is volume. You will specifically look at ow to find te volume

More information

Investigating an automated method for the sensitivity analysis of functions

Investigating an automated method for the sensitivity analysis of functions Investigating an automated metod for te sensitivity analysis of functions Sibel EKER s.eker@student.tudelft.nl Jill SLINGER j..slinger@tudelft.nl Delft University of Tecnology 2628 BX, Delft, te Neterlands

More information

A Practical Approach of Selecting the Edge Detector Parameters to Achieve a Good Edge Map of the Gray Image

A Practical Approach of Selecting the Edge Detector Parameters to Achieve a Good Edge Map of the Gray Image Journal of Computer Science 5 (5): 355-362, 2009 ISSN 1549-3636 2009 Science Publications A Practical Approac of Selecting te Edge Detector Parameters to Acieve a Good Edge Map of te Gray Image 1 Akram

More information

Alternating Direction Implicit Methods for FDTD Using the Dey-Mittra Embedded Boundary Method

Alternating Direction Implicit Methods for FDTD Using the Dey-Mittra Embedded Boundary Method Te Open Plasma Pysics Journal, 2010, 3, 29-35 29 Open Access Alternating Direction Implicit Metods for FDTD Using te Dey-Mittra Embedded Boundary Metod T.M. Austin *, J.R. Cary, D.N. Smite C. Nieter Tec-X

More information

Our Calibrated Model has No Predictive Value: An Example from the Petroleum Industry

Our Calibrated Model has No Predictive Value: An Example from the Petroleum Industry Our Calibrated Model as No Predictive Value: An Example from te Petroleum Industry J.N. Carter a, P.J. Ballester a, Z. Tavassoli a and P.R. King a a Department of Eart Sciences and Engineering, Imperial

More information

13.5 DIRECTIONAL DERIVATIVES and the GRADIENT VECTOR

13.5 DIRECTIONAL DERIVATIVES and the GRADIENT VECTOR 13.5 Directional Derivatives and te Gradient Vector Contemporary Calculus 1 13.5 DIRECTIONAL DERIVATIVES and te GRADIENT VECTOR Directional Derivatives In Section 13.3 te partial derivatives f x and f

More information

MATH 5a Spring 2018 READING ASSIGNMENTS FOR CHAPTER 2

MATH 5a Spring 2018 READING ASSIGNMENTS FOR CHAPTER 2 MATH 5a Spring 2018 READING ASSIGNMENTS FOR CHAPTER 2 Note: Tere will be a very sort online reading quiz (WebWork) on eac reading assignment due one our before class on its due date. Due dates can be found

More information

ANTENNA SPHERICAL COORDINATE SYSTEMS AND THEIR APPLICATION IN COMBINING RESULTS FROM DIFFERENT ANTENNA ORIENTATIONS

ANTENNA SPHERICAL COORDINATE SYSTEMS AND THEIR APPLICATION IN COMBINING RESULTS FROM DIFFERENT ANTENNA ORIENTATIONS NTNN SPHRICL COORDINT SSTMS ND THIR PPLICTION IN COMBINING RSULTS FROM DIFFRNT NTNN ORINTTIONS llen C. Newell, Greg Hindman Nearfield Systems Incorporated 133. 223 rd St. Bldg. 524 Carson, C 9745 US BSTRCT

More information

Density Estimation Over Data Stream

Density Estimation Over Data Stream Density Estimation Over Data Stream Aoying Zou Dept. of Computer Science, Fudan University 22 Handan Rd. Sangai, 2433, P.R. Cina ayzou@fudan.edu.cn Ziyuan Cai Dept. of Computer Science, Fudan University

More information

Non-Interferometric Testing

Non-Interferometric Testing NonInterferometric Testing.nb Optics 513 - James C. Wyant 1 Non-Interferometric Testing Introduction In tese notes four non-interferometric tests are described: (1) te Sack-Hartmann test, (2) te Foucault

More information

Grid Adaptation for Functional Outputs: Application to Two-Dimensional Inviscid Flows

Grid Adaptation for Functional Outputs: Application to Two-Dimensional Inviscid Flows Journal of Computational Pysics 176, 40 69 (2002) doi:10.1006/jcp.2001.6967, available online at ttp://www.idealibrary.com on Grid Adaptation for Functional Outputs: Application to Two-Dimensional Inviscid

More information

The Euler and trapezoidal stencils to solve d d x y x = f x, y x

The Euler and trapezoidal stencils to solve d d x y x = f x, y x restart; Te Euler and trapezoidal stencils to solve d d x y x = y x Te purpose of tis workseet is to derive te tree simplest numerical stencils to solve te first order d equation y x d x = y x, and study

More information

Excel based finite difference modeling of ground water flow

Excel based finite difference modeling of ground water flow Journal of Himalaan Eart Sciences 39(006) 49-53 Ecel based finite difference modeling of ground water flow M. Gulraiz Akter 1, Zulfiqar Amad 1 and Kalid Amin Kan 1 Department of Eart Sciences, Quaid-i-Azam

More information

Multi-Stack Boundary Labeling Problems

Multi-Stack Boundary Labeling Problems Multi-Stack Boundary Labeling Problems Micael A. Bekos 1, Micael Kaufmann 2, Katerina Potika 1 Antonios Symvonis 1 1 National Tecnical University of Atens, Scool of Applied Matematical & Pysical Sciences,

More information

Image Registration via Particle Movement

Image Registration via Particle Movement Image Registration via Particle Movement Zao Yi and Justin Wan Abstract Toug fluid model offers a good approac to nonrigid registration wit large deformations, it suffers from te blurring artifacts introduced

More information

Proceedings of the 8th WSEAS International Conference on Neural Networks, Vancouver, British Columbia, Canada, June 19-21,

Proceedings of the 8th WSEAS International Conference on Neural Networks, Vancouver, British Columbia, Canada, June 19-21, Proceedings of te 8t WSEAS International Conference on Neural Networks, Vancouver, Britis Columbia, Canada, June 9-2, 2007 3 Neural Network Structures wit Constant Weigts to Implement Dis-Jointly Removed

More information

The (, D) and (, N) problems in double-step digraphs with unilateral distance

The (, D) and (, N) problems in double-step digraphs with unilateral distance Electronic Journal of Grap Teory and Applications () (), Te (, D) and (, N) problems in double-step digraps wit unilateral distance C Dalfó, MA Fiol Departament de Matemàtica Aplicada IV Universitat Politècnica

More information

Symmetric Tree Replication Protocol for Efficient Distributed Storage System*

Symmetric Tree Replication Protocol for Efficient Distributed Storage System* ymmetric Tree Replication Protocol for Efficient Distributed torage ystem* ung Cune Coi 1, Hee Yong Youn 1, and Joong up Coi 2 1 cool of Information and Communications Engineering ungkyunkwan University

More information

Edge-Preserving Denoising for Segmentation in CT-Images

Edge-Preserving Denoising for Segmentation in CT-Images Edge-Preserving Denoising for Segmentation in CT-Images Eva Eibenberger, Anja Borsdorf, Andreas Wimmer, Joachim Hornegger Lehrstuhl für Mustererkennung, Friedrich-Alexander-Universität Erlangen-Nürnberg

More information

Cubic smoothing spline

Cubic smoothing spline Cubic smooting spline Menu: QCExpert Regression Cubic spline e module Cubic Spline is used to fit any functional regression curve troug data wit one independent variable x and one dependent random variable

More information

Section 1.2 The Slope of a Tangent

Section 1.2 The Slope of a Tangent Section 1.2 Te Slope of a Tangent You are familiar wit te concept of a tangent to a curve. Wat geometric interpretation can be given to a tangent to te grap of a function at a point? A tangent is te straigt

More information

An Intuitive Framework for Real-Time Freeform Modeling

An Intuitive Framework for Real-Time Freeform Modeling An Intuitive Framework for Real-Time Freeform Modeling Mario Botsc Leif Kobbelt Computer Grapics Group RWTH Aacen University Abstract We present a freeform modeling framework for unstructured triangle

More information

Lehrstuhl für Informatik 10 (Systemsimulation)

Lehrstuhl für Informatik 10 (Systemsimulation) FRIEDRICH-ALEXANDER-UNIVERSITÄT ERLANGEN-NÜRNBERG INSTITUT FÜR INFORMATIK (MATHEMATISCHE MASCHINEN UND DATENVERARBEITUNG) Lerstul für Informatik 10 (Systemsimulation) PDE based Video Compression in Real

More information

A Simple Embedding Method for Solving Partial Differential Equations on Surfaces

A Simple Embedding Method for Solving Partial Differential Equations on Surfaces A Simple Embedding Method for Solving Partial Differential Equations on Surfaces Steven J. Ruuth and Barry Merriman October 6, 2007 Abstract It is increasingly common to encounter partial differential

More information

An Interactive X-Ray Image Segmentation Technique for Bone Extraction

An Interactive X-Ray Image Segmentation Technique for Bone Extraction An Interactive X-Ray Image Segmentation Tecnique for Bone Extraction Cristina Stolojescu-Crisan and Stefan Holban Politenica University of Timisoara V. Parvan 2, 300223 Timisoara, Romania {cristina.stolojescu@etc.upt.ro

More information

Smoothing & Fairing. Mario Botsch

Smoothing & Fairing. Mario Botsch Smoothing & Fairing Mario Botsch Motivation Filter out high frequency noise Desbrun, Meyer, Schroeder, Barr: Implicit Fairing of Irregular Meshes using Diffusion and Curvature Flow, SIGGRAPH 99 2 Motivation

More information

Some Handwritten Signature Parameters in Biometric Recognition Process

Some Handwritten Signature Parameters in Biometric Recognition Process Some Handwritten Signature Parameters in Biometric Recognition Process Piotr Porwik Institute of Informatics, Silesian Uniersity, Bdziska 39, 41- Sosnowiec, Poland porwik@us.edu.pl Tomasz Para Institute

More information

12.2 TECHNIQUES FOR EVALUATING LIMITS

12.2 TECHNIQUES FOR EVALUATING LIMITS Section Tecniques for Evaluating Limits 86 TECHNIQUES FOR EVALUATING LIMITS Wat ou sould learn Use te dividing out tecnique to evaluate its of functions Use te rationalizing tecnique to evaluate its of

More information

Bounding Tree Cover Number and Positive Semidefinite Zero Forcing Number

Bounding Tree Cover Number and Positive Semidefinite Zero Forcing Number Bounding Tree Cover Number and Positive Semidefinite Zero Forcing Number Sofia Burille Mentor: Micael Natanson September 15, 2014 Abstract Given a grap, G, wit a set of vertices, v, and edges, various

More information

An Algorithm for Loopless Deflection in Photonic Packet-Switched Networks

An Algorithm for Loopless Deflection in Photonic Packet-Switched Networks An Algoritm for Loopless Deflection in Potonic Packet-Switced Networks Jason P. Jue Center for Advanced Telecommunications Systems and Services Te University of Texas at Dallas Ricardson, TX 75083-0688

More information

Software Fault Prediction using Machine Learning Algorithm Pooja Garg 1 Mr. Bhushan Dua 2

Software Fault Prediction using Machine Learning Algorithm Pooja Garg 1 Mr. Bhushan Dua 2 IJSRD - International Journal for Scientific Researc & Development Vol. 3, Issue 04, 2015 ISSN (online): 2321-0613 Software Fault Prediction using Macine Learning Algoritm Pooja Garg 1 Mr. Busan Dua 2

More information

4.2 The Derivative. f(x + h) f(x) lim

4.2 The Derivative. f(x + h) f(x) lim 4.2 Te Derivative Introduction In te previous section, it was sown tat if a function f as a nonvertical tangent line at a point (x, f(x)), ten its slope is given by te it f(x + ) f(x). (*) Tis is potentially

More information

Image denoising using TV-Stokes equation with an orientation-matching minimization

Image denoising using TV-Stokes equation with an orientation-matching minimization Image denoising using TV-Stokes equation with an orientation-matching minimization Xue-Cheng Tai 1,2, Sofia Borok 1, and Jooyoung Hahn 1 1 Division of Mathematical Sciences, School of Physical Mathematical

More information

Parallel Simulation of Equation-Based Models on CUDA-Enabled GPUs

Parallel Simulation of Equation-Based Models on CUDA-Enabled GPUs Parallel Simulation of Equation-Based Models on CUDA-Enabled GPUs Per Ostlund Department of Computer and Information Science Linkoping University SE-58183 Linkoping, Sweden per.ostlund@liu.se Kristian

More information

16th European Signal Processing Conference (EUSIPCO 2008), Lausanne, Switzerland, August 25-29, 2008, copyright by EURASIP

16th European Signal Processing Conference (EUSIPCO 2008), Lausanne, Switzerland, August 25-29, 2008, copyright by EURASIP 16t European Signal Processing Conference (EUSIPCO 008), Lausanne, Switzerland, August 5-9, 008, copyrigt by EURASIP ADAPTIVE WINDOW FOR LOCAL POLYNOMIAL REGRESSION FROM NOISY NONUNIFORM SAMPLES A. Sreenivasa

More information

Optimal In-Network Packet Aggregation Policy for Maximum Information Freshness

Optimal In-Network Packet Aggregation Policy for Maximum Information Freshness 1 Optimal In-etwork Packet Aggregation Policy for Maimum Information Fresness Alper Sinan Akyurek, Tajana Simunic Rosing Electrical and Computer Engineering, University of California, San Diego aakyurek@ucsd.edu,

More information

Classification of Osteoporosis using Fractal Texture Features

Classification of Osteoporosis using Fractal Texture Features Classification of Osteoporosis using Fractal Texture Features V.Srikant, C.Dines Kumar and A.Tobin Department of Electronics and Communication Engineering Panimalar Engineering College Cennai, Tamil Nadu,

More information

ICES REPORT Isogeometric Analysis of Boundary Integral Equations

ICES REPORT Isogeometric Analysis of Boundary Integral Equations ICES REPORT 5-2 April 205 Isogeometric Analysis of Boundary Integral Equations by Mattias Taus, Gregory J. Rodin and Tomas J. R. Huges Te Institute for Computational Engineering and Sciences Te University

More information

CESILA: Communication Circle External Square Intersection-Based WSN Localization Algorithm

CESILA: Communication Circle External Square Intersection-Based WSN Localization Algorithm Sensors & Transducers 2013 by IFSA ttp://www.sensorsportal.com CESILA: Communication Circle External Square Intersection-Based WSN Localization Algoritm Sun Hongyu, Fang Ziyi, Qu Guannan College of Computer

More information

Low-complexity Image-based 3D Gaming

Low-complexity Image-based 3D Gaming Low-complexity Image-based 3D Gaming Ingo Bauermann and Eckeard Steinbac Institute of Communication Networks, Media Tecnology Group Tecnisce Universität Müncen Munic, Germany {ingo.bauermann,eckeard.steinbac}@tum.de

More information

Chapter K. Geometric Optics. Blinn College - Physics Terry Honan

Chapter K. Geometric Optics. Blinn College - Physics Terry Honan Capter K Geometric Optics Blinn College - Pysics 2426 - Terry Honan K. - Properties of Ligt Te Speed of Ligt Te speed of ligt in a vacuum is approximately c > 3.0µ0 8 mês. Because of its most fundamental

More information

05 - Surfaces. Acknowledgements: Olga Sorkine-Hornung. CSCI-GA Geometric Modeling - Daniele Panozzo

05 - Surfaces. Acknowledgements: Olga Sorkine-Hornung. CSCI-GA Geometric Modeling - Daniele Panozzo 05 - Surfaces Acknowledgements: Olga Sorkine-Hornung Reminder Curves Turning Number Theorem Continuous world Discrete world k: Curvature is scale dependent is scale-independent Discrete Curvature Integrated

More information

An Effective Sensor Deployment Strategy by Linear Density Control in Wireless Sensor Networks Chiming Huang and Rei-Heng Cheng

An Effective Sensor Deployment Strategy by Linear Density Control in Wireless Sensor Networks Chiming Huang and Rei-Heng Cheng An ffective Sensor Deployment Strategy by Linear Density Control in Wireless Sensor Networks Ciming Huang and ei-heng Ceng 5 De c e mbe r0 International Journal of Advanced Information Tecnologies (IJAIT),

More information

Truncated Newton-based multigrid algorithm for centroidal Voronoi diagram calculation

Truncated Newton-based multigrid algorithm for centroidal Voronoi diagram calculation NUMERICAL MATHEMATICS: Teory, Metods and Applications Numer. Mat. Teor. Met. Appl., Vol. xx, No. x, pp. 1-18 (200x) Truncated Newton-based multigrid algoritm for centroidal Voronoi diagram calculation

More information

2.8 The derivative as a function

2.8 The derivative as a function CHAPTER 2. LIMITS 56 2.8 Te derivative as a function Definition. Te derivative of f(x) istefunction f (x) defined as follows f f(x + ) f(x) (x). 0 Note: tis differs from te definition in section 2.7 in

More information

4.1 Tangent Lines. y 2 y 1 = y 2 y 1

4.1 Tangent Lines. y 2 y 1 = y 2 y 1 41 Tangent Lines Introduction Recall tat te slope of a line tells us ow fast te line rises or falls Given distinct points (x 1, y 1 ) and (x 2, y 2 ), te slope of te line troug tese two points is cange

More information

2 The Derivative. 2.0 Introduction to Derivatives. Slopes of Tangent Lines: Graphically

2 The Derivative. 2.0 Introduction to Derivatives. Slopes of Tangent Lines: Graphically 2 Te Derivative Te two previous capters ave laid te foundation for te study of calculus. Tey provided a review of some material you will need and started to empasize te various ways we will view and use

More information

12.2 Techniques for Evaluating Limits

12.2 Techniques for Evaluating Limits 335_qd /4/5 :5 PM Page 863 Section Tecniques for Evaluating Limits 863 Tecniques for Evaluating Limits Wat ou sould learn Use te dividing out tecnique to evaluate its of functions Use te rationalizing

More information

Traffic Sign Classification Using Ring Partitioned Method

Traffic Sign Classification Using Ring Partitioned Method Traffic Sign Classification Using Ring Partitioned Metod Aryuanto Soetedjo and Koici Yamada Laboratory for Management and Information Systems Science, Nagaoa University of Tecnology 603- Kamitomioamaci,

More information

The navigability variable is binary either a cell is navigable or not. Thus, we can invert the entire reasoning by substituting x i for x i : (4)

The navigability variable is binary either a cell is navigable or not. Thus, we can invert the entire reasoning by substituting x i for x i : (4) A Multi-Resolution Pyramid for Outdoor Robot Terrain Perception Micael Montemerlo and Sebastian Trun AI Lab, Stanford University 353 Serra Mall Stanford, CA 94305-9010 {mmde,trun}@stanford.edu Abstract

More information

Feature-Based Steganalysis for JPEG Images and its Implications for Future Design of Steganographic Schemes

Feature-Based Steganalysis for JPEG Images and its Implications for Future Design of Steganographic Schemes Feature-Based Steganalysis for JPEG Images and its Implications for Future Design of Steganograpic Scemes Jessica Fridric Dept. of Electrical Engineering, SUNY Bingamton, Bingamton, NY 3902-6000, USA fridric@bingamton.edu

More information

Section 2.3: Calculating Limits using the Limit Laws

Section 2.3: Calculating Limits using the Limit Laws Section 2.3: Calculating Limits using te Limit Laws In previous sections, we used graps and numerics to approimate te value of a it if it eists. Te problem wit tis owever is tat it does not always give

More information

Overcomplete Steerable Pyramid Filters and Rotation Invariance

Overcomplete Steerable Pyramid Filters and Rotation Invariance vercomplete Steerable Pyramid Filters and Rotation Invariance H. Greenspan, S. Belongie R. Goodman and P. Perona S. Raksit and C. H. Anderson Department of Electrical Engineering Department of Anatomy

More information

A Cost Model for Distributed Shared Memory. Using Competitive Update. Jai-Hoon Kim Nitin H. Vaidya. Department of Computer Science

A Cost Model for Distributed Shared Memory. Using Competitive Update. Jai-Hoon Kim Nitin H. Vaidya. Department of Computer Science A Cost Model for Distributed Sared Memory Using Competitive Update Jai-Hoon Kim Nitin H. Vaidya Department of Computer Science Texas A&M University College Station, Texas, 77843-3112, USA E-mail: fjkim,vaidyag@cs.tamu.edu

More information

Haar Transform CS 430 Denbigh Starkey

Haar Transform CS 430 Denbigh Starkey Haar Transform CS Denbig Starkey. Background. Computing te transform. Restoring te original image from te transform 7. Producing te transform matrix 8 5. Using Haar for lossless compression 6. Using Haar

More information

Mean Waiting Time Analysis in Finite Storage Queues for Wireless Cellular Networks

Mean Waiting Time Analysis in Finite Storage Queues for Wireless Cellular Networks Mean Waiting Time Analysis in Finite Storage ueues for Wireless ellular Networks J. YLARINOS, S. LOUVROS, K. IOANNOU, A. IOANNOU 3 A.GARMIS 2 and S.KOTSOOULOS Wireless Telecommunication Laboratory, Department

More information

Local features and image matching May 8 th, 2018

Local features and image matching May 8 th, 2018 Local features and image matcing May 8 t, 2018 Yong Jae Lee UC Davis Last time RANSAC for robust fitting Lines, translation Image mosaics Fitting a 2D transformation Homograpy 2 Today Mosaics recap: How

More information

Minimizing Memory Access By Improving Register Usage Through High-level Transformations

Minimizing Memory Access By Improving Register Usage Through High-level Transformations Minimizing Memory Access By Improving Register Usage Troug Hig-level Transformations San Li Scool of Computer Engineering anyang Tecnological University anyang Avenue, SIGAPORE 639798 Email: p144102711@ntu.edu.sg

More information

THANK YOU FOR YOUR PURCHASE!

THANK YOU FOR YOUR PURCHASE! THANK YOU FOR YOUR PURCHASE! Te resources included in tis purcase were designed and created by me. I ope tat you find tis resource elpful in your classroom. Please feel free to contact me wit any questions

More information

, 1 1, A complex fraction is a quotient of rational expressions (including their sums) that result

, 1 1, A complex fraction is a quotient of rational expressions (including their sums) that result RT. Complex Fractions Wen working wit algebraic expressions, sometimes we come across needing to simplify expressions like tese: xx 9 xx +, xx + xx + xx, yy xx + xx + +, aa Simplifying Complex Fractions

More information

Mixed Finite Elements for Variational Surface Modeling

Mixed Finite Elements for Variational Surface Modeling Eurograpics Symposium on Geometry Processing 200 Olga Sorkine and Bruno Lévy (Guest Editors) Volume 29 (200), Number 5 Mixed Finite Elements for Variational Surface Modeling Alec Jacobson, Elif Tosun,2,

More information

Developing an Efficient Algorithm for Image Fusion Using Dual Tree- Complex Wavelet Transform

Developing an Efficient Algorithm for Image Fusion Using Dual Tree- Complex Wavelet Transform ISSN(Online): 30-980 ISSN (Print): 30-9798 (An ISO 397: 007 Certified Organization) Vol. 3, Issue 4, April 05 Developing an Efficient Algoritm for Image Fusion Using Dual Tree- Complex Wavelet Transform

More information

Asynchronous Power Flow on Graphic Processing Units

Asynchronous Power Flow on Graphic Processing Units 1 Asyncronous Power Flow on Grapic Processing Units Manuel Marin, Student Member, IEEE, David Defour, and Federico Milano, Senior Member, IEEE Abstract Asyncronous iterations can be used to implement fixed-point

More information

Comparison of the Efficiency of the Various Algorithms in Stratified Sampling when the Initial Solutions are Determined with Geometric Method

Comparison of the Efficiency of the Various Algorithms in Stratified Sampling when the Initial Solutions are Determined with Geometric Method International Journal of Statistics and Applications 0, (): -0 DOI: 0.9/j.statistics.000.0 Comparison of te Efficiency of te Various Algoritms in Stratified Sampling wen te Initial Solutions are Determined

More information

Parameterization of Meshes

Parameterization of Meshes 2-Manifold Parameterization of Meshes What makes for a smooth manifold? locally looks like Euclidian space collection of charts mutually compatible on their overlaps form an atlas Parameterizations are

More information

A Global Laplacian Smoothing Approach with Feature Preservation

A Global Laplacian Smoothing Approach with Feature Preservation A Global Laplacian Smoothing Approach with Feature Preservation hongping Ji Ligang Liu Guojin Wang Department of Mathematics State Key Lab of CAD&CG hejiang University Hangzhou, 310027 P.R. China jzpboy@yahoo.com.cn,

More information

Automated Segmentation Using a Fast Implementation of the Chan-Vese Models

Automated Segmentation Using a Fast Implementation of the Chan-Vese Models Automated Segmentation Using a Fast Implementation of the Chan-Vese Models Huan Xu, and Xiao-Feng Wang,,3 Intelligent Computation Lab, Hefei Institute of Intelligent Machines, Chinese Academy of Science,

More information

wrobot k wwrobot hrobot (a) Observation area Horopter h(θ) (Virtual) horopters h(θ+ θ lim) U r U l h(θ+ θ) Base line Left camera Optical axis

wrobot k wwrobot hrobot (a) Observation area Horopter h(θ) (Virtual) horopters h(θ+ θ lim) U r U l h(θ+ θ) Base line Left camera Optical axis Selective Acquisition of 3-D Information Enoug for Finding Passable Free Spaces Using an Active Stereo Vision System Atsusi Nisikawa, Atsusi Okubo, and Fumio Miyazaki Department of Systems and Human Science

More information

Zernike vs. Zonal Matrix Iterative Wavefront Reconstructor. Sophia I. Panagopoulou, PhD. University of Crete Medical School Dept.

Zernike vs. Zonal Matrix Iterative Wavefront Reconstructor. Sophia I. Panagopoulou, PhD. University of Crete Medical School Dept. Zernie vs. Zonal Matrix terative Wavefront Reconstructor opia. Panagopoulou PD University of Crete Medical cool Dept. of Optalmology Daniel R. Neal PD Wavefront ciences nc. 480 Central.E. Albuquerque NM

More information

An Efficient, Geometric Multigrid Solver for the Anisotropic Diffusion Equation in Two and Three Dimensions

An Efficient, Geometric Multigrid Solver for the Anisotropic Diffusion Equation in Two and Three Dimensions 1 n Efficient, Geometric Multigrid Solver for the nisotropic Diffusion Equation in Two and Three Dimensions Tolga Tasdizen, Ross Whitaker UUSCI-2004-002 Scientific Computing and Imaging Institute University

More information

SOLVING PARTIAL DIFFERENTIAL EQUATIONS ON POINT CLOUDS

SOLVING PARTIAL DIFFERENTIAL EQUATIONS ON POINT CLOUDS SOLVING PARTIAL DIFFERENTIAL EQUATIONS ON POINT CLOUDS JIAN LIANG AND HONGKAI ZHAO Abstract. In this paper we present a general framework for solving partial differential equations on manifolds represented

More information

Shape Modeling and Geometry Processing

Shape Modeling and Geometry Processing 252-0538-00L, Spring 2018 Shape Modeling and Geometry Processing Discrete Differential Geometry Differential Geometry Motivation Formalize geometric properties of shapes Roi Poranne # 2 Differential Geometry

More information

Solutions Manual for Fundamentals of Fluid Mechanics 7th edition by Munson Rothmayer Okiishi and Huebsch

Solutions Manual for Fundamentals of Fluid Mechanics 7th edition by Munson Rothmayer Okiishi and Huebsch Solutions Manual for Fundamentals of Fluid Mecanics 7t edition by Munson Rotmayer Okiisi and Huebsc Link full download : ttps://digitalcontentmarket.org/download/solutions-manual-forfundamentals-of-fluid-mecanics-7t-edition-by-munson-rotmayer-okiisi-and-uebsc/

More information

Proceedings. Seventh ACM/IEEE International Conference on Distributed Smart Cameras (ICDSC 2013) Palm Spring, CA

Proceedings. Seventh ACM/IEEE International Conference on Distributed Smart Cameras (ICDSC 2013) Palm Spring, CA Proceedings Of te Sevent ACM/IEEE International Conference on Distributed Smart Cameras (ICDSC ) Palm Spring, CA October 9 November st Parameter-Unaware Autocalibration for Occupancy Mapping David Van

More information

On Calibrating a Camera Network Using Parabolic Trajectories of a Bouncing Ball

On Calibrating a Camera Network Using Parabolic Trajectories of a Bouncing Ball On Calibrating a Camera Network Using Parabolic rajectories of a ouncing all Kuan-Wen Cen, Yi-Ping Hung,, Yong-Seng Cen 3 Department of Computer Science and Information Engineering, National aiwan Uniersity,

More information

1 Finding Trigonometric Derivatives

1 Finding Trigonometric Derivatives MTH 121 Fall 2008 Essex County College Division of Matematics Hanout Version 8 1 October 2, 2008 1 Fining Trigonometric Derivatives 1.1 Te Derivative as a Function Te efinition of te erivative as a function

More information

H-Adaptive Multiscale Schemes for the Compressible Navier-Stokes Equations Polyhedral Discretization, Data Compression and Mesh Generation

H-Adaptive Multiscale Schemes for the Compressible Navier-Stokes Equations Polyhedral Discretization, Data Compression and Mesh Generation H-Adaptive Multiscale Scemes for te Compressible Navier-Stokes Equations Polyedral Discretization, Data Compression and Mes Generation F. Bramkamp 1, B. Gottsclic-Müller 2, M. Hesse 1, P. Lamby 2, S. Müller

More information

1.7.1 Laplacian Smoothing

1.7.1 Laplacian Smoothing 1.7.1 Laplacian Smoothing 320491: Advanced Graphics - Chapter 1 434 Theory Minimize energy functional total curvature estimate by polynomial-fitting non-linear (very slow!) 320491: Advanced Graphics -

More information

IMA Preprint Series # 1979

IMA Preprint Series # 1979 INPAINTING THE COLORS By Guillermo Sapiro IMA Preprint Series # 1979 ( May 2004 ) INSTITUTE FOR MATHEMATICS AND ITS APPLICATIONS UNIVERSITY OF MINNESOTA 514 Vincent Hall 206 Church Street S.E. Minneapolis,

More information

Geo-Registration of Aerial Images using RANSAC Algorithm

Geo-Registration of Aerial Images using RANSAC Algorithm NCTAESD0 GeoRegistration of Aerial Images using RANSAC Algoritm Seema.B.S Department of E&C, BIT, seemabs80@gmail.com Hemant Kumar Department of E&C, BIT, drkar00@gmail.com VPS Naidu MSDF Lab, FMCD,CSIRNAL,

More information

Face Recognition using Computer-Generated Database

Face Recognition using Computer-Generated Database Face Recognition using Computer-Generated Database Won-Sook LEE Scool of Information Tecnology and Engineering University of Ottawa, 800 King Edward Ave Ottawa, Ontario, K1N 6N5, Canada Tel: (1-613) 562-5800

More information

θ R = θ 0 (1) -The refraction law says that: the direction of refracted ray (angle θ 1 from vertical) is (2)

θ R = θ 0 (1) -The refraction law says that: the direction of refracted ray (angle θ 1 from vertical) is (2) LIGHT (Basic information) - Considering te ligt of a projector in a smoky room, one gets to geometrical optics model of ligt as a set of tiny particles tat travel along straigt lines called "optical rays.

More information

Fast marching methods

Fast marching methods 1 Fast marching methods Lecture 3 Alexander & Michael Bronstein tosca.cs.technion.ac.il/book Numerical geometry of non-rigid shapes Stanford University, Winter 2009 Metric discretization 2 Approach I:

More information

Pedestrian Detection Algorithm for On-board Cameras of Multi View Angles

Pedestrian Detection Algorithm for On-board Cameras of Multi View Angles Pedestrian Detection Algoritm for On-board Cameras of Multi View Angles S. Kamijo IEEE, K. Fujimura, and Y. Sibayama Abstract In tis paper, a general algoritm for pedestrian detection by on-board monocular

More information

Mesh Processing Pipeline

Mesh Processing Pipeline Mesh Smoothing 1 Mesh Processing Pipeline... Scan Reconstruct Clean Remesh 2 Mesh Quality Visual inspection of sensitive attributes Specular shading Flat Shading Gouraud Shading Phong Shading 3 Mesh Quality

More information

Java Method Modeling using Application Response Measurement (ARM)

Java Method Modeling using Application Response Measurement (ARM) Java Metod Modeling using Application Response Measurement (ARM) Dr. Carl J. De Pasquale College of Staten Island Staten Island, NY Abstract - Wat sould not be surprising, especially to anyone wo as attempted

More information

Introduction to Computer Graphics 5. Clipping

Introduction to Computer Graphics 5. Clipping Introduction to Computer Grapics 5. Clipping I-Cen Lin, Assistant Professor National Ciao Tung Univ., Taiwan Textbook: E.Angel, Interactive Computer Grapics, 5 t Ed., Addison Wesley Ref:Hearn and Baker,

More information