mathlib documentation

analysis.analytic.inverse

Inverse of analytic functions #

We construct the left and right inverse of a formal multilinear series with invertible linear term, we prove that they coincide and study their properties (notably convergence).

Main statements #

The left inverse of a formal multilinear series #

noncomputable def formal_multilinear_series.left_inv {π•œ : Type u_1} [nontrivially_normed_field π•œ] {E : Type u_2} [normed_add_comm_group E] [normed_space π•œ E] {F : Type u_3} [normed_add_comm_group F] [normed_space π•œ F] (p : formal_multilinear_series π•œ E F) (i : E ≃L[π•œ] F) :

The left inverse of a formal multilinear series, where the n-th term is defined inductively in terms of the previous ones to make sure that (left_inv p i) ∘ p = id. For this, the linear term p₁ in p should be invertible. In the definition, i is a linear isomorphism that should coincide with p₁, so that one can use its inverse in the construction. The definition does not use that i = p₁, but proofs that the definition is well-behaved do.

The n-th term in q ∘ p is βˆ‘ qβ‚– (p_{j₁}, ..., p_{jβ‚–}) over j₁ + ... + jβ‚– = n. In this expression, qβ‚™ appears only once, in qβ‚™ (p₁, ..., p₁). We adjust the definition so that this term compensates the rest of the sum, using i⁻¹ as an inverse to p₁.

These formulas only make sense when the constant term pβ‚€ vanishes. The definition we give is general, but it ignores the value of pβ‚€.

Equations
@[simp]
theorem formal_multilinear_series.left_inv_coeff_zero {π•œ : Type u_1} [nontrivially_normed_field π•œ] {E : Type u_2} [normed_add_comm_group E] [normed_space π•œ E] {F : Type u_3} [normed_add_comm_group F] [normed_space π•œ F] (p : formal_multilinear_series π•œ E F) (i : E ≃L[π•œ] F) :
p.left_inv i 0 = 0
@[simp]
theorem formal_multilinear_series.left_inv_coeff_one {π•œ : Type u_1} [nontrivially_normed_field π•œ] {E : Type u_2} [normed_add_comm_group E] [normed_space π•œ E] {F : Type u_3} [normed_add_comm_group F] [normed_space π•œ F] (p : formal_multilinear_series π•œ E F) (i : E ≃L[π•œ] F) :
theorem formal_multilinear_series.left_inv_remove_zero {π•œ : Type u_1} [nontrivially_normed_field π•œ] {E : Type u_2} [normed_add_comm_group E] [normed_space π•œ E] {F : Type u_3} [normed_add_comm_group F] [normed_space π•œ F] (p : formal_multilinear_series π•œ E F) (i : E ≃L[π•œ] F) :

The left inverse does not depend on the zeroth coefficient of a formal multilinear series.

theorem formal_multilinear_series.left_inv_comp {π•œ : Type u_1} [nontrivially_normed_field π•œ] {E : Type u_2} [normed_add_comm_group E] [normed_space π•œ E] {F : Type u_3} [normed_add_comm_group F] [normed_space π•œ F] (p : formal_multilinear_series π•œ E F) (i : E ≃L[π•œ] F) (h : p 1 = ⇑((continuous_multilinear_curry_fin1 π•œ E F).symm) ↑i) :

The left inverse to a formal multilinear series is indeed a left inverse, provided its linear term is invertible.

The right inverse of a formal multilinear series #

noncomputable def formal_multilinear_series.right_inv {π•œ : Type u_1} [nontrivially_normed_field π•œ] {E : Type u_2} [normed_add_comm_group E] [normed_space π•œ E] {F : Type u_3} [normed_add_comm_group F] [normed_space π•œ F] (p : formal_multilinear_series π•œ E F) (i : E ≃L[π•œ] F) :

The right inverse of a formal multilinear series, where the n-th term is defined inductively in terms of the previous ones to make sure that p ∘ (right_inv p i) = id. For this, the linear term p₁ in p should be invertible. In the definition, i is a linear isomorphism that should coincide with p₁, so that one can use its inverse in the construction. The definition does not use that i = p₁, but proofs that the definition is well-behaved do.

