Multigrid Eigensolvers for Image Segmentation Andrew Knyazev Supported by NSF DMS 0612751. This presentation is at

Slides:



Advertisements
Similar presentations
05/11/2005 Carnegie Mellon School of Computer Science Aladdin Lamps 05 Combinatorial and algebraic tools for multigrid Yiannis Koutis Computer Science.
Advertisements

Partitional Algorithms to Detect Complex Clusters
Modularity and community structure in networks
Siddharth Choudhary.  Refines a visual reconstruction to produce jointly optimal 3D structure and viewing parameters  ‘bundle’ refers to the bundle.
Information Networks Graph Clustering Lecture 14.
Online Social Networks and Media. Graph partitioning The general problem – Input: a graph G=(V,E) edge (u,v) denotes similarity between u and v weighted.
Clustering II CMPUT 466/551 Nilanjan Ray. Mean-shift Clustering Will show slides from:
Watermarking 3D Polygonal Meshes in the Mesh Spectral Domain Ryutarou Ohbuchi, Shigeo Takahashi, Takahiko Miyazawa, Akio Mukaiyama.
10/11/2001Random walks and spectral segmentation1 CSE 291 Fall 2001 Marina Meila and Jianbo Shi: Learning Segmentation by Random Walks/A Random Walks View.
Graph Clustering. Why graph clustering is useful? Distance matrices are graphs  as useful as any other clustering Identification of communities in social.
Lecture 21: Spectral Clustering
Spectral Clustering Scatter plot of a 2D data set K-means ClusteringSpectral Clustering U. von Luxburg. A tutorial on spectral clustering. Technical report,
Spectral Clustering 指導教授 : 王聖智 S. J. Wang 學生 : 羅介暐 Jie-Wei Luo.
CS 584. Review n Systems of equations and finite element methods are related.
Normalized Cuts and Image Segmentation Jianbo Shi and Jitendra Malik, Presented by: Alireza Tavakkoli.
Manuchehr Aminian Advisor: Prof. Andrew Knyazev University of Colorado Denver Algorithms for Generalized Image Segmentation.
Multimedia Databases SVD II. Optimality of SVD Def: The Frobenius norm of a n x m matrix M is (reminder) The rank of a matrix M is the number of independent.
Fast algorithm for detecting community structure in networks.
Eigensolvers for analysis of microarray gene expression data Andrew Knyazev (speaker) and Donald McCuan Image from
Segmentation Graph-Theoretic Clustering.
Eigensolvers for analysis of microarray gene expression data
Expanders Eliyahu Kiperwasser. What is it? Expanders are graphs with no small cuts. The later gives several unique traits to such graph, such as: – High.
Bayesian belief networks 2. PCA and ICA
Hypercubes and Neural Networks bill wolfe 10/23/2005.
Image Segmentation A Graph Theoretic Approach. Factors for Visual Grouping Similarity (gray level difference) Similarity (gray level difference) Proximity.
Novel data clustering for microarrays and image segmentation Andrew Knyazev Image from
Application of Graph Theory to OO Software Engineering Alexander Chatzigeorgiou, Nikolaos Tsantalis, George Stephanides Department of Applied Informatics.
Multigrid Eigensolvers for Image Segmentation Andrew Knyazev Supported by NSF DMS This presentation is at
Spectral Graph Theory. Outline: Definitions and different spectra Physical analogy Description of bisection algorithm Relationship of spectrum to graph.
Eigenvalue solvers for data clustering and image segmentation Andrew Knyazev Images courtesy
Spectral Graph Theory (Basics)
Domain decomposition in parallel computing Ashok Srinivasan Florida State University COT 5410 – Spring 2004.
Image Segmentation Rob Atlas Nick Bridle Evan Radkoff.
CMU SCS Large Graph Mining: Power Tools and a Practitioner’s Guide Christos Faloutsos Gary Miller Charalampos (Babis) Tsourakakis CMU.
Presented By Wanchen Lu 2/25/2013
Presenter : Kuang-Jui Hsu Date : 2011/5/3(Tues.).
Algorithms for a large sparse nonlinear eigenvalue problem Yusaku Yamamoto Dept. of Computational Science & Engineering Nagoya University.
Segmentation using eigenvectors
CSSE463: Image Recognition Day 34 This week This week Today: Today: Graph-theoretic approach to segmentation Graph-theoretic approach to segmentation Tuesday:
Segmentation using eigenvectors Papers: “Normalized Cuts and Image Segmentation”. Jianbo Shi and Jitendra Malik, IEEE, 2000 “Segmentation using eigenvectors:
Random Walks and Semi-Supervised Learning Longin Jan Latecki Based on : Xiaojin Zhu. Semi-Supervised Learning with Graphs. PhD thesis. CMU-LTI ,
Segmentation Course web page: vision.cis.udel.edu/~cv May 7, 2003  Lecture 31.
Chapter 14: SEGMENTATION BY CLUSTERING 1. 2 Outline Introduction Human Vision & Gestalt Properties Applications – Background Subtraction – Shot Boundary.
CS 219: Sparse Matrix Algorithms
DATA MINING LECTURE 13 Pagerank, Absorbing Random Walks Coverage Problems.
Fan Chung University of California, San Diego The PageRank of a graph.
Spectral Analysis based on the Adjacency Matrix of Network Data Leting Wu Fall 2009.
Domain decomposition in parallel computing Ashok Srinivasan Florida State University.
Clustering – Part III: Spectral Clustering COSC 526 Class 14 Arvind Ramanathan Computational Science & Engineering Division Oak Ridge National Laboratory,
Graphs, Vectors, and Matrices Daniel A. Spielman Yale University AMS Josiah Willard Gibbs Lecture January 6, 2016.
 In the previews parts we have seen some kind of segmentation method.  In this lecture we will see graph cut, which is a another segmentation method.
