This paper was converted on www.awesomepapers.org from LaTeX by an anonymous user.
Want to know more? Visit the Converter page.

Refer to caption
Figure 1. We present a method to simplify geometry while preserving targeted bandwidths in a customizable spectral domain. The generalized spectral domain is an input to our algorithm and can be defined as a combination of multiple discrete Laplacian operators. Our method includes a simple “lifting” operator to enable the workflow shown on the right. The example shows the calculation of biharmonic distances over a tetrahedral mesh of an engine part with 20 small holes that are preserved.

Generalized Spectral Coarsening

Alexandros D. Keros The University of Edinburgh10 Crichton StreetEdinburghScotlandEH8 9ABUK a.d.keros@sms.ed.ac.uk  and  Kartic Subr The University of Edinburgh10 Crichton StreetEdinburghScotlandEH8 9ABUK k.subr@ed.ac.uk
Abstract.

Many computational algorithms applied to geometry operate on discrete representations of shape. It is sometimes necessary to first simplify, or coarsen, representations found in modern datasets for practicable or expedited processing. The utility of a coarsening algorithm depends on both, the choice of representation as well as the specific processing algorithm or operator. e.g. simulation using the Finite Element Method, calculating Betti numbers, etc. We propose a novel method that can coarsen triangle meshes, tetrahedral meshes and simplicial complexes. Our method allows controllable preservation of salient features from the high-resolution geometry and can therefore be customized to different applications.

Salient properties are typically captured by local shape descriptors via linear differential operators – variants of Laplacians. Eigenvectors of their discretized matrices yield a useful spectral domain for geometry processing (akin to the famous Fourier spectrum which uses eigenfunctions of the derivative operator). Existing methods for spectrum-preserving coarsening use zero-dimensional discretizations of Laplacian operators (defined on vertices). We propose a generalized spectral coarsening method that considers multiple Laplacian operators defined in different dimensionalities in tandem. Our simple algorithm greedily decides the order of contractions of simplices based on a quality function per simplex. The quality function quantifies the error due to removal of that simplex on a chosen band within the spectrum of the coarsened geometry.

geometry processing, numerical coarsening, spectral geometry
ccs: Computing methodologies Shape analysis

1. Introduction

Discrete representations of shape are ubiquitous across computer graphics applications. Meshes, a common choice for computer graphics applications, are specific instances of general abstractions called simplicial complexes. While the vertices of a mesh are commonly embedded (have explicit coordinates) in 2D or 3D, simplicial complexes capture abstract relationships between nodes – as extensions of graphs by including 3-ary (triangles), 4-ary (tetrahedra) and higher dimensional-relationships. We develop an algorithm to coarsen simplicial complexes of arbitrary dimensionality.

The choice of discretization has a profound impact on downstream applications that operate on the geometry, both in terms of efficiency as well as numerical stability. Simplification schemes are used to reduce the number of discrete elements while preserving quality. Quality can defined either in terms of aesthetic appeal (direct rendering, visualization, etc.) or functionally (finite element simulation, topological data analysis, geometry processing algorithms, etc.). We focus on the latter and propose a coarsening algorithm that can be tailored to different applications via a versatile definition of functionally salient features .

We resort to classical spectral theory to formalize the definition of qualities of the input representation which should be preserved while coarsening. Just as the famous Fourier spectrum is obtained via projection onto the eigenfunctions of the univariate derivative operator, our spectral domain of choice is defined via a projection onto a Laplacian operator. Unlike the univariate derivative operator, a variety of definitions exist for Laplacians. For discrete Laplacians, these usually arise from the elements of choice (vertices, edges, triangles, etc.) and their associated weights. The choice of the variant of Laplacian considered impacts the utility of the coarsened mesh in applications. For example, simplification of the domain of a physics simulation requires the preservation of the spectra of both 0- and 1-dimensional Laplacians (De Witt et al., 2012). The input to our algorithm includes a list of Laplacians and associated spectral bands – each band is a subspace in the spectrum corresponding to a Laplacian. Its output is a coarsened representation that preserves the spectral profile in the specified bands.

To summarize, we propose a coarsening algorithm for simplicial complexes that can preserve spectral bands of different Laplacians, across different dimensionalities of simplices. Our simple algorithm operates by first evaluating a quality function per simplex, which quantifies the error introduced by contracting (eliminating) that simplex towards the specified spectral band(s) to be preserved. Then, we greedily perform contractions iteratively by choosing candidates with minimum error until the target coarsening level is reached. Thus, our coarsening algorithm is agnostic to the specific Laplacian considered. Our contributions in this paper are:

  • a novel coarsening operator that is Laplacian-independent;

  • a coarsening operator that simultaneously preserves spectral bands associated with multiple Laplacians;

  • an algorithm for band-pass filtering of simplicial complexes.

We evaluate our method using a variety of surface (triangular) and volumetric (tetrahedral) meshes, as well as simplicial complexes.

2. Related Work

Graphs

The spectrum of a combinatorial graph Laplacian reveals fundamental geometric and algebraic properties of the underlying graph (Chung, 1999). Several works attempt to preserve spectral subspaces, while reducing the size of input graphs (Chen et al., 2022). A notable example (Loukas, 2019) proposes an iterative, parallelizable solution to preserve spectral subspaces of graphs by minimizing undesirable projections.

Meshes

Seminal works for coarsening triangle meshes propose localized and iterative operations via edge collapses based on visual criteria (Garland and Heckbert, 1997; Ronfard and Rossignac, 1996). Similar methods have also been applied to tetrahedral mesh simplification, based on volume, quadric-based, and isosurface-preserving criteria (Chopra and Meyer, 2002; Vo et al., 2007; Chiang and Lu, 2003). Recent methods formulate coarsening as an optimization problem subject to various sparsity conditions (Liu et al., 2019), by detaching the mesh from the operator (Chen et al., 2020) and localizing error computation to form a parallelizable strategy (Lescoat et al., 2020). The cotan Laplacian is a popular choice, and has also been used, via its functional maps, to identify correspondences between partial meshes (Rodolà et al., 2017) .

Simplicial complexes and computational topology

The link condition (Dey et al., 1998) is a combinatorial criterion ensuring that homology is preserved while performing strong collapses (merging vertices as opposed to edge removal), with extended applications and extensions to persistent homology (Wilkerson et al., 2013; Boissonnat and Pritam, 2019). Edge collapses in the form of edge removals (Boissonnat and Pritam, 2020; Glisse and Pritam, 2022) is a state-of-the-art method for simplifying filtered flag simplicial complexes while preserving their (persistent) homology. These methods focus on the dimensionality of the null space (kernel) of the Laplacian. They rarely investigate the general spectral profile of the reduced complex. Notable exceptions (Osting et al., 2017; Black and Maxwell, 2021; Hansen and Ghrist, 2019) apply the method of effective resistances (Spielman and Srivastava, 2011) for coarsening complexes, and cellular sheaves, respectively.

Spectral analysis

The Laplacian makes frequent appearances across geometry processing, machine learning and computational topology. Its specific definitions and flavours vary widely across domains, such as discrete exterior calculus (Desbrun et al., 2005; Crane et al., 2013), vector-field processing (Vaxman et al., 2016; Poelke and Polthier, 2016; de Goes et al., 2016; Wardetzky, 2020; Zhao et al., 2019b), fluid simulation (Liu et al., 2015), mesh segmentation and editing (Lai et al., 2008; Khan et al., 2020; Sorkine et al., 2004), topological signal processing (Barbarossa and Sardellitti, 2020), random walk representations (Lahav and Tal, 2020; Schaub et al., 2020), clustering and learning (Su et al., 2022; Nascimento and De Carvalho, 2011; Ebli and Spreemann, 2019; Ebli et al., 2020; Keros et al., 2022; Smirnov and Solomon, 2021). Its ability to effectively capture salient geometric, topological, and dynamic information of the object of interest makes its spectrum a versatile basis.

