Papers
Topics
Authors
Recent
2000 character limit reached

Volume Estimates for Convex Unions

Updated 23 December 2025
  • The paper introduces randomized approximation schemes, such as FPRAS and NSMC, to estimate the Lebesgue measure of unions of convex sets.
  • Algorithmic approaches leverage membership and volume queries, wrapping hull estimators, and SOS techniques to balance complexity and error bounds.
  • The methods have significant implications for high-dimensional geometry, combinatorial analysis, and optimization, advancing both theory and practical computation.

A volume estimate for the union of convex sets seeks to determine or sharply bound the Lebesgue measure of i=1mCi\bigcup_{i=1}^m C_i for a finite collection of convex sets {C1,,Cm}Rn\{C_1,\dots,C_m\}\subset\mathbb{R}^n. This problem sits at the intersection of high-dimensional geometry, computational complexity, combinatorics, and optimization, with critical applications in stochastic geometry, optimization, computational algebraic geometry, and harmonic analysis. The union operation introduces non-convexity even when the original sets are convex, rendering volume estimation nontrivial both algorithmically and in terms of theoretical structure.

1. Computational Hardness and Oracle Models

Volume computation for unions of convex sets is known to be #P\#\mathbf{P}-hard, subsuming classic problems such as Klee’s measure problem for axis-parallel boxes. The intractability holds even for simple bodies: exact computation of Vol(i=1nBi)\mathrm{Vol}(\bigcup_{i=1}^n B_i) is #P\#\mathbf{P}-hard even when the BiB_i are axis-parallel boxes sharing a corner (0809.0835). This intractability motivates relaxation to randomized approximation schemes relying on weak oracles for point membership, uniform sampling, and approximate single-body volume computation:

  • POINTQUERY (x,B)(x,B): Boolean, indicating whether xBx\in B' (with BB' an ϵP\epsilon_P-approximate body)
  • VOLUMEQUERY (B)(B): Returns VV' so that (VVol(B))/Vol(B)ϵV|(V'-\mathrm{Vol}(B))/\mathrm{Vol}(B)|\le\epsilon_V
  • SAMPLEQUERY (B)(B): Returns xBx\in B' almost uniformly, with f(x)f(x) close to 1/Vol(B)1/\mathrm{Vol}(B')

This oracle model underlies the fastest fully polynomial randomized approximation schemes (FPRAS) and is robust: as long as ϵP,ϵV,ϵS=O(ϵ2/n)\epsilon_P,\epsilon_V,\epsilon_S=O(\epsilon^2/n) with nn the number of bodies, a (1±ϵ)(1\pm\epsilon)-multiplicative approximation can be obtained (0809.0835).

2. Algorithmic Approaches

2.1 FPRAS for Unions