The n-th term in p ∘ q is βˆ‘ pβ‚– (q_{j₁}, ..., q_{jβ‚–}) over j₁ + ... + jβ‚– = n. In this expression, qβ‚™ appears only once, in p₁ (qβ‚™). We adjust the definition of qβ‚™ so that this term compensates the rest of the sum, using i⁻¹ as an inverse to p₁.

These formulas only make sense when the constant term pβ‚€ vanishes. The definition we give is general, but it ignores the value of pβ‚€.

Equations
@[simp]
theorem formal_multilinear_series.right_inv_coeff_zero {π•œ : Type u_1} [nontrivially_normed_field π•œ] {E : Type u_2} [normed_add_comm_group E] [normed_space π•œ E] {F : Type u_3} [normed_add_comm_group F] [normed_space π•œ F] (p : formal_multilinear_series π•œ E F) (i : E ≃L[π•œ] F) :
p.right_inv i 0 = 0
@[simp]
theorem formal_multilinear_series.right_inv_coeff_one {π•œ : Type u_1} [nontrivially_normed_field π•œ] {E : Type u_2} [normed_add_comm_group E] [normed_space π•œ E] {F : Type u_3} [normed_add_comm_group F] [normed_space π•œ F] (p : formal_multilinear_series π•œ E F) (i : E ≃L[π•œ] F) :
theorem formal_multilinear_series.right_inv_remove_zero {π•œ : Type u_1} [nontrivially_normed_field π•œ] {E : Type u_2} [normed_add_comm_group E] [normed_space π•œ E] {F : Type u_3} [normed_add_comm_group F] [normed_space π•œ F] (p : formal_multilinear_series π•œ E F) (i : E ≃L[π•œ] F) :

The right inverse does not depend on the zeroth coefficient of a formal multilinear series.

theorem formal_multilinear_series.comp_right_inv_aux1 {π•œ : Type u_1} [nontrivially_normed_field π•œ] {E : Type u_2} [normed_add_comm_group E] [normed_space π•œ E] {F : Type u_3} [normed_add_comm_group F] [normed_space π•œ F] {n : β„•} (hn : 0 < n) (p : formal_multilinear_series π•œ E F) (q : formal_multilinear_series π•œ F E) (v : fin n β†’ F) :
⇑(p.comp q n) v = {c : composition n | 1 < c.length}.to_finset.sum (Ξ» (c : composition n), ⇑(p c.length) (q.apply_composition c v)) + ⇑(p 1) (Ξ» (i : fin 1), ⇑(q n) v)
theorem formal_multilinear_series.comp_right_inv_aux2 {π•œ : Type u_1} [nontrivially_normed_field π•œ] {E : Type u_2} [normed_add_comm_group E] [normed_space π•œ E] {F : Type u_3} [normed_add_comm_group F] [normed_space π•œ F] (p : formal_multilinear_series π•œ E F) (i : E ≃L[π•œ] F) (n : β„•) (v : fin (n + 2) β†’ F) :
{c : composition (n + 2) | 1 < c.length}.to_finset.sum (Ξ» (c : composition (n + 2)), ⇑(p c.length) (formal_multilinear_series.apply_composition (Ξ» (k : β„•), ite (k < n + 2) (p.right_inv i k) 0) c v)) = {c : composition (n + 2) | 1 < c.length}.to_finset.sum (Ξ» (c : composition (n + 2)), ⇑(p c.length) ((p.right_inv i).apply_composition c v))
theorem formal_multilinear_series.comp_right_inv {π•œ : Type u_1} [nontrivially_normed_field π•œ] {E : Type u_2} [normed_add_comm_group E] [normed_space π•œ E] {F : Type u_3} [normed_add_comm_group F] [normed_space π•œ F] (p : formal_multilinear_series π•œ E F) (i : E ≃L[π•œ] F) (h : p 1 = ⇑((continuous_multilinear_curry_fin1 π•œ E F).symm) ↑i) (h0 : p 0 = 0) :