The de-facto Laplacian operator used in mesh processing is the Laplace-Beltrami operator which is approximated via a discretization called the cotan Laplacian defined on vertices (0D) with vertex and edge weights. A multitude of other Laplacians have been shown to accommodate non-manifold meshes (Sharp and Crane, 2020), FEM simulations (Ayoub et al., 2020), digital surfaces (Caissard et al., 2019), polygonal meshes (Bunge et al., 2021) and arbitrary simplicial complexes (Ziegler et al., 2022).

Motivation

The variety of definitions and properties of Laplacian operators (see Figure 1) suggests that a unified spectral coarsening algorithm could impact a range of applications. Our Laplacian-agnostic spectral coarsening can be tailored by considering the weightings as special cases of Hodge Laplacians. We achieve this by adapting the cost function proposed for graph theory (2019) to simplicial complexes and incorporating it within a standard mesh-coarsening framework (Garland and Heckbert, 1997).

3. Background

3.1. Simplicial Complexes & Meshes

A simplicial complex KK is constructed by considering appropriate subsets of a finite set VV of vertices. Each element vVv\in V exists in KK as a singleton set {v}\{v\}. KK also contains σ={v0,,vk}V\sigma=\{v_{0},\dots,v_{k}\}\subset V which is called a kk-simplex of dimension k=dimσ=|σ|1k=\text{dim}\,\sigma=|\sigma|-1. e.g.  edges (k=1k=1), triangles (k=2k=2), tetrahedra (k=3k=3), etc. For every such σK\sigma\in K, all of σ\sigma’s subsets τσ\tau\subset\sigma are also included in KK. The dimension of the simplicial complex is the maximal dimension of its simplices: dimK=maxσKdimσ\text{dim}\,K=\max_{\sigma\in K}\text{dim}\,\sigma. A graph G=(V,E)G=(V,E) is a 1-dimensional simplicial complex. Another well known special case is a triangle mesh (V,E,F)(V,E,F), which is a 2-dimensional embedded simplicial complex often with additional manifold conditions on the adjacencies of 2-simplices (faces) FF. A tetrahedral mesh is a 3-dimensional embedded simplicial complex.

For a graph G=(V,E)G=(V,E), the incidence matrix A:EVA:E\rightarrow V where Av,e=1A_{v,e}=1 (or 1-1) depending on whether e:vve:v\rightarrow v^{\prime} (or e:vve:v^{\prime}\rightarrow v respectively) and zero otherwise, represents directed connectivity between vertices and edges. Boundary matrices ϑk:[Kk][Kk1]\vartheta_{k}:\mathbb{R}[K_{k}]\rightarrow\mathbb{R}[K_{k-1}] extend this idea to higher dimensions and capture connectivity between (the vector space with real coefficients spanned by) the kk-simplices KkK_{k} and their bounding Kk1K_{k-1} simplices. For convenience boundary operators are constructed by imposing an ordering on the vertices V=K0V=K_{0}, such that each kk-simplex can be expressed by an ordered list σ=[v0,,vk]\sigma=[v_{0},\dots,v_{k}].

The orientation of the simplices in a simplicial complex is dictated by the ordering imposed on the vertices, and the orientation of mesh elements given by the cyclic ordering of vertices. The boundary action is then applied on each simplex σ\sigma according to ϑk(σ)=i=0d(1)iσi,\vartheta_{k}(\sigma)=\sum_{i=0}^{d}(-1)^{i}\sigma_{-i}, where σi:=[v0,,v^i,,vk]\sigma_{-i}:=[v_{0},\dots,\hat{v}_{i},\dots,v_{k}] indicates the deletion of the ii-th vertex from σ\sigma, resulting in a (k1)(k-1)-dimensional bounding simplex. The following figure illustrates a complex along with its three boundary matrices: white cells are zeros and grey cells are ±1\pm 1.

[Uncaptioned image]

3.2. Hodge Laplacian as a generalization

Hodge Laplacians (Rosenberg and Steven, 1997) are differential operators that extend the notion of the well-known graph and mesh Laplacians to higher-dimensional simplicial complexes. It is defined, for each dimension kk, as the sum of a two maps from kk-simplices: one mapping down to (k1)(k-1)-simplices and another mapping up to (k+1)(k+1)-simplices. Each map is defined via its appropriate boundary matrix:

Lkrw\displaystyle L_{k}^{\text{rw}}\;\; =\displaystyle= Lkdown+Lkup\displaystyle L_{k}^{\text{down}}+L_{k}^{\text{up}}\;\; =\displaystyle= ϑkTWk11ϑkWk+Wk1ϑk+1Wk+1ϑk+1T.\displaystyle\vartheta_{k}^{T}W_{k-1}^{-1}\vartheta_{k}W_{k}+W_{k}^{-1}\vartheta_{k+1}W_{k+1}\vartheta_{k+1}^{T}.

WkW_{k} are diagonal matrices that contain a weight per kk-simplex. The superscript clarifies that LkrwL_{k}^{\text{rw}} is the random walk kk-Hodge Laplacian – an antisymmetric linear map from kk-simplices to kk-simplices. It can be symmetrized, while preserving its spectral properties, as Lkw=Wk1/2LkrwWk1/2L_{k}^{w}=W_{k}^{-1/2}\,L_{k}^{\text{rw}}\,W_{k}^{-1/2}. We direct the reader to key works (Horak and Jost, 2013; Lim, 2020) that present a thorough treatment of Hodge Laplacians and their spectra. We refer to LkwL_{k}^{w} as the weighted kk-Hodge Laplacian and to its unweighted (unit weights) version LkL_{k} as simply the kk-Hodge Laplacian.

Most variants of Laplacians used in graph- and mesh-processing may be derived as special cases of the weighted kk-Hodge Laplacian. The graph Laplacian is a 0-Hodge Laplacian with unit weight on vertices Lgraph=L0rw=L0up=ϑ1W1ϑ1TL^{\text{graph}}=L_{0}^{\text{rw}}=L_{0}^{\text{up}}=\vartheta_{1}W_{1}\vartheta_{1}^{T}. The cotan Laplacian, popular as the stiffness matrix in finite element methods, is the 0-Hodge Laplacian with different weights assigned to vertices and edges:

wvi=σ={vi,vj,vk}K2𝒜σ/3\displaystyle w_{v_{i}}=\sum_{\forall\sigma=\{v_{i},v_{j},v_{k}\}\in K_{2}}\mathcal{A}_{\sigma}/3 ,\displaystyle,\;\;\; weij=12(cotθlij+cotθmij).\displaystyle w_{e_{ij}}=\frac{1}{2}(\cot\theta_{lij}+\cot\theta_{mij}).

𝒜σ\mathcal{A}_{\sigma} is the area of face σ\sigma, and θlij\theta_{lij} is the angle at vertex vlv_{l} facing the edge ei,j={vi,vj}e_{i,j}=\{v_{i},v_{j}\}. Figure 1 (left) depicts the impact of the choice of Laplacian on the coarsened Fertility triangle mesh.

Hodge Spectra

Every basis of the vector space k\mathcal{H}_{k} of a complex KK is spanned by a representative of equivalence classes of kk-dimensional nontrivial loops, and is isomorphic to the kernel of the kk-Hodge Laplacian (Eckmann, 1944): kerLkk(K)\ker L_{k}\simeq\mathcal{H}_{k}(K). The eigenvectors of LkL_{k} corresponding to zero eigenvalues (the harmonic part of the spectrum) are minimal representatives of their respective homology classes. An eigenvector corresponding to a non-zero eigenvalue of LkrwL^{\text{rw}}_{k}, must either be an eigenvector of LkupL_{k}^{up} or LkdownL_{k}^{\text{down}} with the same eigenvalue. Furthermore, an element of the nullspace of LkrwL_{k}^{\text{rw}} must be in the kernel of both of its components. Given an eigenpair (λi,vi)(\lambda_{i},v_{i}) of LkdownL_{k}^{\text{down}} then (λi,ϑkvi)(\lambda_{i},\vartheta_{k}v_{i}) is an eigenpair of Lk1upL_{k-1}^{\text{up}} (Torres and Bianconi, 2020; Horak and Jost, 2013). The Hodge decomposition ties everything together, by expressing the space of kk-simplices KkK_{k} as a direct sum of gradients, curls, and harmonics:

Kk=imϑkTimϑk+1kerLk.K_{k}=\text{im}\vartheta_{k}^{T}\oplus\text{im}\vartheta_{k+1}\oplus\ker L_{k}.

We refer to several excellent introductions (Lim, 2020; Chen et al., 2021) to Hodge decompositions.

4. Method

We propose a simple iterative algorithm for coarsening a simplicial complex based on two inputs: the fraction of simplices to be reduced and the portion of the input spectrum needing to be preserved. We use the latter to construct a quality function that is evaluated at each simplex. Then we greedily contract a simplex (or a group of simplices with low spectral-quality scores). We recalculate the quality function for simplices in the coarsened complex and iterate until the specified number of simplices have been reduced.

Refer to caption
Figure 2. An illustrated overview of our algorithm.

4.1. Quality function

Each contraction (e.g. edge collapse) can be defined as a projection Pk:KkK^kP_{k}:K_{k}\rightarrow\hat{K}_{k} mapping kk-simplices in the input complex to those in the coarsened complex. Ideally, the eigenspace to be preserved should be perpendicular to that induced by the contraction. Intuitively the projection of the former onto the latter measures “spectral leak”, with a large value indicating that the contraction leads to loss of fidelity with respect to the specified target spectrum.

Let the eigenspace to be preserved be represented by eigenvectors UU and eigenvalues SS (diagonal matrix) of the Hodge Laplacian LkwL_{k}^{\text{w}} (or LkL_{k}) of the input complex, and let Ak=US+A_{k}=U\sqrt{S^{+}} be the preserved subspace. Since PP and its pseudoinverse Pk+=PkTD2P^{+}_{k}=P_{k}^{T}D^{-2}, where DD is a diagonal (normalizing) matrix containing row norms, map in opposite directions to and from the output complex, the operator Π=Pk+Pk\Pi=P_{k}^{+}P_{k} projects a signal defined on the fine complex down to the coarsened complex and back up to the fine complex.

Ideally, we seek contractions where ΠkAk\Pi_{k}A_{k} is identical to AkA_{k} by minimizing ΠkAkAk\|\Pi_{k}A_{k}-A_{k}\|_{\bullet}. Our quality function ck:Kkc_{k}:K_{k}\rightarrow\mathbb{R}

(1) ck=ΠkAkL,c_{k}=\|\Pi_{k}^{\perp}\;A_{k}^{\ell}\|_{L},

where the perpendicular projection Πk=(𝕀Πk)\Pi_{k}^{\perp}=(\mathbb{I}-\Pi_{k}), quantifies spectral error. Here xL=xTLx\|x\|_{L}=\sqrt{x^{T}Lx} denotes the LL-norm. The above definition of cc in terms of Πk\Pi^{\perp}_{k} allows for localized error computations, facilitating parallelization, since the nonzero entries of Πk\Pi^{\perp}_{k} only refer to simplices affected by the contraction. This quality function, has been analyzed to have desirable theoretical properties when applied to graph simplification and general positive semidefinite matrices (Loukas, 2019).

4.2. Contraction

The first step to performing contractions, or setting equivalences of multiple simplices, is to identify a set Φ\Phi of candidate contraction sets ϕiΦ\phi_{i}\in\Phi. We execute edge collapses by setting each ϕi\phi_{i} to be an edge. More complicated contractions, such as collapsing stars around vertices, may be performed by identifying the relevant Φ={ϕi}\Phi=\{\phi_{i}\}.

Then, we evaluate the quality function over each candidate contraction set and greedily contract the set ϕ\phi^{*} with the minimum quality. This involves identifying all the simplices in ϕ\phi^{*} to one, target, vertex. As a result, the complex is coarsened while best preserving the spectral band (U,S)(U,S) of LkL_{k}. In practice, we apply such contractions iteratively until a specified ratio of simplices has been contracted, with some additional bookkeeping at each level \ell: starting from Ak=0=US+A^{\ell=0}_{k}=U\sqrt{S^{+}}, we update the target subspace and the corresponding projection matrices PkP^{\ell}_{k} and Πk\Pi^{\ell}_{k}, with AkA_{k}^{\ell} tracking the evolution of the desired spectrum at each iteration.

4.3. Multiple Laplacian subspaces

The quality function (Equation 1) can be adapted so that the target subspace is shaped via multiple spectral bands. We define cost functions ck,νc_{k}^{\ell,\,\nu} at level \ell independently for BB different spectral bands ν=1,2,,B\nu=1,2,\cdots,B. Each of these is associated with a potentially different Laplacian. The aggregate cost function can then be tailored based on the specific downstream application as qagg:Bq_{\text{agg}}:\mathbb{R}^{B}\rightarrow\mathbb{R} to obtain the final quality function ck=qagg({ck,ν}),ν[0,1,,B].c^{\ell}_{k}=q_{\text{agg}}(\{c^{\ell,\,\nu}_{k}\}),\;\;\nu\in[0,1,\cdots,B].

In our experiments in Section 5, where L0L_{0}, L1L_{1} and L2L_{2} are considered in tandem, we simply average the contributions of the different Laplacians qagg(ckv)=1Bk,vckvq_{\text{agg}}({c^{v}_{k}})=\frac{1}{B}\sum_{k,v}c^{v}_{k}. Algorithm 1 shows our generalized coarsening procedure by assembling the above stages.

1
inputs : 
K={Kk}K=\{K_{k}\};
  // high-resolution simplicial complex
2
ρ\rho ;
  // fraction of simplices to reduce
{(S0,U0),,(SB,UB)}\{(S_{0},U_{0}),\dots,(S_{B},U_{B})\} ;
  // target subspaces to preserve
L={L0,,LB}L=\{L_{0},\dots,L_{B}\} ;
  // Laplacians corresponding to subspaces
3
output : 
K^\hat{K} ;
  // Coarsened complex
PkP_{k} ;
  // projection matrices (fine to coarse)
4   K^K\hat{K}\leftarrow K;
5 0\ell\leftarrow 0 ;
6
7while  1|K^|/|K|<ρ1-|\hat{K}|/|K|<\rho  do
       Define Φ\Phi ;
        // say, set of all edges of K^\hat{K}
8      
9      foreach  subspace (Sν,Bn)(S_{\nu},B_{n}) do
10             if =0\ell=0 then
11                   MνUνSν+1/2M^{\ell}_{\nu}\leftarrow U_{\nu}S_{\nu}^{+1/2};
12                   AνMνA^{\ell}_{\nu}\leftarrow M^{\ell}_{\nu};
13                  
14            else
                   LνPLν1P+L^{\ell}_{\nu}\leftarrow P^{\ell\mp}L^{\ell-1}_{\nu}P^{\ell+} ;
                    // coarsened Laplacian
15                   MνPMν1M^{\ell}_{\nu}\leftarrow P^{\ell}M^{\ell-1}_{\nu};
                   AνM(MνTLνMν)+1/2A^{\ell}_{\nu}\leftarrow M^{\ell}({M^{\ell}_{\nu}}^{T}L^{\ell}_{\nu}M^{\ell}_{\nu})^{+1/2} ;
                    // coarse target subspace
16                  
17            
18      
19      foreach set of simplices ϕΦ\phi\in\Phi do
20             Π(𝕀P+P)\Pi^{\perp}\leftarrow(\mathbb{I}-P^{+}P);
21             foreach  subspace (Sν,Bν)(S_{\nu},B_{\nu})  do
22                   cϕ,νΠAνc^{\ell,\,\nu}_{\phi}\leftarrow\|\Pi^{\perp}A^{\ell}_{\nu}\| ;
23                  
            cϕqagg({cϕ,ν})c^{\ell}_{\phi}\leftarrow q_{\text{agg}}(\{c^{\ell,\,\nu}_{\phi}\}) ;
              // user-specified aggreg. function
