Outline Introduction Edge Detection A t c i ti ve C Contours

Size: px
Start display at page:

Download "Outline Introduction Edge Detection A t c i ti ve C Contours"

Transcription

1 Edge Detection and Active Contours Elsa Angelini Department TSI, Telecom ParisTech 2008

2 Outline Introduction Edge Detection Active Contours

3 Introduction The segmentation Problem Edges Regions Textures es Segmentation Measures Shape Recognition Structural Scene Analysis

4 What is a contour? Introduction

5 Introduction Contours profiles Staircase Ramp Roof

6 Introduction The segmentation problem: Partition an image into objects: 2 approaches: Region-based Contour-based Edge Detection: Detection of «abrupt changes» in image gradient. Analysis of first and second derivatives of image gradients.

7 Outline Introduction Edge Detection Active Contours

8 Edge Detection Gradient-based Edge 1st derivative 2nd derivative Edges: location of gradient maxima, in the direction of the gradient.

9 Edge Detection Gradient-based Image I( x, y) with a continuous representation: (, ) I xy x G= I (, x y ) = I ( xy, ) y (, ) I( x, y) 2 2 I x y G= I(, x y) = + x y

10 Edge Detection Gradient-based Filters Gradient Roberts Prewitt Sobel Oriented edges.

11 Edge Detection Gradient-based Dedicated Gradient Filters 1. Pre-processing: filtering (Gaussian, Median). 2. Segmentation via thresholding or local maxima detection. 3. Post-processing: contour closing, curve fitting, smoothing.

12 Edge Detection Gradient-based example: Boundary Tracking Edge map Boundary tracking is very sensitive to noise Use Boundary tracking is very sensitive to noise Use of smoothing, average gradient computation, large «tracking» neighborhoods.

13 Edge Detection Gradient-based example: morphological post-processing

14 Edge Detection Gradient-based: Line Detection by Hough y Transform Algorithm: Parameter Space 1. Quantize Parameter Space ( m, c ) ( m, c) A( m, c) A( m, c) A ( m, c ) = 0 m, c Create Accumulator Array 3. Set 4. For each image edge increment: If lies on the line: ( x i, yi ) A( m, c) = A( m, c) + 1 ( m, c) c = xim + y i A( m, c 5. Find local maxima in ) x

15 Edge Detection Gradient-based: Line Detection by Hough Transform

16 Edge Detection Laplacian-based Edge 1st derivative 2nd derivative Zero Crossing 2 I ( xy, ) 2 I ( xy, ) Ixy (, ) = + x y 2 2

17 Edge Detection Laplacian-based Laplacian operator on the image: Discrete implementation with convolution kernels: convolution kernels -Set of closed connected contours but Very sensitive to noise!

18 Edge Detection Laplacian-based: Laplacian of Gaussian (LoG) ( (, )) LoG I x y 2 2 ( I ( xy, ) Gσ ( xy, )) I( xy, ) Gσ ( xy, ) = x y ( ) ( Gσ ( x, y ) ) Gσ ( x, y ) I( x y) = I( x, y) +, x 2 2 ( ) y 2 2 Convolution kernel?

19 Edge Detection Laplacian-based: Laplacian of Gaussian (LoG) ( ) 1 1 x + y Gσ = e = e 2πσ πσ 2σ x + y 2 2 x + y σ 2 σ Convolution kernel Band-pass Impulse response Transfer function

20 Edge Detection Laplacian-based Parameter σ controls the width of central peak : amount of smoothing. - Good approximation with Difference of Gaussians (DoG), with a ratio σ 2 / σ 1 = 1.6. DoG separable in x and y : efficient implementation.

21 Edge Detection Laplacian of a Gaussian (LoG) Gradient-based LoG

22 Edge Detection Analytical: CANNY: Hypothesis: 1D contours, staircase model, white Gaussian noise Edge detection via detection of local maxima of Linear Filtering. I( x) = AH( x) + n( x) ( ) ( ) ( ) O x = I x f x x dx 0 edge 0 edge ( ) = ( ) f x f x edge f edge?

23 Edge Detection Analytical CANNY: Performance Criteria: Good Detection Good Localization Unique Response 0 Σ= Λ= f ' edge f f edge f 2 edge ' edge f '2 edge ( ) x dx ( ) x dx ( 0) ( ) x dx 0 ( 0) fedge ( ) x dx = k ''2 2 f x dx f x dx edge ( ) ( ) edge