The right inverse to a formal multilinear series is indeed a right inverse, provided its linear term is invertible and its constant term vanishes.

theorem formal_multilinear_series.right_inv_coeff {π•œ : Type u_1} [nontrivially_normed_field π•œ] {E : Type u_2} [normed_add_comm_group E] [normed_space π•œ E] {F : Type u_3} [normed_add_comm_group F] [normed_space π•œ F] (p : formal_multilinear_series π•œ E F) (i : E ≃L[π•œ] F) (n : β„•) (hn : 2 ≀ n) :

Coincidence of the left and the right inverse #

theorem formal_multilinear_series.left_inv_eq_right_inv {π•œ : Type u_1} [nontrivially_normed_field π•œ] {E : Type u_2} [normed_add_comm_group E] [normed_space π•œ E] {F : Type u_3} [normed_add_comm_group F] [normed_space π•œ F] (p : formal_multilinear_series π•œ E F) (i : E ≃L[π•œ] F) (h : p 1 = ⇑((continuous_multilinear_curry_fin1 π•œ E F).symm) ↑i) :

The left inverse and the right inverse of a formal multilinear series coincide. This is not at all obvious from their definition, but it follows from uniqueness of inverses (which comes from the fact that composition is associative on formal multilinear series).

Convergence of the inverse of a power series #

Assume that p is a convergent multilinear series, and let q be its (left or right) inverse. Using the left-inverse formula gives $$ q_n = - (p_1)^{-n} \sum_{k=0}^{n-1} \sum_{i_1 + \dotsc + i_k = n} q_k (p_{i_1}, \dotsc, p_{i_k}). $$ Assume for simplicity that we are in dimension 1 and p₁ = 1. In the formula for qβ‚™, the term q_{n-1} appears with a multiplicity of n-1 (choosing the index i_j for which i_j = 2 while all the other indices are equal to 1), which indicates that qβ‚™ might grow like n!. This is bad for summability properties.

It turns out that the right-inverse formula is better behaved, and should instead be used for this kind of estimate. It reads $$ q_n = - (p_1)^{-1} \sum_{k=2}^n \sum_{i_1 + \dotsc + i_k = n} p_k (q_{i_1}, \dotsc, q_{i_k}). $$ Here, q_{n-1} can only appear in the term with k = 2, and it only appears twice, so there is hope this formula can lead to an at most geometric behavior.

Let Qβ‚™ = βˆ₯qβ‚™βˆ₯. Bounding βˆ₯pβ‚–βˆ₯ with C r^k gives an inequality $$ Q_n ≀ C' \sum_{k=2}^n r^k \sum_{i_1 + \dotsc + i_k = n} Q_{i_1} \dotsm Q_{i_k}. $$

This formula is not enough to prove by naive induction on n a bound of the form Qβ‚™ ≀ D R^n. However, assuming that the inequality above were an equality, one could get a formula for the generating series of the Qβ‚™:

$$ \begin{align} Q(z) & := \sum Q_n z^n = Q_1 z + C' \sum_{2 \leq k \leq n} \sum_{i_1 + \dotsc + i_k = n} (r z^{i_1} Q_{i_1}) \dotsm (r z^{i_k} Q_{i_k}) \\ & = Q_1 z + C' \sum_{k = 2}^\infty (\sum_{i_1 \geq 1} r z^{i_1} Q_{i_1}) \dotsm (\sum_{i_k \geq 1} r z^{i_k} Q_{i_k}) \\ & = Q_1 z + C' \sum_{k = 2}^\infty (r Q(z))^k = Q_1 z + C' (r Q(z))^2 / (1 - r Q(z)). \end{align} $$

One can solve this formula explicitly. The solution is analytic in a neighborhood of 0 in β„‚, hence its coefficients grow at most geometrically (by a contour integral argument), and therefore the original Qβ‚™, which are bounded by these ones, are also at most geometric.

This classical argument is not really satisfactory, as it requires an a priori bound on a complex analytic function. Another option would be to compute explicitly its terms (with binomial coefficients) to obtain an explicit geometric bound, but this would be very painful.