24            
25      
26      (K^,P)Contract(K^,argminϕ{cϕ})(\hat{K},P^{\ell})\leftarrow\mathrm{Contract}(\hat{K},\operatorname*{\arg\!\min}_{\phi}\{c^{\ell}_{\phi}\});
27       +1\ell\leftarrow\ell+1;
28      
29
ALGORITHM 1 Iterative generalized spectral coarsening

4.4. Implementation details

Terms of the Hodge Laplacian

Due to the interplay of spectra of LkL_{k} and Lk+1L_{k+1} discussed in Section 3.2, constraints on Laplacians for multiple kk can potentially introduce ‘spectral conflicts’. We avoid this by considering only the LkupL_{k}^{\text{up}} components of the chosen Laplacians for each kk. For wide spectral bands and appropriate choice of kk, the spectral region of interest will be a subspace of the spectrum of LkupL_{k}^{\text{up}} and thus preserved.

Building coarsening matrices PkP_{k}

During contraction, let zz be the index of a contracted simplex in KK, tt be the index of the target simplex in K^\hat{K} and |ϕ||\phi| bet the cardinality of the candidate family being contracted. PkP_{k} is then a simplicial map KkK^kK_{k}\rightarrow\hat{K}_{k} where every kk-simplex of KK maps to a valid simplex of K^\hat{K}, or to zero. For consistency, it is required that ϑ^kPk=Pk1ϑk\hat{\vartheta}_{k}P_{k}=P_{k-1}\vartheta_{k}. To satisfy desirable spectral approximation guarantees (Loukas, 2019) and for P+=PTD2P^{+}=P^{T}D^{-2} to hold, we set the elements of each contraction set as Pt,z=1|ϕ|P_{t,z}=\frac{1}{|\phi|}, for all zϕz\in\phi, where ϕt\phi\mapsto t. We resolve the ambiguity of the choice of target simplex by consistently selecting the target simplex based on its index. e.g. for edge contractions, both vertices are merged into one with the smaller index.

Choosing candidate families Φ\Phi

Our algorithm is agnostic of the choice of combinations of simplices Φ\Phi to be contracted. We tested with various candidate families: edges (pairs of vertices), faces (triplets of vertices) and more general vertex neighborhoods consisting of closed-stars. Larger contraction sets result in aggressive coarsening at each iteration which leads to larger spectral error. All results in this paper use only edge collapses. This also simplifies comparison to related work (which are restricted to edge collapses).

Harmonic subspaces

For k>0k>0, the harmonic portion of the spectrum of LkL_{k} is non-trivial and encodes information about non-trivial cycles called homology generators. A homology group k\mathcal{H}_{k} is a vector space of cycles that are not bounding higher dimensional simplices and therefore manifest as the null space of LkL_{k}. It is often desirable to preserve these eigenvectors, despite their coresponding zero eigenvalue, to maintain topological consistency. In practice, for all experiments we use modified eigenvalues S~=𝕀+S\tilde{S}=\mathbb{I}+S when dealing with spectral of higher-dimensional Laplacians.

Local Delaunay vertex position optimization

Edge contractions may produce self-intersections, particularly if a fixed vertex-placement policy is followed, say, at the midpoint of an edge. While there are methods to avoid this effectively (Sacht et al., 2013), we adopted a simple vertex positioning scheme for tetrahedral meshes to prevent intersections.

[Uncaptioned image]

Our scheme operates in four steps: (1) identify the faces in the link of the edge being collapsed; (2) construct the Delaunay tetrahedralization of the vertices of these faces; (3) choose barycenters of the new tetrahedra that are on the same side of the faces in 1 as the corresponding vertex of the edge being collapsed; (4) the output vertex is the centroid of all vertices that pass the test in 3. If no vertices pass the test in 3 then we do not perform the collapse.

Ref . (11385 v.) 5000 verts. 3000 verts. 1000 verts.
Refer to caption Refer to caption Refer to caption Refer to caption
kk Π\|\cdot\|_{\Pi^{\perp}} Lc\|\cdot\|_{L_{\text{c}}} Cconf\|\cdot\|_{C_{\text{conf}}} sub\|\cdot\|_{\text{sub}} Θ\|\cdot\|_{\Theta} λ\|\cdot\|_{\lambda}
5000 v. 0 39.126 1.023 7.855 0.010 13.8 9.07
1 73.351 0.007 1.251 0.183 8.4 5.165
2 83.015 0.003 1.241 0.174 2.95 2.52
3000 v. 0 61.272 3.298 13.506 0.002 8.17 19.51
1 91.813 0.013 1.723 0.381 2.48 10.138
2 97.56 0.004 1.583 0.489 0.44 4.89
1000 v. 0 87.90 8.266 26.511 0.009 2.45 55.53
1 97.72 0.026 2.804 0.532 0.75 23.139
2 99.60 0.011 2.434 0.709 0.07 11.34
Figure 3. Spectral error increases controllably as the reference tetrahedral mesh (top left) with 11,38511,385 vertices is progressively coarsened while preserving the spaces spanned by the first 100100 eigenvectors of three Laplacians: Lk,k=0,1and 2L_{k},\,k=0,1\,\mathrm{and}\,2.
kk Π\|\cdot\|_{\Pi^{\perp}} Lc\|\cdot\|_{L_{\text{c}}} Cconf\|\cdot\|_{C_{\text{conf}}} sub\|\cdot\|_{\text{sub}} Θ\|\cdot\|_{\Theta} λ\|\cdot\|_{\lambda}
triangle mesh
ours 0 9.94 5.6𝐞𝟓\mathbf{5.6\,e5} 𝟐𝟑𝟗𝟑\mathbf{2393} 1.5e41.5\,e{4} 37.314 𝟏𝟗𝟖\mathbf{198}
baseline 0 6.82\mathbf{6.82} 2.6e72.6\,e7 4738 𝟐𝟑𝟏𝟏\mathbf{2311} 21.127\mathbf{21.127} 5648
ours 1 31.35 0.008\mathbf{0.008} 0.787\mathbf{0.787} 0.350 0.805\mathbf{0.805} 0.590
baseline 1 27.82\mathbf{27.82} 0.018 0.827 0.159\mathbf{0.159} 2.555 0.635
tetrahedral mesh
ours 0 22.379 142 130 3.1e43.1\,e{4} 24.58 1.827
ours 1 83.90 0.030 2.206 0.174 4.999 9.581
ours 2 91.14 0.007 1.696 0.287 1.289 1.938
Figure 4. A comparison of spectral error resulting from our method to the baseline on a Suzanne triangle mesh (top portion) using different metrics. The bottom portion reports spectral errors on a Fertility tetrahedral mesh.

5. Results

Unless otherwise specified, we use a common low-pass constraint as the default for experiments: to preserve the space spanned by the first 100100 eigenvectors of the specified Laplacian(s).

5.1. Meshes

2D Baseline

To enable comparisons of Lk,k=1L_{k},\;k=1 for triangle meshes we extend previous work (Lescoat et al., 2020) as a baseline. Their method minimizes spectral error E=PM1LFM~1L~PFM~2,E=\|PM^{-1}LF-\tilde{M}^{-1}\tilde{L}PF\|_{\tilde{M}}^{2}, where PP is a coarsening projection matrix, MM is a mass matrix, LL is a differential operator, and FF is the spectrum of interest as a matrix of eigenvectors. A tilde above the respective notations denotes their coarsened versions. From their output coarsening matrix P0P_{0} we additionally infer coarsening matrices P1P_{1} and P2P_{2} which operate on the space of edges and faces respectively. However, they do not consider higher dimensional mappings in their error metric. Since they only consider one Laplacian L0cotL_{0}^{\mathrm{cot}}, we include this as one of the targets in all our comparisons, unless stated otherwise. We visualize spectral preservation via functional maps (Liu et al., 2019; Lescoat et al., 2020; Chen et al., 2020) C=UcTPUC=U_{c}^{T}PU which is a diagonal matrix when the input and output spectra match perfectly. Unfortunately, it is not straightforward to compare with prior non-spectal tetrahedral coarsening methods, or to extend previous spectral coarsening methods to operate on tetrahedral meshes (Section 2).