Community structure in graphs Santo Fortunato. More links “inside” than “outside” Graphs are “sparse” “Communities”
Presented by Alon Levin
Spectral Clustering Shannon Quinn (with thanks to William Cohen of Carnegie Mellon University, and J. Leskovec, A. Rajaraman, and J. Ullman of Stanford.
A Tutorial on Spectral Clustering Ulrike von Luxburg Max Planck Institute for Biological Cybernetics Statistics and Computing, Dec. 2007, Vol. 17, No.
Normalized Cuts and Image Segmentation Patrick Denis COSC 6121 York University Jianbo Shi and Jitendra Malik.
Laplacian Matrices of Graphs: Algorithms and Applications ICML, June 21, 2016 Daniel A. Spielman.
CS 140: Sparse Matrix-Vector Multiplication and Graph Partitioning
High Performance Computing Seminar II Parallel mesh partitioning with ParMETIS Parallel iterative solvers with Hypre M.Sc. Caroline Mendonça Costa.
Laplacian Matrices of Graphs: Algorithms and Applications ICML, June 21, 2016 Daniel A. Spielman.
High Performance Computing Seminar
Spectral clustering of graphs
A Continuous Optimization Approach to the Minimum Bisection Problem
Segmentation Graph-Theoretic Clustering.
Grouping.
Approximating the Community Structure of the Long Tail
Spectral Clustering Eric Xing Lecture 8, August 13, 2010
3.3 Network-Centric Community Detection
CS 565 Computer Vision Nazar Khan Lecture 11.
“Traditional” image segmentation
Presentation transcript:

Multigrid Eigensolvers for Image Segmentation Andrew Knyazev Supported by NSF DMS This presentation is at 1

Eigensolvers for image segmentation: Clustering: how? Spectral clustering and partitioning Partitioning as image segmentation Eigensolvers for spectral clustering Multi-resolution image segmentation References Conclusions 2

Clustering: how? The overview There is no good widely accepted definition of clustering. The traditional graph-theoretical definition is combinatorial in nature and computationally infeasible. Heuristics rule! Good open source software, e.g., METIS and CLUTO. Clustering can be performed hierarchically by agglomeration (bottom-up) and by division (top-down). 3 Agglomeration clustering example

Clustering: how? Algorithms Partitioning means determining clusters. Partitioning can be used recursively for hierarchical division (top-down). Many partitioning methods are known. Here we cover: Spectral partitioning using Fiedler vectors = Principal Components Analysis (PCA)‏ PCA/spectral partitioning is known to produce high quality clusters, but is considered to be expensive as solution of large-scale eigenproblems is required. Our expertise in eigensolvers comes to the rescue! 4

Eigenproblems in mechanical vibrations Free transversal vibration without damping of the mass-spring system is described by the ODE system 5 Standing wave assumption leads to the eigenproblem Images courtesy Component x i describes the up-down movement of mass i.

6 Spectral clustering in mechanics A 4-degree-of-freedom system has 4 modes of vibration and 4 natural frequencies: partition into 2 clusters using the second eigenvector: Images Courtesy: Russell, Ketteriung U. The main idea comes from mechanical vibrations and is intuitive: in the spring-mass system the masses which are tightly connected will have the tendency to move together synchronically in low-frequency free vibrations. Analysing the signs of the components corresponding to different masses of the low-frequency vibration modes of the system allows us to determine the clusters of the masses!

7 A = symmetric adjacency matrix D = diagonal degree matrix Laplacian matrix L = D – A Spectral clustering for simple graphs Undirected graphs with no self- loops and no more than one edge between any two different vertices L=K describes transversal vibrations of the spring-mass system (as well as Kirchhoff's law for electrical circuits of resistors)

8 The Fiedler eigenvector gives bi-partitioning by separating the positive and negative components only By running the K-means on the Fiedler eigenvector one could find more then 2 partitions if the vector is close to piecewise-constant after reordering The same idea for more then one eigenvectors (multi-way) Rows sum to zero Spectral clustering for simple graphs Example Courtesy: Blelloch CMU The Laplacian matrix L is symmetric with the zero smallest eigenvalue and constant eigenvector (free boundary). The second eigenvector, called the Fiedler vector, describes the partitioning.

PCA clustering for simple graphs 9 The Fiedler vector is an eigenvector of Lx= λ x, in the spring- mass system this corresponds to the stiffness matrix K=L and to the mass matrix M=I (identity) Should not the masses with a larger adjacency degree be heavier? Let us take the mass matrix M=D -the degree matrix So-called N-cut smallest eigenvectors of Lx= λD x are the largest for Ax= µD x with µ=1-λ since L=D-A PCA for D -1 A computes the largest eigenvectors, which then can be used for clustering by the K-means D -1 A is row-stochastic and describes the Markov random walk probabilities on the simple graph

10 Partitioning as image segmentation Image pixels serve as graph vertices. We generate a sparse Laplacian, by comparing neighboring only 5 or 9 pixels here when calculating the weights for the edges by comparing pixel colors. Here is an example displaying on the right 4 Fiedler vectors of an image on the left. The actual values of vectors’ components are shown at every pixel.

11 Eigensolvers for spectral clustering Our BLOPEX-LOBPCG software has proved to be efficient for large-scale eigenproblems for Laplacians from PDE's and for image segmentation using multiscale preconditioning of hypre The LOBPCG for massively parallel computers is available in our Block Locally Optimal Preconditioned Eigenvalue Xolvers (BLOPEX) package BLOPEX is built-in in and is included as an external package in PETSc, see On BlueGene/L 1024 CPU we can compute the Fiedler vector of a 24 megapixel image in seconds (including the hypre algebraic multigrid setup).

Multi-resolution image segmentation Bipartitioning for 9-Point Stencil. Left to right: Original - Spectral - NCUT - Spectral Line - NCUT Line. Top to bottom: 2856, 53482, 95904, pixels images 12 Image ``Very Large Telescope at Paranal'' in the Atacama desert region in Chile from the European Southern Observatory web site

Multiresolution image segmentation Direct bisection of the highest resolution image may be better quality compared to multiresolution segmentation Multiway clustering using several eigenvectors may help multiresolution segmentation smallest eigenvalues of L and D -1 L for different image scaling

References AK, Toward the Optimal Preconditioned Eigensolver: Locally Optimal Block Preconditioned Conjugate Gradient Method. SISC 23 (2001), AK and K. Neymeyr, Efficient solution of symmetric eigenvalue problems using multigrid preconditioners in the locally optimal block conjugate gradient method. ETNA, 15 (2003), AK, I. Lashuk, M. E. Argentati, and E. Ovchinnikov, Block Locally Optimal Preconditioned Eigenvalue Xolvers (BLOPEX) in hypre and PETSc. SISC. 25(2007),

15 Conclusions Spectral Clustering is an intuitive and powerful tool for image segmentation. Our eigenxolvers efficiently perform image segmentation using Hypre’s algebraic multigrid preconditioning on parallel computers. Segmentation using smaller resolutions of the same image, e.g., to construct initial approximations for higher resolutions, could accelerate the process, but requires multi-way computations involving several eigenvectors.