Instead, we will use the above intuition, but in a slightly different form, with finite sums and an induction. I learnt this trick in [Pos17]. Let $S_n = \sum_{k=1}^n Q_k a^k$ (where a is a positive real parameter to be chosen suitably small). The above computation but with finite sums shows that

$$ S_n \leq Q_1 a + C' \sum_{k=2}^n (r S_{n-1})^k. $$

In particular, $S_n \leq Q_1 a + C' (r S_{n-1})^2 / (1- r S_{n-1})$. Assume that $S_{n-1} \leq K a$, where K > Q₁ is fixed and a is small enough so that r K a ≀ 1/2 (to control the denominator). Then this equation gives a bound $S_n \leq Q_1 a + 2 C' r^2 K^2 a^2$. If a is small enough, this is bounded by K a as the second term is quadratic in a, and therefore negligible.

By induction, we deduce Sβ‚™ ≀ K a for all n, which gives in particular the fact that aⁿ Qβ‚™ remains bounded.

theorem formal_multilinear_series.radius_right_inv_pos_of_radius_pos_aux1 (n : β„•) (p : β„• β†’ ℝ) (hp : βˆ€ (k : β„•), 0 ≀ p k) {r a : ℝ} (hr : 0 ≀ r) (ha : 0 ≀ a) :
(finset.Ico 2 (n + 1)).sum (Ξ» (k : β„•), a ^ k * {c : composition k | 1 < c.length}.to_finset.sum (Ξ» (c : composition k), r ^ c.length * finset.univ.prod (Ξ» (j : fin c.length), p (c.blocks_fun j)))) ≀ (finset.Ico 2 (n + 1)).sum (Ξ» (j : β„•), r ^ j * (finset.Ico 1 n).sum (Ξ» (k : β„•), a ^ k * p k) ^ j)

First technical lemma to control the growth of coefficients of the inverse. Bound the explicit expression for βˆ‘_{k<n+1} aᡏ Qβ‚– in terms of a sum of powers of the same sum one step before, in a general abstract setup.

theorem formal_multilinear_series.radius_right_inv_pos_of_radius_pos_aux2 {π•œ : Type u_1} [nontrivially_normed_field π•œ] {E : Type u_2} [normed_add_comm_group E] [normed_space π•œ E] {F : Type u_3} [normed_add_comm_group F] [normed_space π•œ F] {n : β„•} (hn : 2 ≀ n + 1) (p : formal_multilinear_series π•œ E F) (i : E ≃L[π•œ] F) {r a C : ℝ} (hr : 0 ≀ r) (ha : 0 ≀ a) (hC : 0 ≀ C) (hp : βˆ€ (n : β„•), βˆ₯p nβˆ₯ ≀ C * r ^ n) :
(finset.Ico 1 (n + 1)).sum (Ξ» (k : β„•), a ^ k * βˆ₯p.right_inv i kβˆ₯) ≀ βˆ₯↑(i.symm)βˆ₯ * a + βˆ₯↑(i.symm)βˆ₯ * C * (finset.Ico 2 (n + 1)).sum (Ξ» (k : β„•), (r * (finset.Ico 1 n).sum (Ξ» (j : β„•), a ^ j * βˆ₯p.right_inv i jβˆ₯)) ^ k)

Second technical lemma to control the growth of coefficients of the inverse. Bound the explicit expression for βˆ‘_{k<n+1} aᡏ Qβ‚– in terms of a sum of powers of the same sum one step before, in the specific setup we are interesting in, by reducing to the general bound in radius_right_inv_pos_of_radius_pos_aux1.

theorem formal_multilinear_series.radius_right_inv_pos_of_radius_pos {π•œ : Type u_1} [nontrivially_normed_field π•œ] {E : Type u_2} [normed_add_comm_group E] [normed_space π•œ E] {F : Type u_3} [normed_add_comm_group F] [normed_space π•œ F] (p : formal_multilinear_series π•œ E F) (i : E ≃L[π•œ] F) (hp : 0 < p.radius) :

If a a formal multilinear series has a positive radius of convergence, then its right inverse also has a positive radius of convergence.