Quantitative comparison

We visualize coarsened triangular (Figure 8) and tetrahedral (Figure 11) meshes along with a few eigenvectors (as heat maps on vertices). The results are reassuring that for the special case of coarsening triangle meshes our algorithm produces similar spectral results to previous work. Using L1L_{1} subtly improves the preservation of structures such as the jaw-line, the mouth and the nose of the Suzanne model (Figure 8). The boundary loops around the eyes (eigenvectors of the null space of L1L_{1}) aim to preserve their original size compared to when only L0L_{0} is used. The bottom row of Figure 8 contains quantitative comparisons of our eigenvalues against the baseline and reference. It appears that the approximation is good for L0L_{0}, but curiously spectral divergence is observed for our method and the baseline in L1L_{1} .

This is also observed on a tetrahedral mesh (Fertility model) as shown in the bottom row of Figure 9. However, the profile of eigenvalues for L1L_{1} and the eigenvalues of L2L_{2} are approximated well. We also show functional maps to support these observations. The Laplacians considered were L0cotL_{0}^{\mathrm{cot}} and L1L_{1} for the triangle mesh (2D), and additionally L2L_{2} for the tetrahedral mesh. We report errors in Table 4 using the following error metrics: a local volume-preserving measure CΠ=CTC𝕀F2\|C\|_{\Pi^{\perp}}=\|C^{T}C-\mathbb{I}\|_{F}^{2}, an isometry measure CLc=ScCCSF2/CF2\|C\|_{L_{\text{c}}}=\|S_{c}C-CS\|_{F}^{2}/\|C\|_{F}^{2}, a conformality measure Cconf=CTSCScF2\|C\|_{\text{conf}}=\|C^{T}SC-Sc\|_{F}^{2}, a subspace approximation measure Csub=|S1/2UTΠUS1/221|\|C\|_{\text{sub}}=|\|S^{1/2}U^{T}\Pi US^{-1/2}\|_{2}-1|, subspace alignment Cθ=sinΘ(U,P+Uc)F2\|C\|_{\theta}=\|\sin\Theta(U,P^{+}U_{c})\|_{F}^{2} and relative eigenvalue error Sλ=(SSc)/S2\|S\|_{\lambda}=\|(S-Sc)/S\|_{2}.

The above results indicate comparable performance against the baseline for for triangle meshes and the added capability of handling higher dimensional Laplacians for tetrahedral (3D) meshes. Additional examples are included in the supplementary material. We illustrate the evolution of spectral errors for the Tree root model over three levels of coarsening (Figure 3).

5.2. Simplicial Complexes

We compare our coarsening algorithm to the state-of-the-art edgecollapser of the Gudhi library (The GUDHI Project, 2015), that guarantees homology preservation, and a simple baseline where edges are collapsed at random.

Band-pass filtering

We demonstrate the versatility of our method by coarsening an input complex with two different spectral bands to be preserved: β1+1\beta_{1}+1 lowest, and 10 largest eigenpairs of L1L_{1}. Here, β1\beta_{1} is the betti number (rank of the homology group 1\mathcal{H}_{1}). Figure 5 presents these results along with the functional maps CC as explained above. As expected (by design), Gudhi exactly preserves the homology rank β1\beta_{1}, with no regard for other features. On the contrary, our method can be tuned to a spectral band of choice. Either the nullspace-encoded harmonic information (first row of functional maps) or the high frequency band(second row of maps).

Homology preservation

We constructed a diverse dataset of 100 simplicial complexes (Keros et al., 2022) with non-trivial topology by randomly sampling 400 points repeatedly on multi-holed tori, and subsequently constructing alpha complexes at various thresholds. It contains from zero up to 66 homology cycles. On this dataset, we computed mean spectral error metrics (Table 1), alongside a homology preservation error Eβ=|β1fineβ1coarse|E_{\beta}=|\beta_{1}^{\mathrm{fine}}-\beta_{1}^{\mathrm{coarse}}|. Intuitively, this is the error in the number of 1-cycles destroyed by coarsening. The number of simplices reduced by Gudhi was consistent across both experiments. We ran two variants of our method which preserved the first 3030 eigenpairs of L1L_{1}, reducing the input complexes by a factor of 0.8, and the first β1+1\beta_{1}+1 eigenpairs of L1L_{1}, matching the target number of vertices to the result of Gudhi. The results are summarized in Table 1 with standard deviations in parentheses. Gudhi, as designed, preserves β1\beta_{1} exactly but exhibits spectral leak elsewhere. With random contractions, the leak is amortized across spectral bands but it destroys about 1 cycle on average. Our method is controllable, highlighting that it can be particularly effective if the spectral constraints are known for a particular application.

k ρ\rho Lc\|\cdot\|_{L_{\text{c}}} Π\|\cdot\|_{\Pi^{\perp}} sub\|\cdot\|_{\text{sub}} λ\|\cdot\|_{\lambda} EβE_{\beta}
30 Gudhi 0.9 3.84 (4.2) 29.1 ( 2.9) 2.5 (16.8) 71.5 (664) 0.0 (0.0)
Ours 0.8 0.49 (0.5) 8.98 (3.5) 1.52 (12.2) 2.76 (10.5) 0.07 (0.2)
Random 0.8 3.08 (2.2) 20.8 (3.5) 0.32 (0.4) 400000 (3 e6) .98 (1.2)
β1+1\beta_{1}+1 Gudhi 0.9 - 2.94 (1.0) 0.91 (0.2) - 0.0 (0.0)
Ours 0.9 - 1.78 (1.2) 0.78 (0.3) - 0.21 (0.6)
Random 0.9 - 2.76 (1.1) 0.88 (0.2) - 1.29 (1.4)
Table 1. Spectral approximation metrics averaged over 100 complexes. Two sets of executions of our algorithm preserve the first 3030 and the first β1+1\beta_{1}+1 dimensions of the eigenspace respectively. The various error metrics (columns) are described in Section 5.2. Standard deviations are shown in parentheses.
Input Random Gudhi Ours (low) Ours (high)
Refer to caption Refer to caption Refer to caption Refer to caption Refer to caption

0-10

Refer to caption Refer to caption Refer to caption Refer to caption

790-800

Refer to caption Refer to caption Refer to caption Refer to caption
Figure 5. Band-pass filtering of a simplicial complex using our method. The top row shows the input and coarsened complexes. Ours is executed with two different input specifications. Rows 2 and 3 depict the functional maps of the lowest ten and highest 100 frequencies of L1L_{1}. Gudhi’s method is specifically designed to preserve homology so its map is only diagonal for the first 4 (number of holes) elements. Our algorithm can controllably coarsen the input complex.

5.3. Applications

Denoising

A straightforward application of our method is to suppress frequencies associated with noise. We filtered a noisy Bunny model (43K vertices) using a very narrow low-pass filter: only the first three eigenvectors of L0L_{0} and L1L_{1}. Figure 6 visualizes our result along with the baseline filters unevenly, possibly due to noisy geometric information in its cotan weighting.

noisy ours baseline
Refer to caption Refer to caption Refer to caption
Figure 6. Denoising. A noisy Bunny model (43645 vertices) is coarsened to 2% of its size (1000 vertices), to preserve only the first 3 eigenvectors of L0L_{0} & L1L_{1} using our method, and the first 3 eigenvectors of L0cotL_{0}^{\text{cot}} for the baseline.

Finite Element Method (FEM)