24 Edge Detection Analytical Canny: Optimization of the 3 criteria with Lagrange multipliers. b ( ) ( ' '',,, )( ) Max ΛΣ = L x fedge f edge f edge x dx a b f 2 λ f '2 λ f ''2 λ f dx a edge 1 edge 2 edge 3 edge = f 2λ f + 2λ f + λ = 0 '' ''' edge edge edge

25 Analytical edge CANNY Solution ( ) x sin ( ) x cos( ) x σ σ σ sin ( ) x σ = cos( ) f x a e wx a e wx a e wx a e wx λ λ 1 λ w λ 4λ > 0; w = ; 4 = σ 2λ2 σ 2λ2 FIR on [ M, M ]: ( ) ( ) ' ( ) ' ( ) f 0 = 0; f M = 0; f 0 = S; f M = 0 edge edge edge edge ΣΛ =1.12

26 Edge Detection Analytical Canny Post processing: Hysterisis thresholding 1. A high threshold to select true edges 2. low threshold along the direction of the gradient.

27 Edge Detection Analytical 1. CANNY s approximation with derivatives of Gaussian (IIR). 2 ( ) x 2 2σ f x = xe, ΛΣ= 0.92 edge 2. CANNY s approximation with IIR (DERICHE) ' ' ( ) ( ) ( ) ( ) f 0 = 0; f = 0; f 0 = S; f = 0 edge edge edge edge ( ) ( α x ) fedge x = ce wx 2α Λ = 2 α ; Σ = 2 2 α + w sin ( )

28 Edge Detection Analytical DERICHE

29 Outline Introduction Edge Detection Active Contours

30 Formulations: Parametric Geometric Statistics Graph-cuts Active Contours N-D Implementation Applications Conclusions and Perspectives

31 Active Contours Contour placed in the data space and deforming towards an optimal position and shape. Forces of Deformation: Internal forces: define intrinsic shape properties preserve shape smoothness during deformation. External forces: defined from the data. Control contour deformation according to data content (e.g: edge locations).

32 Active Contours Parametric contours. Geometric contours.

33 Parametric Active Contours Formulation of the Problem 1. Energy Minimization : Minimize the weighted sum of internal and external energies (Force potentials). Final contour position corresponds to an energy s minimum. 2. Dynamical Forces : Equilibrium between internal and external forces at each point on the contour.

34 Parametric Active Contours Definition of the Energy An active contour is a curve v(s) =[x(s), y(s)], where s [0, 1] ] is the arc length. s v(s) evolves towards a position minimizing the energy functional: E total = E internal (v(s)) + E external (v(s))

35 Parametric Active Contours E internal( (v(s))( : Goal: Obtain a smooth contour Penalize the size of the object increased energy with high h area and perimeter values. Penalize irregular contours minimize the contour curvature. Constrain the shape of the contour: circles, ellipses,... Minimization Method: optimization. Finite formulation: Exhaustive search of a minimum, global or with probabilistic algorithms. Infinite formulation: local minimum via progressive adaptation, gradient descent or other PDE solvers.

36 Parametric Active Contours E internal l(v(s)) : E it interne 2 1 vs ( ) α ( s ) + β ( s ) ( ) 2 2 vs = α + β 0 2 s s d s length of fthe contour Curvature of the contour tension controlled by the rigidity controlled by elasticity coefficient. rigidity coefficient. dθ dy ' ',tan θ, ds x y κ = = = + ds dx s

37 Parametric Active Contours E external l(v(s)) : Standard formulation: Integral of a force potential. Eexterne = 1 0 ( ) ( ) P v s ds Potential : low values on the contours in the image (e.g.: derived from image gradient) (, ) = (, ) 2 P xy w I xy (, ) = (, ) * (, ) 2 Pxy w G xy Ixy σ

38 Parametric Active Contours Energy Minimization Goal: find the contour v(s) that minimizes the global energy. Framework: Attract an initial contours towards contours of the image, while avoiding stretching and bending. Method 1: Variational problem formulated with the Euler-Lagrange equation: ( ) 2 2 vs ( ) vs α ( ) = s s s s 2 β Pv 0 2

39 Parametric Active Contours Energy Minimization Method 2: Dynamic Deformable model: Minimization viewed as a static problem. Buildadynamic system that we evolve towards an equilibrium state according to a Lagrangian mechanical point of view. This dynamical model unifies the shape and motion descriptions, defining an active contour quantification of a shape evolution through time v(s,t).

40 Parametric Active Contours Energy Minimization Method 2: Dynamic Deformable model: Motion equation: according to the 2 nd law of Newton, : ( ) v v v vs µ γ α + β P v t t s s s s ( ) Equilibrium state: v t v t 2 = = 0 2

41 Parametric Active Contours Energy Minimization Methods 1 & 2: no analytical solution (due to external energy). Need to discretize : Finite Differences: each element of the contour is viewed as a point with individual mechanical properties. Finite Elements : sub-elements between nodes. N control points v = (v 1, v 2,..., v N ), distant with a spatial step h.

42 Parametric Active Contours Energy Minimization: Numerical Schemes Discretization of spatial derivatives 2 v i v i v i + v i 1 = 2 2 s h Matrix Notation (α, β cst): α ( ) vs ( ) vs 2 4 β Pv 2 4 ( ) = 0 s s ( ) Av= P v 4 v i v i 2 4v i 1+ 6v i 4v i + 1+ v i + 2 = 4 4 s Penta diagonal matrix β 4 β β α α h h h β β β β α α 6 α h h h h 1 A = β β h 2 α h h β 0... h h

43 Parametric Active Contours Energy Minimization: Numerical Schemes Problems (, ) (, ) Ax= Px x y v = ( x, y ), Ay= Py x y Internal forces Non-linear terms in the potential force. Matrix A non-invertible invertible. Need for iterative numerical schemes ( 1 1) ( 1, γ ) Ax P x y = x x Ay P x y = y y n n n n n x ( 1 1 1, ) γ ( ) n n n n n y Inertia coefficient i

44 Parametric Active Contours Energy Minimization: Parameters Spatial continuity spatial step smaller than pixel size. α = elasticity (i.e. dof of points to move away from each others). β = rigidity. Temporal step set to have a maximum Temporal step set to have a maximum displacement of 1-2 pixels at each iteration.

45 Parametric Active Contours Energy Minimization: Conclusions Advantages Extraction of a locally optimal position via iterative deformation of a curve. Suited for contour extraction: open, closed (v 0 = v N ) With fixed extremities (v 0 et v N fixed) General Framework : several different types exist. Simple an efficient 2D implementation. Numerical stability wrt internal forces.

46 Parametric Active Contours Energy Minimization: Conclusions Limitations Instability wrt external forces: if spatial step too big, can miss some contours. Sensitive to local minima problems and initialization. Difficult parameterization. No change in topology allowed (i.e. division/fusion of objects). No simultaneous deformation of multiple objects.

47 Parametric Active Contours Formulation of the Problem 1. Energy Minimization : Minimize the weighted sum of internal and external energies (Force potentials). Final contour position corresponds to an energy s minimum. 2. Dynamical Forces : Equilibrium between internal and external forces at each point on the contour.

48 Parametric Active Contours Formulation with Dynamical Forces Dynamical problem with more general forces than potential forces. Newton s law : 2 µ C = F C + F C + F C mass tt 2 ( ) ( ) ( ) internal external viscous C γ t

49 Parametric Active Contours Formulation with Dynamical Forces Simplification: no mass γ C F internal C F external C t t = + ( ) ( ) idem Superposition of forces

50 Parametric Active Contours F external : GRADIENT forces external : Properties of the Gradient Vectors: Point towards the contours (normals). Large modules near edges. Module around 0 in homogeneous regions. Problems: Weak attraction range (only close to edges) No force in homogeneous areas (nothing moves ). To solve : Initialization problems. Convergence towards concave regions.

51 Parametric Active Contours Example F external : Balloon [Cohen et Cohen] : A gradient fore to attract the contours towards edges. A pressure force to constrain the model to inflate/deflate: P ( C ) n Fexterne ( C ) = k k1n s P C ( ) +/-: inflate ( ) Computational ti cost: image gradient and normals on the contours for each node. Need to control the dynamical behavior of the contour far from the edges ( weight of k 1 ).

52 Parametric Active Contours Example F externe : Potential Forces for Distances Distance map D(x, y) (Euclidian or Chamfer) for each pixel to the closest point on the contour field of potential forces. D(x, y) defines the potential energy : ( ) D( (, ) 2 D xy Pdistance x, y = we D ( x, y) and the field of forces F C P x y externe = distance, ( ) ( ) Problem remaining: concave shapes

53 Parametric Active Contours Example of F externe : GVF [Xu et Prince 1998] Vector field. Preserve gradient properties near the edges. Diffuse these properties in homogeneous regions via «gradient diffuse».

54 Parametric Active Contours Example of F externe : GVF I ( x, y) GVF is a vector field : V( x, y) = [ u( x, y) v( x, y) ] Ι ( xy) edge, V x, y is defined via energy minimization: ( ) E = ( ) Regularization on the overall domain (, ) (, ) (, ) (, ) ( u ) x xy uy xy vx xy vy xy µ Ω + Ιedge ( xy, ) V ( xy, ) Ι ( xy, ) 2 2 edge Data terms Ι edge xy, = Edge map of the image I ( xy, ) dxdy

55 Parametric Active Contours Example of F externe : GVF The GVF vector field is obtained by solving the Euler equations : I ( ) ( ) 2 ( ) 2 edge x, y Iedge x, y Iedge x, y µ u( x y) u x y + = ( ) ( ),, 0 x x y I ( ) ( ) ( ) ( ( )) 2 2 edge x, y Iedge x, y Iedge x, y µ v x, y v( x, y) + = 0 y x y Laplace Eq. Gradient data term Gradient of the Edge map

56 Parametric Active Contours GVF Final result, iter = 50 GVF force Final result, iter = 50 GVF force Final result, iter = 50 GVF force

57 Parametric Active Contours Example of F externe : GVF Numerical implementation in m mp m the computer lab

58 Parametric Active Contours Example of F : Example of F externe : GVF

59 Parametric Active Contours Bibliography 1. Kass M, Witkin A and Terzopoulos D. Snakes: Active contour models. International Journal of Computer Vision 1987; 1-: Cohen LD and Cohen I. Finite-elements methods for active contour models and balloons for 2-D and 3-D Images. IEEE Transactions on Pattern Analysis and Machine Intelligence 1993; 15-11: Xu C and Prince JL. Snakes, shapes and gradient vector Flow. IEEE Transactions on Image Processing 1998:

60 Active Contours Parametric contours. Geometric contours.

61 Geometric Active Contours Introduction Theory of curve evolution and geometrical flows. The contour deforms with a speed made of 2 terms: Regularizing term (curvature-based motion). Expansion term or contraction to go towards image edges. The active contour is defined via a geometrical flow (PDE). the curve evolution must stop at locations of image edges corresponding to the object to segment.

62 Geometric Active Contours Geometric Active contours Numerical methods via level sets. Geodesic. Mumford-Shah.

63 Geometric Active Contours Curve Evolution Theory: Curve evolution through geometric measures (normal vectors to the curve, curvature,...) and independent of curve parameterization (e.g. derivatives). Let a curve X( s, t) = [ x( s, t) y( s, t) ] with spatial parameter s and temporal parameter t The curve evolution in the normal directions controlled by the PDE: Propagation speed Geometric measure of s the curve ( ) X s, t t = V ( κ ) N N

64 Geometric Active Contours Curve Evolution Theory 1. Constant speed: X ( s, t ) = VN 0 t similar to a pression force (balloon). 2. Motion under curvature: X ( s, t ) = ακ N, α > 0 t similar to an elasticity force.

65 Geometric Active Contours Numerical Methods with Level Sets Goal: Numerical methods to compute the spatial propagation of acurveintime:add atemporal dimension. Precise characterization of the geometric properties of the contour. Approach: Γ, 0 0 = 0 f dd l φ ( ) φ ( t ) Define a spatio-temporal temporal function. Immerge the contour in a function as its 0-level (iso-contours). Extend the function to other levels. φ : + Ω Γ, = 0

66 Geometric Active Contours Numerical Methods with Level Sets Definition of the level set function: φ x, y, t > 0, x, y Ω ( ) ( ) i ( x, y, t) < 0, ( x, y) Ω o ( x, y, t) = 0, ( x, y ) Γ( st, ) > Ω Ω φ φ Γ ( s, t ) is defined as the 0 level of φ ( x, y, t ). Γ ( st, ) deforms with a speed applied v on each point. How to control the level l set motion? Ω o Γ Ω i ( s, t )

67 Geometric Active Contours Numerical Methods with Level Sets Iterative Deformation Scheme: 1. Define a field of speed vectors (cf. theory of curve evolution). 2. Compute initial values of the level set function, based on the initial position of the contour to evolve. 3. Adjust the function in time, so that the level 0 corresponds to the segmentation solution. Evolution equation for the level set function?

68 Geometric Active Contours Numerical Methods with Level Sets Curve evolution theory: Γ = V t ( κ ) N N ( s, t) Evolution equation of the level set function: dφ ( Γ, t) φ ( Γ, t) = cste = 0 dt ( ) φ Γ, t φ (, t ) Γ + Γ. = 0 t t Γ ( s, t )

69 Geometric Active Contours Numerical Methods with Level Sets Evolution equation of the level set function: φ ( Γ, t ) + V ( κ ) φ ( Γ, t) N. N = 0 ( s, t ) t Normal vector: N = φ φ ( Γ, t ) ( Γ, t ) Γ ( s, t )

70 Geometric Active Contours Numerical Methods with Level Sets Evolution equation of the level set function: N ( s, t) φ ( Γ, t ) + V ( κ ) φ ( Γ, t ) = 0 t φ ( Γ ) 0,0 given Γ ( s, t )

71 Geometric Active Contours Numerical Methods with Level Sets Geometrical properties of the level set curve: directly computed on the level set Γ ( s, t ) function! N ( s, t) φ ( Γ, t ) N = φ ( Γ, t ) ( ) 2 2 φ Γ, t φ xxφ y 2φxφ yφxy + φ yyφx κ =. = φ Γ, t φ + φ ( ) ( ) x y

72 Geometric Active Contours Numerical Methods with Level Sets What type of φ function?: Most common choice: signed distance function N ( s, t) N = φ ( Γ, t) φ (, t ) Γ = 1 κ = φ ( Γ, t ) Γ ( s, t) Careful! φ t The solution of = V ( κ ) φ is not the signed distance function of the curve solution to: V κ N. Γ = t ( )

73 Geometric Active Contours Numerical Methods with Level Sets What speed of propagation? Take into account: Image Information: zero on edges from the objets to segment. Geometric Information of the contour: smoothing via constraints on the countour. Particular case: Motion under curvature Each part of the model evolves in the normal direction, with a speed proportional to the curvature. points can move inward or outward, depending on the curvature s sign.

74 Geometric Active Contours Numerical Methods with Level Sets Speed of propagation? ( Γ, t ) Defined only on the contour only. Extension of the speed over the whole domain : Natural Extension: e.g. with motion under curvature, computing the curvature on the overall levell set function. Values of the nearest point from the 0-level. problems since the speed does not depend on f and we are not anymore in the H-J framework. φ t + V Γ, = 0 ( κ ) φ ( t) φ ( x, y, t) t (, ) φ (,, ) = V x y φ x y t

75 Geometric Active Contours Numerical Methods with Level Sets Reinitialization Why reinitialize? Unique correspondence between a curve and its level set function (convergence iif convergence) Preserve a constant gradient norm numerical stability. Methods : Direct evaluation: Detect the 0-level and re-compute the signed distance function. High computational cost! Iterative: Equilibrium state: norm of gradient =1. φt = sign ( φ)( 1 φ ) Opposite flows for negative and positive values. Problem: the 0-level can move during reinitialization!

76 Geometric Active Contours Numerical Methods with Level Sets Narrow Band Only evolve levell sets in a narrow band around the level zero. Reduce computational cost. No need to compute evolution speed far from the 0-level. less constraints on t for the CFL stability, limiting the maximum speed of deformation.

77 Geometric Active Contours Level Sets Advantages Change of topology Intrinsic geometric properties easy to compute (normals, curvatures). Extension to N-D straightforward : add new spatial variables to the evolution equation of the volume φ(x, y, z,, t). Numerical implementation: Discretization of φ(x,y,t)on regular grid (x, y). Standard numerical schemes for the spatial derivative.

78 Geometric Active Contours Level Sets Limitations 3 limitations related to the numerical implementation: Construction of an initial level set function φ(x, y, t = 0) from an initial 0-level (initial contour). Evolution equation only defined for the 0-level the speed function V is not defined in general for the other levels arbitrary spatial extension. Instable definition of the normal to the level set function φ(x, y, t = 0) reinitialization iti + smoothing.

79 Geometric Active Contours Geometric Active contours Numerical methods via level sets. Geodesic. Mumford-Shah.

80 Geometric Active Contours Geodesic Deformable Models [Caselles, Kimmel, Sapiro 1997] Geodesic curves in a Riemannian space Geodesic: path (locally) minimal between 2 points. Space with metrics defined from geodesics. Novel approach (equivalent) Min ( ( ) ) ( ) ' ( ) ( ) E C C s ds g I C s ds 1 = 0 0 ( ( ( ) ) ) ' ( ) Min g I C s C s ds 0 Geodesic computation

81 Geometric Active Contours Geodesic Deformable Models Euclidian Geodesics ( ) '( ) Length L E C = C s ds = ds C Motion under curvature = κ N t Euclidian Metric and curvature Motion under curvature provides fastest t minimization i i of L E. Geodesics for deformable models 1 Lenght L C = g I C s C ' s ds C t R =g I N- g.n N ( ) κ ( ) ( ) ( ) ( ) ( ) ( ) 0 LE 0 ( C) ( ( )) ( ) '( ) = g I C s C s ds Image characteristics S

82 Geometric Active Contours Geometric Active contours Numerical methods via level sets. Geodesic. Mumford-Shah.

83 Geometric Active Contours Mumford and Shah Variational method. Image I 0 segmentation, defined on the domain Ω, is provided by a pair ( CI, ) with: C contours in the image and I a smooth approximation of I 0. Energie associated with the segmentation: (, ) α βlength( ) ( ) 2 2 Ω\ C Ω\ C 0 ECI I d C I I d = Ω+ + Ω 1D, # of points on C 2D, perimeter of C 3D, surface of C

84 Geometric Active Contours Mumford and Shah Conjuncture There exists a minimal segmentation made of a finite set of curves C 1. [Morel-Solimini 1995, Aubert-Kornprobst 2000]: There exists a minimal segmentation. The minimal segmentation is not unique. The ensemble of solutions is a compact set. Contours are rectifiable (i.e. of finite length). All contours can be included in a single rectifiable curve.

85 Geometric Active Contours Mumford and Shah Particular case: I 0 is a cartoon-like image. The smooth approximation I of I 0 is a piecewise constant image with values c 1 et c 2 which are the mean values of I 0 in the object and the background. The contour C corresponds to the contours of the objects. 2 ( 1, 2, ) = υ ( ) + λ inside 1 + λ 2 ( C) outside( C) EccC Length C I c I c I = 0 2

86 Geometric Active Contours Mumford and Shah Deformable models without Edges [Chan, Vese, IEEE TIP 2001] 2 ( ) µ ( ) ν ( ) λ Ω λ 1 inside( C) outside( C) 0 2 EC LC AC I c d I c d Ω = + + Ω+ Ω 2 Regularizing terms (cf. internal energy) Homogeneity constraints (cf. external energy) c 1 = mean value inside C c 2 = mean value outside C L(C) = length of C A(C) = area of C

87 Geometric Active Contours Mumford and Shah Deformable models without Edges [Chan, Vese, IEEE TIP 2001] 2 ( ) µ ( ) ν ( ) λ λ inside( C) outside ( C) EC = LC + AC + I c d Ω+ I c d Ω Insert the n-d curve C in a level set function (n+1)-d φ { N / φ ( ) 0} { N / φ ( ) 0} { N / φ ( ) 0} C = x x = C = x x < inside C = x x > outside 2. Define a Heaviside function H(φ) H( z) 1if z 0 = 0if z 0 3. Define a Dirac function δ(φ) ( z) δ = dh ( z) dz

88 Geometric Active Contours Mumford and Shah Deformable models without Edges [Chan, Vese, IEEE TIP 2001] - Level set Function φ = distance to the 0- level φ - Heaviside Function H ( φ ) H ( φ ) 1 2 φ = 1 arctan 2 + π ε - Dirac Function ( ) 2 2 δ φ { (,, ) / φ (,, ) 0 } C = xyz xyz = Area C ( ) = Area ( φ 0 ) = H( φ ) dω Length ( C ) = Length ( φ = 0 ) δ ( φ ) = H( φ ) dω 1 ε = π φ + ε Ω Ω ( ) φ d = δ φ Ω Ω

89 Geometric Active Contours Mumford and Shah Deformable models without Edges [Chan, Vese, IEEE TIP 2001] ( ) 2 ( φ,, ) = µ δ ( φ) φ + υ ( φ) + λ ( φ) + λ 1 ( φ) E c c dx H I c H dx I c H dx ε 0 1 ε ε 0 Ω 0 0 ε 1 Ω 0 1 ε Ω Ω length area homogeneity homogeneity φ δε ( φ ) µ 2 2 ν λ ( ) λ ( ) div 0 I c0 + 1 I c1 = φ 0 δ φ I ( x, y, z) H ( φ ( x, y, z) ) dxdydz Ω ε ( ) φ = 0 on Ω, c 0 ( φ ) = φ n H ( φ ( x, y, z) ) dxdydz ( φ c c ) Segmentation via inf E,, φ, c, c 0 1 ε 0 1 c 1 ( φ) = Ω Ω ( ( )) I ( x, y, z) 1 H φ ( x, y, z) dxdydz Ω ( 1 H ( φ ( xyz,, ) ) ) dxdydz d d

90 Geometric Active Contours Bibliography D. Mumford and J. Shah, "Boundary detection by minimizing functional," International Conference on Computer Vision and Pattern Recognition, San Francisco, CA, USA, pp , S. Osher and J. A. Sethian, "Fronts propagating with curvaturedependent speed: Algorithms based on Hamilton-Jacobi formulations," Journal of Computational Physics, vol. 79, No. 1, pp , V. Caselles, F. Catté, B. Coll, F. Dibos, A geometric model for edge detection, ti Num. Mathematik, tik 66, 1-31, R.Malladi, J.A. Sethian, Baba C. Vemuri: Shape modeling with front propagation: A level set approach '. IEEE Transactions on Pattern Analysis and Machine Intelligence 17(2): , T. F. Chan and L. A. Vese, "Active contours without t edges," IEEE Transactions on Image Processing, vol. 10, No. 2, pp , 2001.

91 Active Contours Two families of N-D Active Contours: Parametric : Explicit representation of the contour. Compact representation allowing fast implementation (enable real-time applications). Changes of topology very difficult to handle (in 3D). Geometric: Implicit representation of the contour as the level 0 of a scalar function of dimension (N-D+1). Contour parameterization after the deformations. Flexible adaptation ti of the contours topology. Increase dimension of space search.

Segmentation using deformable models

Segmentation using deformable models Segmentation using deformable models Isabelle Bloch http://www.tsi.enst.fr/ bloch Téécom ParisTech - CNRS UMR 5141 LTCI Paris - France Modèles déformables p.1/43 Introduction Deformable models = evolution

More information

Numerical Methods of Applied Mathematics -- II Spring 2009

Numerical Methods of Applied Mathematics -- II Spring 2009 MIT OpenCourseWare http://ocw.mit.edu 18.336 Numerical Methods of Applied Mathematics -- II Spring 2009 For information about citing these materials or our Terms of Use, visit: http://ocw.mit.edu/terms.

More information

A Tutorial on Active Contours

A Tutorial on Active Contours Elham Sakhaee March 4, 14 1 Introduction I prepared this technical report as part of my preparation for Computer Vision PhD qualifying exam. Here we discuss derivation of curve evolution function for some

More information

arxiv: v1 [cs.cv] 17 Jun 2012

arxiv: v1 [cs.cv] 17 Jun 2012 1 The Stability of Convergence of Curve Evolutions in Vector Fields Junyan Wang* Member, IEEE and Kap Luk Chan Member, IEEE Abstract arxiv:1206.4042v1 [cs.cv] 17 Jun 2012 Curve evolution is often used

More information

Analysis of Numerical Methods for Level Set Based Image Segmentation

Analysis of Numerical Methods for Level Set Based Image Segmentation Analysis of Numerical Methods for Level Set Based Image Segmentation Björn Scheuermann and Bodo Rosenhahn Institut für Informationsverarbeitung Leibnitz Universität Hannover {scheuerm,rosenhahn}@tnt.uni-hannover.de

More information

A Pseudo-distance for Shape Priors in Level Set Segmentation

A Pseudo-distance for Shape Priors in Level Set Segmentation O. Faugeras, N. Paragios (Eds.), 2nd IEEE Workshop on Variational, Geometric and Level Set Methods in Computer Vision, Nice, 2003. A Pseudo-distance for Shape Priors in Level Set Segmentation Daniel Cremers

More information

An improved active contour model based on level set method

An improved active contour model based on level set method 1 015 1 ( ) Journal of East China Normal University (Natural Science) No. 1 Jan. 015 : 1000-5641(015)01-0161-11, (, 0006) :,., (SPF),.,,.,,,,. : ; ; ; : O948 : A DOI: 10.3969/j.issn.1000-5641.015.01.00

More information

Active Contours Snakes and Level Set Method

Active Contours Snakes and Level Set Method Active Contours Snakes and Level Set Method Niels Chr. Overgaard 2010-09-21 N. Chr. Overgaard Lecture 7 2010-09-21 1 / 26 Outline What is an mage? What is an Active Contour? Deforming Force: The Edge Map

More information

THE TOPOLOGICAL DESIGN OF MATERIALS WITH SPECIFIED THERMAL EXPANSION USING A LEVEL SET-BASED PARAMETERIZATION METHOD

THE TOPOLOGICAL DESIGN OF MATERIALS WITH SPECIFIED THERMAL EXPANSION USING A LEVEL SET-BASED PARAMETERIZATION METHOD 11th. World Congress on Computational Mechanics (WCCM XI) 5th. European Conference on Computational Mechanics (ECCM V) 6th. European Conference on Computational Fluid Dynamics (ECFD VI) July 20-25, 2014,

More information

Edge Detection. CS 650: Computer Vision

Edge Detection. CS 650: Computer Vision CS 650: Computer Vision Edges and Gradients Edge: local indication of an object transition Edge detection: local operators that find edges (usually involves convolution) Local intensity transitions are

More information

Edge Detection. Introduction to Computer Vision. Useful Mathematics Funcs. The bad news

Edge Detection. Introduction to Computer Vision. Useful Mathematics Funcs. The bad news Edge Detection Introduction to Computer Vision CS / ECE 8B Thursday, April, 004 Edge detection (HO #5) Edge detection is a local area operator that seeks to find significant, meaningful changes in image

More information

Riemannian Drums, Anisotropic Curve Evolution and Segmentation

Riemannian Drums, Anisotropic Curve Evolution and Segmentation Riemannian Drums, Anisotropic Curve Evolution and Segmentation Jayant Shah * Mathematics Department, Northeastern University, Boston, MA 02115. * This work was partially supported by PHS Grant 2-R01 NS34189

More information

Fraunhofer Institute for Computer Graphics Research Interactive Graphics Systems Group, TU Darmstadt Fraunhoferstrasse 5, Darmstadt, Germany

Fraunhofer Institute for Computer Graphics Research Interactive Graphics Systems Group, TU Darmstadt Fraunhoferstrasse 5, Darmstadt, Germany Scale Space and PDE methods in image analysis and processing Arjan Kuijper Fraunhofer Institute for Computer Graphics Research Interactive Graphics Systems Group, TU Darmstadt Fraunhoferstrasse 5, 64283

More information

Nonlinear Diffusion. Journal Club Presentation. Xiaowei Zhou

Nonlinear Diffusion. Journal Club Presentation. Xiaowei Zhou 1 / 41 Journal Club Presentation Xiaowei Zhou Department of Electronic and Computer Engineering The Hong Kong University of Science and Technology 2009-12-11 2 / 41 Outline 1 Motivation Diffusion process

More information

Lecture 7: Edge Detection

Lecture 7: Edge Detection #1 Lecture 7: Edge Detection Saad J Bedros sbedros@umn.edu Review From Last Lecture Definition of an Edge First Order Derivative Approximation as Edge Detector #2 This Lecture Examples of Edge Detection

More information

LEVEL SET BASED MULTISPECTRAL SEGMENTATION WITH CORNERS

LEVEL SET BASED MULTISPECTRAL SEGMENTATION WITH CORNERS LEVEL SET BASED MULTISPECTRAL SEGMENTATION WITH CORNERS WENHUA GAO AND ANDREA BERTOZZI Abstract. In this paper we propose an active contour model for segmentation based on the Chan-Vese model. The new

More information

Mathematical Problems in Image Processing

Mathematical Problems in Image Processing Gilles Aubert Pierre Kornprobst Mathematical Problems in Image Processing Partial Differential Equations and the Calculus of Variations Second Edition Springer Foreword Preface to the Second Edition Preface

More information

Nonlinear Dynamical Shape Priors for Level Set Segmentation

Nonlinear Dynamical Shape Priors for Level Set Segmentation To appear in the Journal of Scientific Computing, 2008, c Springer. Nonlinear Dynamical Shape Priors for Level Set Segmentation Daniel Cremers Department of Computer Science University of Bonn, Germany

More information

Image Analysis. Feature extraction: corners and blobs

Image Analysis. Feature extraction: corners and blobs Image Analysis Feature extraction: corners and blobs Christophoros Nikou cnikou@cs.uoi.gr Images taken from: Computer Vision course by Svetlana Lazebnik, University of North Carolina at Chapel Hill (http://www.cs.unc.edu/~lazebnik/spring10/).

More information

Generalized Newton-Type Method for Energy Formulations in Image Processing

Generalized Newton-Type Method for Energy Formulations in Image Processing Generalized Newton-Type Method for Energy Formulations in Image Processing Leah Bar and Guillermo Sapiro Department of Electrical and Computer Engineering University of Minnesota Outline Optimization in

More information

Feature Extraction and Image Processing

Feature Extraction and Image Processing Feature Extraction and Image Processing Second edition Mark S. Nixon Alberto S. Aguado :*авш JBK IIP AMSTERDAM BOSTON HEIDELBERG LONDON NEW YORK OXFORD PARIS SAN DIEGO SAN FRANCISCO SINGAPORE SYDNEY TOKYO

More information

TRACKING and DETECTION in COMPUTER VISION Filtering and edge detection

TRACKING and DETECTION in COMPUTER VISION Filtering and edge detection Technischen Universität München Winter Semester 0/0 TRACKING and DETECTION in COMPUTER VISION Filtering and edge detection Slobodan Ilić Overview Image formation Convolution Non-liner filtering: Median

More information

Filtering and Edge Detection

Filtering and Edge Detection Filtering and Edge Detection Local Neighborhoods Hard to tell anything from a single pixel Example: you see a reddish pixel. Is this the object s color? Illumination? Noise? The next step in order of complexity

More information

A Generative Model Based Approach to Motion Segmentation

A Generative Model Based Approach to Motion Segmentation A Generative Model Based Approach to Motion Segmentation Daniel Cremers 1 and Alan Yuille 2 1 Department of Computer Science University of California at Los Angeles 2 Department of Statistics and Psychology

More information

Modulation-Feature based Textured Image Segmentation Using Curve Evolution

Modulation-Feature based Textured Image Segmentation Using Curve Evolution Modulation-Feature based Textured Image Segmentation Using Curve Evolution Iasonas Kokkinos, Giorgos Evangelopoulos and Petros Maragos Computer Vision, Speech Communication and Signal Processing Group

More information

On Mean Curvature Diusion in Nonlinear Image Filtering. Adel I. El-Fallah and Gary E. Ford. University of California, Davis. Davis, CA

On Mean Curvature Diusion in Nonlinear Image Filtering. Adel I. El-Fallah and Gary E. Ford. University of California, Davis. Davis, CA On Mean Curvature Diusion in Nonlinear Image Filtering Adel I. El-Fallah and Gary E. Ford CIPIC, Center for Image Processing and Integrated Computing University of California, Davis Davis, CA 95616 Abstract

More information

Weighted Minimal Surfaces and Discrete Weighted Minimal Surfaces

Weighted Minimal Surfaces and Discrete Weighted Minimal Surfaces Weighted Minimal Surfaces and Discrete Weighted Minimal Surfaces Qin Zhang a,b, Guoliang Xu a, a LSEC, Institute of Computational Mathematics, Academy of Mathematics and System Science, Chinese Academy

More information

STRUCTURAL OPTIMIZATION BY THE LEVEL SET METHOD

STRUCTURAL OPTIMIZATION BY THE LEVEL SET METHOD Shape optimization 1 G. Allaire STRUCTURAL OPTIMIZATION BY THE LEVEL SET METHOD G. ALLAIRE CMAP, Ecole Polytechnique with F. JOUVE and A.-M. TOADER 1. Introduction 2. Setting of the problem 3. Shape differentiation

More information

Motion Estimation (I) Ce Liu Microsoft Research New England

Motion Estimation (I) Ce Liu Microsoft Research New England Motion Estimation (I) Ce Liu celiu@microsoft.com Microsoft Research New England We live in a moving world Perceiving, understanding and predicting motion is an important part of our daily lives Motion

More information

Exercise 1 (Formula for connection 1-forms) Using the first structure equation, show that

Exercise 1 (Formula for connection 1-forms) Using the first structure equation, show that 1 Stokes s Theorem Let D R 2 be a connected compact smooth domain, so that D is a smooth embedded circle. Given a smooth function f : D R, define fdx dy fdxdy, D where the left-hand side is the integral

More information

Erkut Erdem. Hacettepe University February 24 th, Linear Diffusion 1. 2 Appendix - The Calculus of Variations 5.

Erkut Erdem. Hacettepe University February 24 th, Linear Diffusion 1. 2 Appendix - The Calculus of Variations 5. LINEAR DIFFUSION Erkut Erdem Hacettepe University February 24 th, 2012 CONTENTS 1 Linear Diffusion 1 2 Appendix - The Calculus of Variations 5 References 6 1 LINEAR DIFFUSION The linear diffusion (heat)

More information

Edge Detection. Image Processing - Computer Vision

Edge Detection. Image Processing - Computer Vision Image Processing - Lesson 10 Edge Detection Image Processing - Computer Vision Low Level Edge detection masks Gradient Detectors Compass Detectors Second Derivative - Laplace detectors Edge Linking Image

More information

DREAM 2 S: Deformable Regions Driven by an Eulerian Accurate Minimization Method for Image and Video Segmentation

DREAM 2 S: Deformable Regions Driven by an Eulerian Accurate Minimization Method for Image and Video Segmentation International Journal of Computer Vision 53), 45 0, 003 c 003 Kluwer Academic Publishers. Manufactured in The Netherlands. DREAM S: Deformable Regions Driven by an Eulerian Accurate Minimization Method

More information

A Common Framework for Curve Evolution, Segmentation and Anisotropic Diffusion

A Common Framework for Curve Evolution, Segmentation and Anisotropic Diffusion IEEE Conference on Computer Vision and Pattern ecognition, June, 1996. A Common Framework for Curve Evolution, Segmentation and Anisotropic Diffusion Jayant Shah Mathematics Department, Northeastern University,

More information

Solutions to old Exam 3 problems

Solutions to old Exam 3 problems Solutions to old Exam 3 problems Hi students! I am putting this version of my review for the Final exam review here on the web site, place and time to be announced. Enjoy!! Best, Bill Meeks PS. There are

More information

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost Game and Media Technology Master Program - Utrecht University Dr. Nicolas Pronost Soft body physics Soft bodies In reality, objects are not purely rigid for some it is a good approximation but if you hit

More information

Computing High Frequency Waves By the Level Set Method

Computing High Frequency Waves By the Level Set Method Computing High Frequency Waves By the Level Set Method Hailiang Liu Department of Mathematics Iowa State University Collaborators: Li-Tien Cheng (UCSD), Stanley Osher (UCLA) Shi Jin (UW-Madison), Richard

More information

Isometric elastic deformations

Isometric elastic deformations Isometric elastic deformations Fares Al-Azemi and Ovidiu Calin Abstract. This paper deals with the problem of finding a class of isometric deformations of simple and closed curves, which decrease the total

More information

A Level Set Based. Finite Element Algorithm. for Image Segmentation

A Level Set Based. Finite Element Algorithm. for Image Segmentation A Level Set Based Finite Element Algorithm for Image Segmentation Michael Fried, IAM Universität Freiburg, Germany Image Segmentation Ω IR n rectangular domain, n = (1), 2, 3 u 0 : Ω [0, C max ] intensity

More information

Pattern Recognition Letters

Pattern Recognition Letters Pattern Recognition Letters 32 (2011) 270 279 Contents lists available at ScienceDirect Pattern Recognition Letters journal homepage: www.elsevier.com/locate/patrec Moving-edge detection via heat flow

More information

II. DIFFERENTIABLE MANIFOLDS. Washington Mio CENTER FOR APPLIED VISION AND IMAGING SCIENCES

II. DIFFERENTIABLE MANIFOLDS. Washington Mio CENTER FOR APPLIED VISION AND IMAGING SCIENCES II. DIFFERENTIABLE MANIFOLDS Washington Mio Anuj Srivastava and Xiuwen Liu (Illustrations by D. Badlyans) CENTER FOR APPLIED VISION AND IMAGING SCIENCES Florida State University WHY MANIFOLDS? Non-linearity

More information

Motion Estimation (I)

Motion Estimation (I) Motion Estimation (I) Ce Liu celiu@microsoft.com Microsoft Research New England We live in a moving world Perceiving, understanding and predicting motion is an important part of our daily lives Motion

More information

Created by T. Madas LINE INTEGRALS. Created by T. Madas

Created by T. Madas LINE INTEGRALS. Created by T. Madas LINE INTEGRALS LINE INTEGRALS IN 2 DIMENSIONAL CARTESIAN COORDINATES Question 1 Evaluate the integral ( x + 2y) dx, C where C is the path along the curve with equation y 2 = x + 1, from ( ) 0,1 to ( )

More information

A Survey of Computational High Frequency Wave Propagation II. Olof Runborg NADA, KTH

A Survey of Computational High Frequency Wave Propagation II. Olof Runborg NADA, KTH A Survey of Computational High Frequency Wave Propagation II Olof Runborg NADA, KTH High Frequency Wave Propagation CSCAMM, September 19-22, 2005 Numerical methods Direct methods Wave equation (time domain)

More information

Roadmap. Introduction to image analysis (computer vision) Theory of edge detection. Applications

Roadmap. Introduction to image analysis (computer vision) Theory of edge detection. Applications Edge Detection Roadmap Introduction to image analysis (computer vision) Its connection with psychology and neuroscience Why is image analysis difficult? Theory of edge detection Gradient operator Advanced

More information

CS 468. Differential Geometry for Computer Science. Lecture 17 Surface Deformation

CS 468. Differential Geometry for Computer Science. Lecture 17 Surface Deformation CS 468 Differential Geometry for Computer Science Lecture 17 Surface Deformation Outline Fundamental theorem of surface geometry. Some terminology: embeddings, isometries, deformations. Curvature flows

More information

Linear Diffusion. E9 242 STIP- R. Venkatesh Babu IISc

Linear Diffusion. E9 242 STIP- R. Venkatesh Babu IISc Linear Diffusion Derivation of Heat equation Consider a 2D hot plate with Initial temperature profile I 0 (x, y) Uniform (isotropic) conduction coefficient c Unit thickness (along z) Problem: What is temperature

More information

Optimal stopping time formulation of adaptive image filtering

Optimal stopping time formulation of adaptive image filtering Optimal stopping time formulation of adaptive image filtering I. Capuzzo Dolcetta, R. Ferretti 19.04.2000 Abstract This paper presents an approach to image filtering based on an optimal stopping time problem

More information

Foliations of hyperbolic space by constant mean curvature surfaces sharing ideal boundary

Foliations of hyperbolic space by constant mean curvature surfaces sharing ideal boundary Foliations of hyperbolic space by constant mean curvature surfaces sharing ideal boundary David Chopp and John A. Velling December 1, 2003 Abstract Let γ be a Jordan curve in S 2, considered as the ideal

More information

Introduction to Nonlinear Image Processing

Introduction to Nonlinear Image Processing Introduction to Nonlinear Image Processing 1 IPAM Summer School on Computer Vision July 22, 2013 Iasonas Kokkinos Center for Visual Computing Ecole Centrale Paris / INRIA Saclay Mean and median 2 Observations

More information

A Nonparametric Statistical Method for Image Segmentation Using Information Theory and Curve Evolution

A Nonparametric Statistical Method for Image Segmentation Using Information Theory and Curve Evolution SUBMITTED TO IEEE TRANSACTIONS ON IMAGE PROCESSING 1 A Nonparametric Statistical Method for Image Segmentation Using Information Theory and Curve Evolution Junmo Kim, John W. Fisher III, Anthony Yezzi,

More information

Efficient Beltrami Filtering of Color Images via Vector Extrapolation

Efficient Beltrami Filtering of Color Images via Vector Extrapolation Efficient Beltrami Filtering of Color Images via Vector Extrapolation Lorina Dascal, Guy Rosman, and Ron Kimmel Computer Science Department, Technion, Institute of Technology, Haifa 32000, Israel Abstract.

More information

Novel integro-differential equations in image processing and its applications

Novel integro-differential equations in image processing and its applications Novel integro-differential equations in image processing and its applications Prashant Athavale a and Eitan Tadmor b a Institute of Pure and Applied Mathematics, University of California, Los Angeles,

More information

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

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

More information

PDEs in Image Processing, Tutorials

PDEs in Image Processing, Tutorials PDEs in Image Processing, Tutorials Markus Grasmair Vienna, Winter Term 2010 2011 Direct Methods Let X be a topological space and R: X R {+ } some functional. following definitions: The mapping R is lower

More information

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

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

More information

NONLINEAR DIFFUSION PDES

NONLINEAR DIFFUSION PDES NONLINEAR DIFFUSION PDES Erkut Erdem Hacettepe University March 5 th, 0 CONTENTS Perona-Malik Type Nonlinear Diffusion Edge Enhancing Diffusion 5 References 7 PERONA-MALIK TYPE NONLINEAR DIFFUSION The

More information

An unconstrained multiphase thresholding approach for image segmentation

An unconstrained multiphase thresholding approach for image segmentation An unconstrained multiphase thresholding approach for image segmentation Benjamin Berkels Institut für Numerische Simulation, Rheinische Friedrich-Wilhelms-Universität Bonn, Nussallee 15, 53115 Bonn, Germany

More information

Math 265H: Calculus III Practice Midterm II: Fall 2014

Math 265H: Calculus III Practice Midterm II: Fall 2014 Name: Section #: Math 65H: alculus III Practice Midterm II: Fall 14 Instructions: This exam has 7 problems. The number of points awarded for each question is indicated in the problem. Answer each question

More information

ENERGY METHODS IN IMAGE PROCESSING WITH EDGE ENHANCEMENT

ENERGY METHODS IN IMAGE PROCESSING WITH EDGE ENHANCEMENT ENERGY METHODS IN IMAGE PROCESSING WITH EDGE ENHANCEMENT PRASHANT ATHAVALE Abstract. Digital images are can be realized as L 2 (R 2 objects. Noise is introduced in a digital image due to various reasons.

More information

A Nonlocal p-laplacian Equation With Variable Exponent For Image Restoration

A Nonlocal p-laplacian Equation With Variable Exponent For Image Restoration A Nonlocal p-laplacian Equation With Variable Exponent For Image Restoration EST Essaouira-Cadi Ayyad University SADIK Khadija Work with : Lamia ZIAD Supervised by : Fahd KARAMI Driss MESKINE Premier congrès

More information

Machine vision. Summary # 4. The mask for Laplacian is given

Machine vision. Summary # 4. The mask for Laplacian is given 1 Machine vision Summary # 4 The mask for Laplacian is given L = 0 1 0 1 4 1 (6) 0 1 0 Another Laplacian mask that gives more importance to the center element is L = 1 1 1 1 8 1 (7) 1 1 1 Note that the

More information

Bayesian Approaches to Motion-Based Image and Video Segmentation

Bayesian Approaches to Motion-Based Image and Video Segmentation Bayesian Approaches to Motion-Based Image and Video Segmentation Daniel Cremers Department of Computer Science University of California, Los Angeles, USA http://www.cs.ucla.edu/ cremers Abstract. We present

More information

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C.

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C. Lecture 9 Approximations of Laplace s Equation, Finite Element Method Mathématiques appliquées (MATH54-1) B. Dewals, C. Geuzaine V1.2 23/11/218 1 Learning objectives of this lecture Apply the finite difference

More information

Lecture 8: Interest Point Detection. Saad J Bedros

Lecture 8: Interest Point Detection. Saad J Bedros #1 Lecture 8: Interest Point Detection Saad J Bedros sbedros@umn.edu Review of Edge Detectors #2 Today s Lecture Interest Points Detection What do we mean with Interest Point Detection in an Image Goal:

More information

Variational Methods in Image Denoising

Variational Methods in Image Denoising Variational Methods in Image Denoising Jamylle Carter Postdoctoral Fellow Mathematical Sciences Research Institute (MSRI) MSRI Workshop for Women in Mathematics: Introduction to Image Analysis 22 January

More information

Optimized Conformal Parameterization of Cortical Surfaces Using Shape Based Matching of Landmark Curves

Optimized Conformal Parameterization of Cortical Surfaces Using Shape Based Matching of Landmark Curves Optimized Conformal Parameterization of Cortical Surfaces Using Shape Based Matching of Landmark Curves Lok Ming Lui 1, Sheshadri Thiruvenkadam 1, Yalin Wang 1,2,TonyChan 1, and Paul Thompson 2 1 Department

More information

Lecture 04 Image Filtering

Lecture 04 Image Filtering Institute of Informatics Institute of Neuroinformatics Lecture 04 Image Filtering Davide Scaramuzza 1 Lab Exercise 2 - Today afternoon Room ETH HG E 1.1 from 13:15 to 15:00 Work description: your first

More information

A Partial Differential Equation Approach to Image Zoom

A Partial Differential Equation Approach to Image Zoom A Partial Differential Equation Approach to Image Zoom Abdelmounim Belahmidi and Frédéric Guichard January 2004 Abstract We propose a new model for zooming digital image. This model, driven by a partial

More information

PH.D. PRELIMINARY EXAMINATION MATHEMATICS

PH.D. PRELIMINARY EXAMINATION MATHEMATICS UNIVERSITY OF CALIFORNIA, BERKELEY Dept. of Civil and Environmental Engineering FALL SEMESTER 2014 Structural Engineering, Mechanics and Materials NAME PH.D. PRELIMINARY EXAMINATION MATHEMATICS Problem

More information

Exact Solutions of the Einstein Equations

Exact Solutions of the Einstein Equations Notes from phz 6607, Special and General Relativity University of Florida, Fall 2004, Detweiler Exact Solutions of the Einstein Equations These notes are not a substitute in any manner for class lectures.

More information

A Mathematical Trivium

A Mathematical Trivium A Mathematical Trivium V.I. Arnold 1991 1. Sketch the graph of the derivative and the graph of the integral of a function given by a freehand graph. 2. Find the limit lim x 0 sin tan x tan sin x arcsin

More information

Green s Functions and Distributions

Green s Functions and Distributions CHAPTER 9 Green s Functions and Distributions 9.1. Boundary Value Problems We would like to study, and solve if possible, boundary value problems such as the following: (1.1) u = f in U u = g on U, where

More information

ECE Digital Image Processing and Introduction to Computer Vision. Outline

ECE Digital Image Processing and Introduction to Computer Vision. Outline 2/9/7 ECE592-064 Digital Image Processing and Introduction to Computer Vision Depart. of ECE, NC State University Instructor: Tianfu (Matt) Wu Spring 207. Recap Outline 2. Sharpening Filtering Illustration

More information

Edges and Scale. Image Features. Detecting edges. Origin of Edges. Solution: smooth first. Effects of noise

Edges and Scale. Image Features. Detecting edges. Origin of Edges. Solution: smooth first. Effects of noise Edges and Scale Image Features From Sandlot Science Slides revised from S. Seitz, R. Szeliski, S. Lazebnik, etc. Origin of Edges surface normal discontinuity depth discontinuity surface color discontinuity

More information

IN THE past two decades, active contour models (ACMs,

IN THE past two decades, active contour models (ACMs, 258 IEEE TRANSACTIONS ON IMAGE PROCESSING, VOL. 22, NO. 1, JANUARY 213 Reinitialization-Free Level Set Evolution via Reaction Diffusion Kaihua Zhang, Lei Zhang, Member, IEEE, Huihui Song, and David Zhang,

More information

Machine vision, spring 2018 Summary 4

Machine vision, spring 2018 Summary 4 Machine vision Summary # 4 The mask for Laplacian is given L = 4 (6) Another Laplacian mask that gives more importance to the center element is given by L = 8 (7) Note that the sum of the elements in the

More information

Piecewise rigid curve deformation via a Finsler steepest descent

Piecewise rigid curve deformation via a Finsler steepest descent Piecewise rigid curve deformation via a Finsler steepest descent arxiv:1308.0224v3 [math.na] 7 Dec 2015 Guillaume Charpiat Stars Lab INRIA Sophia-Antipolis Giacomo Nardi, Gabriel Peyré François-Xavier

More information

Gross Motion Planning

Gross Motion Planning Gross Motion Planning...given a moving object, A, initially in an unoccupied region of freespace, s, a set of stationary objects, B i, at known locations, and a legal goal position, g, find a sequence

More information

CSE 473/573 Computer Vision and Image Processing (CVIP)

CSE 473/573 Computer Vision and Image Processing (CVIP) CSE 473/573 Computer Vision and Image Processing (CVIP) Ifeoma Nwogu inwogu@buffalo.edu Lecture 11 Local Features 1 Schedule Last class We started local features Today More on local features Readings for

More information

Numerical Solutions of Geometric Partial Differential Equations. Adam Oberman McGill University

Numerical Solutions of Geometric Partial Differential Equations. Adam Oberman McGill University Numerical Solutions of Geometric Partial Differential Equations Adam Oberman McGill University Sample Equations and Schemes Fully Nonlinear Pucci Equation! "#+ "#* "#) "#( "#$ "#' "#& "#% "#! "!!!"#$ "

More information

Multivariable Calculus

Multivariable Calculus 2 Multivariable Calculus 2.1 Limits and Continuity Problem 2.1.1 (Fa94) Let the function f : R n R n satisfy the following two conditions: (i) f (K ) is compact whenever K is a compact subset of R n. (ii)

More information

Image Segmentation: Definition Importance. Digital Image Processing, 2nd ed. Chapter 10 Image Segmentation.

Image Segmentation: Definition Importance. Digital Image Processing, 2nd ed. Chapter 10 Image Segmentation. : Definition Importance Detection of Discontinuities: 9 R = wi z i= 1 i Point Detection: 1. A Mask 2. Thresholding R T Line Detection: A Suitable Mask in desired direction Thresholding Line i : R R, j

More information

Segmenting Images on the Tensor Manifold

Segmenting Images on the Tensor Manifold Segmenting Images on the Tensor Manifold Yogesh Rathi, Allen Tannenbaum Georgia Institute of Technology, Atlanta, GA yogesh.rathi@gatech.edu, tannenba@ece.gatech.edu Oleg Michailovich University of Waterloo,

More information

Nonlinear Diffusion. 1 Introduction: Motivation for non-standard diffusion

Nonlinear Diffusion. 1 Introduction: Motivation for non-standard diffusion Nonlinear Diffusion These notes summarize the way I present this material, for my benefit. But everything in here is said in more detail, and better, in Weickert s paper. 1 Introduction: Motivation for

More information

Simultaneous Segmentation and Object Behavior Classification of Image Sequences

Simultaneous Segmentation and Object Behavior Classification of Image Sequences Simultaneous Segmentation and Object Behavior Classification of Image Sequences Laura Gui 1, Jean-Philippe Thiran 1 and Nikos Paragios 1 Signal Processing Institute (ITS), Ecole Polytechnique Fédérale

More information

Fundamentals of Fluid Dynamics: Ideal Flow Theory & Basic Aerodynamics

Fundamentals of Fluid Dynamics: Ideal Flow Theory & Basic Aerodynamics Fundamentals of Fluid Dynamics: Ideal Flow Theory & Basic Aerodynamics Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI (after: D.J. ACHESON s Elementary Fluid Dynamics ) bluebox.ippt.pan.pl/

More information

Properties of detectors Edge detectors Harris DoG Properties of descriptors SIFT HOG Shape context

Properties of detectors Edge detectors Harris DoG Properties of descriptors SIFT HOG Shape context Lecture 10 Detectors and descriptors Properties of detectors Edge detectors Harris DoG Properties of descriptors SIFT HOG Shape context Silvio Savarese Lecture 10-16-Feb-15 From the 3D to 2D & vice versa

More information

Approximation of self-avoiding inextensible curves

Approximation of self-avoiding inextensible curves Approximation of self-avoiding inextensible curves Sören Bartels Department of Applied Mathematics University of Freiburg, Germany Joint with Philipp Reiter (U Duisburg-Essen) & Johannes Riege (U Freiburg)

More information

Image as a signal. Luc Brun. January 25, 2018

Image as a signal. Luc Brun. January 25, 2018 Image as a signal Luc Brun January 25, 2018 Introduction Smoothing Edge detection Fourier Transform 2 / 36 Different way to see an image A stochastic process, A random vector (I [0, 0], I [0, 1],..., I

More information

3 The Friedmann-Robertson-Walker metric

3 The Friedmann-Robertson-Walker metric 3 The Friedmann-Robertson-Walker metric 3.1 Three dimensions The most general isotropic and homogeneous metric in three dimensions is similar to the two dimensional result of eq. (43): ( ) dr ds 2 = a

More information

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

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

More information

A MULTISCALE APPROACH IN TOPOLOGY OPTIMIZATION

A MULTISCALE APPROACH IN TOPOLOGY OPTIMIZATION 1 A MULTISCALE APPROACH IN TOPOLOGY OPTIMIZATION Grégoire ALLAIRE CMAP, Ecole Polytechnique The most recent results were obtained in collaboration with F. de Gournay, F. Jouve, O. Pantz, A.-M. Toader.

More information

Practice Problems for the Final Exam

Practice Problems for the Final Exam Math 114 Spring 2017 Practice Problems for the Final Exam 1. The planes 3x + 2y + z = 6 and x + y = 2 intersect in a line l. Find the distance from the origin to l. (Answer: 24 3 ) 2. Find the area of

More information

Master of Intelligent Systems - French-Czech Double Diploma. Hough transform

Master of Intelligent Systems - French-Czech Double Diploma. Hough transform Hough transform I- Introduction The Hough transform is used to isolate features of a particular shape within an image. Because it requires that the desired features be specified in some parametric form,

More information

Fundamentals of Non-local Total Variation Spectral Theory

Fundamentals of Non-local Total Variation Spectral Theory Fundamentals of Non-local Total Variation Spectral Theory Jean-François Aujol 1,2, Guy Gilboa 3, Nicolas Papadakis 1,2 1 Univ. Bordeaux, IMB, UMR 5251, F-33400 Talence, France 2 CNRS, IMB, UMR 5251, F-33400

More information

c 2006 Society for Industrial and Applied Mathematics

c 2006 Society for Industrial and Applied Mathematics SIAM J. APPL. MATH. Vol. 66, No. 5, pp. 1632 1648 c 26 Society for Industrial and Applied Mathematics ALGORITHMS FOR FINING GLOBAL MINIMIZERS OF IMAGE SEGMENTATION AN ENOISING MOELS TONY F. CHAN, SELIM

More information

Aircraft Structures Kirchhoff-Love Plates

Aircraft Structures Kirchhoff-Love Plates University of Liège erospace & Mechanical Engineering ircraft Structures Kirchhoff-Love Plates Ludovic Noels Computational & Multiscale Mechanics of Materials CM3 http://www.ltas-cm3.ulg.ac.be/ Chemin

More information

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Soft-Body Physics Soft Bodies Realistic objects are not purely rigid. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Deformed

More information

CURRENT MATERIAL: Vector Calculus.

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

More information