The APPROXUNION algorithm of Bringmann and Friedrich (0809.0835) constructs a near-optimal FPRAS for the volume of unions of convex bodies. It combines the following steps:

  • Compute approximate volumes ViV_i for each BiB_i.
  • Perform a randomized "hit-and-judge" loop: select BiB_i with probability proportional to ViV_i, draw xBix\sim B_i, and determine the number of random BjB_j needed for xx to be classified as contained.
  • Return the estimator U~=TsumVnM\widetilde{U} = \frac{T_\text{sum}\, V'}{n\,M} where V=iViV' = \sum_i V_i.

When convex bodies are provided by membership oracles, and volume/sampling oracles are simulated using Dyer–Frieze–Kannan or Lovász–Vempala random walks, the FPRAS has total runtime O~(nd5/ϵ2)\widetilde O(nd^5/\epsilon^2) for dd-dimensional bodies (0809.0835).

2.2 nn-Sphere Monte Carlo (NSMC)

The nn-sphere Monte Carlo method, due to Venkatapathi and Arun, provides a volume estimator by sampling random directions s^Sn1\hat{s}\in S^{n-1} and measuring the maximal extent function S(s^):=sup{ρ:ρs^D}S(\hat{s}) := \sup\{\rho: \rho\hat{s} \in D\} for the set DD containing the origin. For unions of convex sets:

  • S(s^)=max1imSi(s^)S(\hat{s}) = \max_{1\leq i\leq m} S_i(\hat{s}) where SiS_i is the support function of CiC_i.
  • The volume is V(D)=vnEs^[S(s^)n]V(D) = v_n\, \mathbb{E}_{\hat{s}}[S(\hat{s})^n] where vnv_n is the volume of the unit nn-ball.
  • Complexity is O(mn2/ϵ2)O(m n^2/\epsilon^2) for relative error ϵ\epsilon, with provable error bounds (I. et al., 2020).
  • NSMC is dimension-agnostic, “embarrassingly parallel,” and outperforms multistage MCMC methods for n100n\lesssim 100 with moderate accuracy requirements.

2.3 Wrapping Hull Estimation

The wrapping hull approach of Baldin (Baldin, 2017) provides a statistically optimal estimator for the volume of a union of convex sets, within the intersection-stable class. Given NN points sampled uniformly from S=i=1mCiS = \bigcup_{i=1}^m C_i, define the wrapping hull WW as the minimal union of m\leq m convex bodies containing the sample:

  • Oracle (known λ\lambda): V^oracle=W+N/λ\widehat{V}_\text{oracle} = |W| + N_\partial/\lambda where NN_\partial is the number of sample points on W\partial W.
  • Data-driven: V^=N+1N0+1W\widehat{V} = \frac{N+1}{N_0+1}|W| with N0N_0 interior sample points.
  • The estimator achieves minimax error rates O(n2/(d+1))O(n^{-2/(d+1)}) in dimension dd.

This framework is unbiased, consistent, and attains the uniformly minimal variance among all estimators based on the observed samples (Baldin, 2017).

2.4 Sum-of-Squares (SOS) Semialgebraic Methods

SOS-based methods enable inner and outer semialgebraic approximations of unions of convex sets. Given S=i=1mCiS = \bigcup_{i=1}^m C_i, one can encode the inclusion S{x:p(x)1}S \subseteq \{x : p(x)\leq 1\} for a degree-$2d$ polynomial p(x)p(x) via SOS certificates:

  • For each Ci={x:gi,j(x)0j}C_i = \{x : g_{i,j}(x)\geq 0\,\forall j\}, enforce p(x)1=σi(x)+jλi,j(x)gi,j(x)p(x)-1 = \sigma_i(x) + \sum_j \lambda_{i,j}(x)g_{i,j}(x) with λi,j,σiΣSOS\lambda_{i,j},\sigma_i \in \Sigma_\mathrm{SOS}.
  • Add convexity constraints if required: enforce the Hessian 2p(x)0\nabla^2 p(x)\succeq 0 via matrix-SOS.
  • Minimize logdet(Q)-\log\det(Q) where p(x)=v(x)TQv(x)p(x)=v(x)^T Q v(x) to heuristically tighten volume bounds (Jones et al., 2018).

Volume is then estimated for the 1-sublevel set by randomized or moment methods. This approach is heuristic for d>2d>2, but yields tight convex relaxations especially in the quadratic case.

3. Mixed Volume, Polytope Unions, and the “Unmixing” Principle

The computational algebraic geometry of unions is informed by the concept of mixed volume. "Unmixing the mixed volume" refers to sufficient combinatorial face conditions on the family {Pi}\{P_i\} of convex polytopes guaranteeing:

$\MV(P_1, \ldots, P_n) = n!\operatorname{Vol}\big(\operatorname{conv}(P_1 \cup \ldots \cup P_n)\big)$

(Chen, 2017). The “unmixed-faces” and “semi-mixed-faces” theorems give explicit criteria: if every positive-dimensional face of the convex hull meets every PiP_i (or, for semi-mixed, more weakly intersects in low-dimensional faces in a controlled way), exact reduction is possible.

Algorithmic implication: traditional mixed volume routines scale poorly with the Cayley complexity, but replacing the computation with a single convex hull typically leads to speedups of one or two orders of magnitude, as demonstrated in power-flow benchmarks and polyhedral homotopy root-counting (Chen, 2017). For general convex bodies an analogous extension remains conjectural.

4. Combinatorial and Geometric Volume Lower Bounds

Recent advances relate the structure of unions to combinatorial volume lower bounds. If a family U\mathcal{U} of convex sets (of diameter 1\leq 1 and volume δ2\sim \delta^2 in R3\mathbb{R}^3) satisfies a "no clustering in convex sets" condition, sharp lower volume bounds follow:

UUUcδϵN1(#U)δ2\left| \bigcup_{U\in \mathcal{U}} U \right| \geq c \,\delta^\epsilon N^{-1} (\#\mathcal{U})\,\delta^2

where NN is such that no convex VV contains more than NN elements of U\mathcal{U} (Wang et al., 24 Feb 2025). This generalizes classical Kakeya-type estimates and is proved by multiscale induction, grains decomposition, and hairbrush bounds. The approach holds for both tubes and general convex sets, with applications to the Kakeya conjecture and dimension results.

5. Error Bounds, Complexity, and Practical Guidance

Method Error (relative/absolute) Complexity Applicability
FPRAS (APPROXUNION) 1±ϵ1\pm\epsilon multiplicative O~(nd5/ϵ2)\widetilde{O}(nd^5/\epsilon^2) High-dim, generic
NSMC O(n/N)O(\sqrt{n}/\sqrt{N}) RMS O(mn2/ϵ2)O(m n^2/\epsilon^2) n100n\lesssim100
Wrapping hull O(n2/(d+1))O(n^{-2/(d+1)}) RMS O(nO(dm))O(n^{O(dm)}) (low-d mm) Sample-based, union
SOS (semialgebraic outer) Heuristic, sample/analytic Depends on SDP size Convex polynomial input

In practice, the NSMC is favorable for moderate dimension if the support functions are explicit, parallellizable, and unbiased. FPRAS works widely when oracles are accessible. Wrapping hull estimators achieve minimax error rates when uniform samples are available. SOS approaches are best suited where tight outer convex or semialgebraic approximations are needed (I. et al., 2020, 0809.0835, Baldin, 2017, Jones et al., 2018).

6. Theoretical Implications and Open Questions

The study of volume estimation for unions of convex sets has led to important insights into complexity, geometric measure theory, and computational algebra. Notably:

  • There is a provable asymmetry: unions of convex sets admit efficient randomized approximation, but intersections are provably hard to approximate multiplicatively in high-dimensions (0809.0835).
  • The connection between mixed volume and the convex hull of unions allows practical speed-ups for algebraic geometry applications under combinatorial criteria (Chen, 2017).
  • Geometric lower bounds for unions with anti-concentration structure yield sharp estimates in combinatorial and harmonic analysis contexts, resolving dimension conjectures (Wang et al., 24 Feb 2025).

A plausible implication is that advances in volume estimates for unions may further impact the study of exceptional sets in geometric measure theory and the analysis of polynomial systems, with direct computational and theoretical utility. Extensions from polytopes to general convex bodies in the mixed-volume equivalence, and optimizing the computational cost for large-scale unions given only oracle access, remain key open directions.

Whiteboard

Topic to Video (Beta)

Follow Topic

Get notified by email when new papers are published related to Volume Estimates for Unions of Convex Sets.