We solve the Poisson equation Δu=1-\Delta u=1 with Dirichlet boundary condition u=0u=0 on the popular Plate-hole model, using piece-wise linear (triangular) elements. In addition to solving it on the discretized mesh, we test robustness by applying planar pertubations to the vertices with increasing levels of Gaussian noise. For each setting, we coarsen the noisy mesh with ρ=0.75\rho=0.75 (8000 to 2000 vertices) using L0cotL_{0}^{\text{cot}} and L1L^{1}, run a standard FEM solver on the coarse mesh and lift the solution to the input mesh. Figure 10 shows a plot of error vs noise (top left), the reference solution (top right) and error maps for different noise settings (columns) and methods (rows). Also shown are previous work (Lescoat et al., 2020), with (optpos) and without (noopt) vertex position optimization, and a quadric-based method (Garland and Heckbert, 1997). The coarse mesh is overlaid on the error maps and can be viewed by magnifiying the figure. Our method exhibits robustness against noise and improved approximation performance against element reduction.

Spectral distances

We evaluate the fidelity (Figure 12) of spectral distance measures computed on the coarse mesh and “lifted” to the fine mesh, between vertices w,vw,v of a triangle surface mesh (Suzanne) and a volume tetrahedral mesh (Fertility), using the same parameters as Figures 8 and 11. Figure 1 illustrates the spectral distance approximation process on the Engine tetrahedral model, coarsened with ρ=.8\rho=-.8 (from 46220 to 10000 vertices) while preserving the first 50 eigenvectors of L0cotL_{0}^{\text{cot}} and the first 25 eigenvectors of L1L_{1} and L2L_{2}. The model has 20 holes that are retained in the coarse mesh. The metrics used and their parameters are tabulated below.

diffusion w,v,tw,v,t i(ui(v)ui(w))2e2sit\sum_{i}(u_{i}(v)-u_{i}(w))^{2}e^{-2s_{i}t}
biharmonic w,vw,v i(ui(v)ui(w))2/si2\sum_{i}(u_{i}(v)-u_{i}(w))^{2}/s_{i}^{2}
commute w,vw,v i(ui(v)ui(w))2/si\sum_{i}(u_{i}(v)-u_{i}(w))^{2}/s_{i}
WKS v,tv,t iui2(v)e(tlogsi)22σ2/ie(tlogsi)22σ2\sum_{i}u_{i}^{2}(v)e^{-\frac{(t-\log s_{i})^{2}}{2\sigma^{2}}}/\sum_{i}e^{-\frac{(t-\log s_{i})^{2}}{2\sigma^{2}}}
WKD w,vw,v tmintmax|WKS(w,t)WKS(v,t)WKS(w,t)WKS(v,t)|𝑑t\int_{t_{\text{min}}}^{t_{\text{max}}}\left|\frac{WKS(w,t)-WKS(v,t)}{WKS(w,t)-WKS(v,t)}\right|dt,
HKS w,v,tw,v,t iui(w)ui(v)esit\sum_{i}u_{i}(w)u_{i}(v)e^{-s_{i}t}

Spectral distance approximation on Suzanne outperforms the baseline by orders on magnitude in most cases, with error remaining low even for the tetrahedral Fertility mesh. The qualitative comparison indicates agreement between our “lifted” version and the reference, despite some localized distortions.

6. Discussion

Execution time

We implemented our method in C++, and performed experiments on a 16-core workstation (Intel E5-2630 v3,2.4 GHz) with 64GB RAM. Our method compares favorably (orders of magnitude faster) against the spectral coarsening baseline in Figure 7. Although it appears that we are competitive with the quadric-based method (Garland and Heckbert, 1997)) it should be noted that ours (like the baseline) requires an eigenspace of the laplacians as input while the latter does not. The time for the eigendecomposition is not reflected in the plot (which only measures geometric operations) and should be added to both our method and the baseline. The triangle meshes used in the comparison contain 10772 (Fertility) and 29690 (Dinoskull) vertices, respectively. We use L0cotL_{0}^{\text{cot}} for the baseline, and L0cotL_{0}^{\text{cot}} & L1L_{1} for our method.

Refer to caption Refer to caption
Figure 7. Computation time vs reduction ratio.

Boundary

The intricacies of boundary values problems involving Hodge Laplacians (Mitrea, 2016) complicate practical computations. The differential operators need to be constructed carefully to guarantee coverage of tangential and normal conditions (Zhao et al., 2019a). Since our method is Laplacian-agnostic, any positive semi-definite variante of the Laplacian operator, with its spectrum, can be provided as input.

Limitation and future work

The utility of our tool hinges on knowledge of spectral constraints imposed by downstream tasks. While this is known in some cases (homology, spectral distances and denoising), such constraints are not typically known across applications. There is especially little use of higher dimensional Laplacian operators. However, we are hopeful that the availability of a tool such as ours will inspire the graphics communities (particularly geometry processing and simulation) to explore the applicability of mixed-dimensional Laplacian spectral constraints.

7. Conclusion

We presented a simple and efficient algorithm for coarsening simplicial complexes, while preserving targeted spectral subspaces across multiple dimensions. We exemplified the impact of the choices of spectral domain on applications such as denoising, FEM and approximate distance calculations on coarsened meshes. We hope that this work will pave the way towards unleashing the potential of using mixtures of Laplacians in discrete geometry processing.

Ui,i=1,2,9,50U_{i},\,i=1,2,9,50

Reference

Refer to caption Refer to caption

Ours

Refer to caption Refer to caption

Baseline

Refer to caption Refer to caption
Refer to caption Refer to caption
Figure 8. A visualization of an input mesh (top left), coarsened meshes (first column) and four eigenvectors of its L0cotL_{0}^{\mathrm{cot}} (right) computed using our method (second row) and our baseline (third row). The mesh was coarsened from 1640 to 400 vertices, preserving L0cotL_{0}^{\mathrm{cot}} and L1L_{1}. Our method is mostly similar with subtle differences around the square jaw and button nose. The eigenvalues of the preserved spectrum are plotted below with those corresponding to k=0k=0 on the left and k=1k=1 on the right.
L0cotL_{0}^{\text{cot}} L1L_{1} L2L_{2}
Refer to caption Refer to caption Refer to caption
Refer to caption Refer to caption Refer to caption
Figure 9. Functional maps (top) and eigenvalues (bottom) for the Fertility tetrahedral mesh pictured in Figure 11.
Refer to caption
Error maps

Ours

Refer to caption Refer to caption Refer to caption

L. 2020 (noopt)

Refer to caption Refer to caption Refer to caption

G& H 97

Refer to caption Refer to caption Refer to caption
noise = 0.0 noise = 1 noise = 3
Figure 10. FEM on our coarsened mesh is robust to Gaussian noise added to the vertices (top left). The solution to Δu=1-\Delta u=1 on the fine mesh (zoom in to view) is shown on the top right. The table below compares error as heat maps of simulation error (blue is low and red is high), with the coarse mesh (zoom to view) overlaid, for ours and two other coarsening methods (rows).
U1U_{1} U5U_{5} U20U_{20} U50U_{50}

Reference

Refer to caption Refer to caption Refer to caption Refer to caption Refer to caption

Ours

Refer to caption Refer to caption Refer to caption Refer to caption Refer to caption
Figure 11. A visualization of four arbitrary eigenvectors UiU_{i} (columns) of L0cotL_{0}^{\mathrm{cot}} evaluated on the vertices of a tetrahedral mesh that was coarsened from 10K to 3K vertices using our algorithm. The input specification was to preserve the first 100 eigenvectors of L0cotL_{0}^{\mathrm{cot}}, L0L_{0} and L1L_{1}. The insets on the top left depict slices through the mesh.
2D (triangle mesh) 3D (tetrahedral mesh)
Diffusion Biharmonic HKS Diffusion Biharmonic HKS

Reference

Refer to caption Refer to caption Refer to caption

Reference

Refer to caption Refer to caption Refer to caption

Ours

Refer to caption Refer to caption Refer to caption

Ours

Refer to caption Refer to caption Refer to caption

Baseline

Refer to caption Refer to caption Refer to caption

Ours - Lifted

Refer to caption Refer to caption Refer to caption
diff. biharm. commute WKS WKD HKS HKD
ours 0.009\mathbf{0.009} .00002\mathbf{.00002} .0009\mathbf{.0009} 66.06\mathbf{66.06} 0.007\mathbf{0.007} 0.003\mathbf{0.003} 0.026\mathbf{0.026}
baseline 0.324 0.033 0.008 1292 0.656 0.228 0.411
diff. biharm. commute WKS WKD HKS HKD
0.699 0.739 0.019 81.6 1.597 .009 2.336
Figure 12. Different distance metrics from a point (blue dot on each mesh) are computed on a coarse mesh and visualized using colored isocontours. Our P+P^{+} operator enables the “lifting” of these distances from the coarse mesh (insets in 2D plots and third row of 3D plots). The tables report mean squared error error for various distance metrics. The insets in the 3D plots depict slices through the mesh.

References

  • (1)
  • Ayoub et al. (2020) Rama Ayoub, Aziz Hamdouni, and Dina Razafindralandy. 2020. A new Hodge operator in Discrete Exterior Calculus. Application to fluid mechanics. arXiv preprint arXiv:2006.16930 (2020).
  • Barbarossa and Sardellitti (2020) Sergio Barbarossa and Stefania Sardellitti. 2020. Topological signal processing over simplicial complexes. IEEE Transactions on Signal Processing 68 (2020), 2992–3007.
  • Black and Maxwell (2021) Mitchell Black and William Maxwell. 2021. Effective Resistance and Capacitance in Simplicial Complexes and a Quantum Algorithm. In 32nd International Symposium on Algorithms and Computation (ISAAC 2021) (Leibniz International Proceedings in Informatics (LIPIcs), Vol. 212), Hee-Kap Ahn and Kunihiko Sadakane (Eds.). Schloss Dagstuhl – Leibniz-Zentrum für Informatik, Dagstuhl, Germany, 31:1–31:27. https://doi.org/10.4230/LIPIcs.ISAAC.2021.31
  • Boissonnat and Pritam (2019) Jean-Daniel Boissonnat and Siddharth Pritam. 2019. Computing Persistent Homology of Flag Complexes via Strong Collapses. In SoCG 2019-International Symposium on Computational geometry.
  • Boissonnat and Pritam (2020) Jean-Daniel Boissonnat and Siddharth Pritam. 2020. Edge collapse and persistence of flag complexes. In SoCG 2020-36th International Symposium on Computational Geometry.
  • Bunge et al. (2021) A. Bunge, M. Botsch, and M. Alexa. 2021. The Diamond Laplace for Polygonal and Polyhedral Meshes. Computer Graphics Forum 40, 5 (Aug. 2021), 217–230. https://doi.org/10.1111/cgf.14369
  • Caissard et al. (2019) Thomas Caissard, David Coeurjolly, Jacques-Olivier Lachaud, and Tristan Roussillon. 2019. Laplace–beltrami operator on digital surfaces. Journal of Mathematical Imaging and Vision 61, 3 (2019), 359–379.
  • Chen et al. (2020) Honglin Chen, Hsueh-TI Derek Liu, Alec Jacobson, and David I. W. Levin. 2020. Chordal Decomposition for Spectral Coarsening. 39, 6, Article 265 (nov 2020), 16 pages. https://doi.org/10.1145/3414685.3417789
  • Chen et al. (2022) Jie Chen, Yousef Saad, and Zechen Zhang. 2022. Graph coarsening: from scientific computing to machine learning. SeMA Journal (2022), 1–37.
  • Chen et al. (2021) Yu-Chia Chen, Marina Meilă, and Ioannis G Kevrekidis. 2021. Helmholtzian Eigenmap: Topological feature discovery & edge flow learning from point cloud data. arXiv preprint arXiv:2103.07626 (2021).
  • Chiang and Lu (2003) Yi-Jen Chiang and Xiang Lu. 2003. Progressive Simplification of Tetrahedral Meshes Preserving All Isosurface Topologies. Computer Graphics Forum 22, 3 (Sept. 2003), 493–504. https://doi.org/10.1111/1467-8659.00697
  • Chopra and Meyer (2002) Prashant Chopra and Joerg Meyer. 2002. Tetfusion: an algorithm for rapid tetrahedral mesh simplification. In IEEE Visualization, 2002. VIS 2002. IEEE, 133–140.
  • Chung (1999) F R K Chung. 1999. Spectral Graph Theory. ACM SIGACT News 30 (1999), 14. https://doi.org/10.1145/568547.568553
  • Crane et al. (2013) Keenan Crane, Fernando De Goes, Mathieu Desbrun, and Peter Schröder. 2013. Digital geometry processing with discrete exterior calculus. In ACM SIGGRAPH 2013 Courses. 1–126.
  • de Goes et al. (2016) Fernando de Goes, Mathieu Desbrun, and Yiying Tong. 2016. Vector Field Processing on Triangle Meshes. In ACM SIGGRAPH 2016 Courses (Anaheim, California) (SIGGRAPH ’16). Association for Computing Machinery, New York, NY, USA, Article 27, 49 pages. https://doi.org/10.1145/2897826.2927303
  • De Witt et al. (2012) Tyler De Witt, Christian Lessig, and Eugene Fiume. 2012. Fluid Simulation Using Laplacian Eigenfunctions. ACM Trans. Graph. 31, 1 (Jan. 2012), 1–11. https://doi.org/10.1145/2077341.2077351
  • Desbrun et al. (2005) Mathieu Desbrun, Anil N Hirani, Melvin Leok, and Jerrold E Marsden. 2005. Discrete exterior calculus. arXiv preprint math/0508341 (2005).
  • Dey et al. (1998) Tamal K Dey, Herbert Edelsbrunner, Sumanta Guha, and Dmitry V Nekhayev. 1998. Topology preserving edge contraction. In Publ. Inst. Math.(Beograd)(NS. Citeseer.
  • Ebli et al. (2020) Stefania Ebli, Michaël Defferrard, and Gard Spreemann. 2020. Simplicial neural networks. arXiv preprint arXiv:2010.03633 (2020).
  • Ebli and Spreemann (2019) Stefania Ebli and Gard Spreemann. 2019. A notion of harmonic clustering in simplicial complexes. In 2019 18th IEEE International Conference On Machine Learning And Applications (ICMLA). IEEE, 1083–1090.
  • Eckmann (1944) Beno Eckmann. 1944. Harmonische funktionen und randwertaufgaben in einem komplex. Commentarii Mathematici Helvetici 17, 1 (1944), 240–255.
  • Garland and Heckbert (1997) Michael Garland and Paul S Heckbert. 1997. Surface simplification using quadric error metrics. In Proceedings of the 24th annual conference on Computer graphics and interactive techniques. 209–216.
  • Glisse and Pritam (2022) Marc Glisse and Siddharth Pritam. 2022. Swap, Shift and Trim to Edge Collapse a Filtration. arXiv preprint arXiv:2203.07022 (2022).
  • Hansen and Ghrist (2019) Jakob Hansen and Robert Ghrist. 2019. Toward a spectral theory of cellular sheaves. Journal of Applied and Computational Topology 3, 4 (2019), 315–358.
  • Horak and Jost (2013) Danijela Horak and Jürgen Jost. 2013. Spectra of combinatorial Laplace operators on simplicial complexes. Advances in Mathematics 244 (2013), 303–336.
  • Keros et al. (2022) Alexandros Keros, Vidit Nanda, and Kartic Subr. 2022. Dist2Cycle: A Simplicial Neural Network for Homology Localization. In 36th AAAI Conference on Artificial Intelligence.
  • Khan et al. (2020) Dawar Khan, Alexander Plopski, Yuichiro Fujimoto, Masayuki Kanbara, Gul Jabeen, Yongjie Jessica Zhang, Xiaopeng Zhang, and Hirokazu Kato. 2020. Surface remeshing: A systematic literature review of methods and research directions. IEEE transactions on visualization and computer graphics 28, 3 (2020), 1680–1713.
  • Lahav and Tal (2020) Alon Lahav and Ayellet Tal. 2020. Meshwalker: Deep mesh understanding by random walks. ACM Transactions on Graphics (TOG) 39, 6 (2020), 1–13.
  • Lai et al. (2008) Yu-Kun Lai, Shi-Min Hu, Ralph R Martin, and Paul L Rosin. 2008. Fast mesh segmentation using random walks. In Proceedings of the 2008 ACM symposium on Solid and physical modeling. 183–191.
  • Lescoat et al. (2020) Thibault Lescoat, Hsueh-Ti Derek Liu, Jean-Marc Thiery, Alec Jacobson, Tamy Boubekeur, and Maks Ovsjanikov. 2020. Spectral mesh simplification. In Computer Graphics Forum, Vol. 39. Wiley Online Library, 315–324.
  • Lim (2020) Lek-Heng Lim. 2020. Hodge Laplacians on graphs. Siam Review 62, 3 (2020), 685–715.
  • Liu et al. (2015) Beibei Liu, Gemma Mason, Julian Hodgson, Yiying Tong, and Mathieu Desbrun. 2015. Model-reduced variational fluid simulation. ACM Transactions on Graphics (TOG) 34, 6 (2015), 1–12.
  • Liu et al. (2019) Hsueh-Ti Derek Liu, Alec Jacobson, and Maks Ovsjanikov. 2019. Spectral Coarsening of Geometric Operators. ACM Trans. Graph. 38, 4, Article 105 (jul 2019), 13 pages. https://doi.org/10.1145/3306346.3322953
  • Loukas (2019) Andreas Loukas. 2019. Graph Reduction with Spectral and Cut Guarantees. J. Mach. Learn. Res. 20, 116 (2019), 1–42.
  • Mitrea (2016) Dorina Mitrea. 2016. The Hodge-Laplacian: Boundary Value Problems on Riemannian Manifolds. Number volume 64 in De Gruyter Studies in Mathematics. De Gruyter, Berlin ; Boston.
  • Nascimento and De Carvalho (2011) Maria CV Nascimento and Andre CPLF De Carvalho. 2011. Spectral methods for graph clustering–a survey. European Journal of Operational Research 211, 2 (2011), 221–231.
  • Osting et al. (2017) Braxton Osting, Sourabh Palande, and Bei Wang. 2017. Towards spectral sparsification of simplicial complexes based on generalized effective resistance. arXiv preprint arXiv:1708.08436 (2017).
  • Poelke and Polthier (2016) Konstantin Poelke and Konrad Polthier. 2016. Boundary-aware Hodge decompositions for piecewise constant vector fields. Computer-Aided Design 78 (2016), 126–136.
  • Rodolà et al. (2017) Emanuele Rodolà, Luca Cosmo, Michael M Bronstein, Andrea Torsello, and Daniel Cremers. 2017. Partial functional correspondence. In Computer graphics forum, Vol. 36. Wiley Online Library, 222–236.
  • Ronfard and Rossignac (1996) Rémi Ronfard and Jarek Rossignac. 1996. Full-range approximation of triangulated polyhedra.. In Computer Graphics Forum, Vol. 15. Wiley Online Library, 67–76.
  • Rosenberg and Steven (1997) Steven Rosenberg and Rosenberg Steven. 1997. The Laplacian on a Riemannian manifold: an introduction to analysis on manifolds. Number 31. Cambridge University Press.
  • Sacht et al. (2013) Leonardo Sacht, Alec Jacobson, Daniele Panozzo, Christian Schüller, and Olga Sorkine-Hornung. 2013. Consistent volumetric discretizations inside self-intersecting surfaces. In Computer Graphics Forum, Vol. 32. Wiley Online Library, 147–156.
  • Schaub et al. (2020) Michael T Schaub, Austin R Benson, Paul Horn, Gabor Lippner, and Ali Jadbabaie. 2020. Random walks on simplicial complexes and the normalized hodge 1-laplacian. SIAM Rev. 62, 2 (2020), 353–391.
  • Sharp and Crane (2020) Nicholas Sharp and Keenan Crane. 2020. A laplacian for nonmanifold triangle meshes. In Computer Graphics Forum, Vol. 39. Wiley Online Library, 69–80.
  • Smirnov and Solomon (2021) Dmitriy Smirnov and Justin Solomon. 2021. HodgeNet: learning spectral geometry on triangle meshes. ACM Transactions on Graphics (TOG) 40, 4 (2021), 1–11.
  • Sorkine et al. (2004) Olga Sorkine, Daniel Cohen-Or, Yaron Lipman, Marc Alexa, Christian Rössl, and H-P Seidel. 2004. Laplacian surface editing. In Proceedings of the 2004 Eurographics/ACM SIGGRAPH symposium on Geometry processing. 175–184.
  • Spielman and Srivastava (2011) Daniel A Spielman and Nikhil Srivastava. 2011. Graph sparsification by effective resistances. SIAM J. Comput. 40, 6 (2011), 1913–1926.
  • Su et al. (2022) Xing Su, Shan Xue, Fanzhen Liu, Jia Wu, Jian Yang, Chuan Zhou, Wenbin Hu, Cecile Paris, Surya Nepal, Di Jin, Quan Z. Sheng, and Philip S. Yu. 2022. A Comprehensive Survey on Community Detection With Deep Learning. IEEE Transactions on Neural Networks and Learning Systems (2022), 1–21. https://doi.org/10.1109/TNNLS.2021.3137396
  • The GUDHI Project (2015) The GUDHI Project. 2015. GUDHI User and Reference Manual. GUDHI Editorial Board. http://gudhi.gforge.inria.fr/doc/latest/
  • Torres and Bianconi (2020) Joaquín J Torres and Ginestra Bianconi. 2020. Simplicial complexes: higher-order spectral dimension and dynamics. Journal of Physics: Complexity 1, 1 (2020), 015002.
  • Vaxman et al. (2016) Amir Vaxman, Marcel Campen, Olga Diamanti, Daniele Panozzo, David Bommes, Klaus Hildebrandt, and Mirela Ben-Chen. 2016. Directional Field Synthesis, Design, and Processing. Computer Graphics Forum 35, 2 (2016), 545–572. https://doi.org/10.1111/cgf.12864 arXiv:https://onlinelibrary.wiley.com/doi/pdf/10.1111/cgf.12864
  • Vo et al. (2007) Huy T. Vo, Steven P. Callahan, Peter Lindstrom, Valerio Pascucci, and Claudio T. Silva. 2007. Streaming Simplification of Tetrahedral Meshes. IEEE Transactions on Visualization and Computer Graphics 13, 1 (2007), 145–155. https://doi.org/10.1109/TVCG.2007.21
  • Wardetzky (2020) Max Wardetzky. 2020. Discrete Laplace operators. An Excursion Through Discrete Differential Geometry: AMS Short Course, Discrete Differential Geometry, January 8-9, 2018, San Diego, California 76 (2020), 1.
  • Wilkerson et al. (2013) Adam C Wilkerson, Terrence J Moore, Ananthram Swami, and Hamid Krim. 2013. Simplifying the homology of networks via strong collapses. In 2013 IEEE International Conference on Acoustics, Speech and Signal Processing. IEEE, 5258–5262.
  • Zhao et al. (2019a) Rundong Zhao, Mathieu Desbrun, Guo-Wei Wei, and Yiying Tong. 2019a. 3D Hodge Decompositions of Edge- and Face-Based Vector Fields. ACM Trans. Graph. 38, 6 (Dec. 2019), 1–13. https://doi.org/10.1145/3355089.3356546
  • Zhao et al. (2019b) Rundong Zhao, Mathieu Desbrun, Guo-Wei Wei, and Yiying Tong. 2019b. 3D Hodge decompositions of edge-and face-based vector fields. ACM Transactions on Graphics (TOG) 38, 6 (2019), 1–13.
  • Ziegler et al. (2022) Cameron Ziegler, Per Sebastian Skardal, Haimonti Dutta, and Dane Taylor. 2022. Balanced Hodge Laplacians optimize consensus dynamics over simplicial complexes. Chaos: An Interdisciplinary Journal of Nonlinear Science 32, 2 (2022), 023128.