Next Article in Journal
Mathematical Calculations for the Design of Elliptical Isolated Foundations with Optimal Cost
Previous Article in Journal
An Exploratory Assessment of LLMs’ Potential for Flight Trajectory Reconstruction Analysis
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Projected Gradient Descent Method for Tropical Principal Component Analysis over Tree Space

by
Ruriko Yoshida
Department of Operations Research, Naval Postgraduate School, Monterey, CA 93943, USA
Mathematics 2025, 13(11), 1776; https://doi.org/10.3390/math13111776
Submission received: 16 April 2025 / Revised: 23 May 2025 / Accepted: 24 May 2025 / Published: 27 May 2025

Abstract

:
Tropical Principal Component Analysis (PCA) is an analogue of the classical PCA in the setting of tropical geometry, and applied it to visualize a set of gene trees over a space of phylogenetic trees, which is a union of lower-dimensional polyhedral cones in an Euclidean space with dimension m ( m 1 ) / 2 , where m is the number of leaves. In this paper, we introduce a projected gradient descent method to estimate the tropical principal polytope over the space of phylogenetic trees, and we apply it to an Apicomplexa dataset. With computational experiments against Markov Chain Monte Carlo (MCMC) samplers, we show that our projected gradient descent method yields a lower sum of tropical distances between observations and their projections onto the estimated best-fit tropical polytope, compared with the MCMC-based approach.

1. Introduction

Phylogenomics is a relatively new field that applies tools from phylogenetics to genome data. One of the key tasks in phylogenomics is to analyze gene trees, which are phylogenetic trees representing the evolutionary histories of genes in the genome. In this work, we use an unsupervised learning method to visualize how gene trees are distributed over the space of phylogenetic trees, that is, the set of all possible phylogenetic trees with a fixed set of labels for all leaves.
A phylogenetic tree T on a given set of leaves [ m ] : = { 1 , , m } is a weighted tree in which the internal nodes in T are unlabeled, their leaves X are labeled, and their branch lengths represent evolutionary time and mutation rates. In phylogenetics, a phylogenetic tree on the set of species [ m ] represents their evolutionary history. In phylogenomics, we construct a phylogenetic tree from an alignment or sequence data for each gene in a given genome. A phylogenetic tree reconstruced from a gene alignment is called a gene tree. Since different genes may have distinct evolutionary histories, gene trees can vary in topology and branch lengths. Thus, it is a statistical challenge to analyze a set of phylogenetic trees.
When conducting statistical analysis on a set of phylogenetic trees, we represent each tree as a vector in a high-dimensional vector space. One common method is to compute all pairwise distances between two distinct leaves in [ m ] , resulting in R m 2 . However, not every vector in R m 2 corresponds to a valid phylogenetic tree on [ m ] . In 1974, Buneman showed [1] that a vector derived from all possible pairwise distances between leaves in [ m ] must satisfy the four-point conditions to represent a phylogenetic tree. For an equidistant tree—namely, a rooted phylogenetic tree in which the total edge weight from the root to each leaf in [ m ] is equal (see Definition 9)—the vector must satisfy the three-point condition to correspond to the phylogenetic tree (Theorem 1).
In 2006, Ardila and Klivans showed that the space of all phylogenetic trees on [ m ] is a union of m 2 dimensional cones in R m 2 , and that this space is not classically convex [2]. Therefore, classical statistical methods cannot be directly applied to a set of phylogenetic trees, as these methods assume a Euclidean sample space.
However, Ardila and Klivans also showed that the space of equidistant trees—rooted phylogenetic trees on [ m ] as defined in Definition 9—is a tropical Grasmaniann. So, the space of equidistant trees on [ m ] is tropically convex and forms a tropical linear space with the max-plus algebra over the tropical projective space. Therefore, we can apply tropical linear algebra to perform statistical analysis on the space of equidistant trees on [ m ] .
In 2019, Yoshida et al. introduced tropical principal component analysis (PCA), an analogue of a classical PCA from the perspective of tropical geometry, to visualize how gene trees are distributed over the space of equidistant trees on [ m ] using max-plus algebra [3]. For s m 2 , they defined the ( s 1 ) -th order tropcial principal polytope, or the best-fit tropical polytope with s vertices, whose vertices serve as analogues of the classical first s principal components.They showed that computing these vertices can be formulated as a mixed integer linear programming problem, as shown in Problem 1 [3]. Later, Page et al.  developed a Markov Chain Monte Carlo (MCMC) method to estimate the vertices of the tropical principal polytope from a set of gene trees.
In this work, inspired by the recent work of tropical gradient descent defined in [4], we introduce a projected gradient descent method to compute the set of vertices of the tropical principal polytope from a set of gene trees. We compute subgradients in order to find the optimal solution for the mixed integer programming problem in order to compute the tropical principal polytope shown in Theorem 3. Then, we apply our novel method to Apicomplexa data from [5], and our experiments using the R package TML version 2.3.0 [6] show that our method outperforms existing approaches in terms of computational time and cost function.
This paper is organized as follows. In Section 2, we introduce the basics of tropical geometry. In Section 3, we review the notions of metrics and ultrametrics, and discuss the isometry between the space of equidistant trees on [ m ] and the space of ultrametrics on the finite set [ m ] , based on results by Buneman [1]. In Section 4, we present tropical PCA and the s-th order tropical principal polytope for s e , where e : = m 2 . Section 5 provides experimental results on the Apicomplexa dataset from [5].

2. Tropical Basics

In this section, we introduce the basics of tropical geometry to be used for our main results. Let 1 = ( 1 , , 1 ) R e . Then, through this paper, we consider the tropical projective torus, R e / R 1 which is isomorphic to R e 1 . This means that R e / R 1 is equivalent to a hyperplane in R e . This implies that for a point x : = ( x 1 , , x e ) R e / R 1 ,
( x 1 , , x e ) = ( x 1 + c , , x e + c )
where c R . See [7] for more details.
Throughout this paper, we consider tropically convex sets defined by the max-plus algebra provided in Definition 1.
Definition 1 (Tropical Arithmetic Operations). 
The tropical semiring ( R { } , , ) is defined using the following tropical additionand multiplication:
a b : = max { a , b } , a b : = a + b
for any a , b R { } .
Remark 1. 
is the identity element under additionand 0 is the identity element under multiplicationover ( R { } , , ) .
Definition 2 (Tropical Scalar Multiplication and Vector Addition). 
For any a , b R { } and for any v = ( v 1 , , v e ) , w = ( w 1 , , w e ) ( R { } ) e , the tropical scalar multiplication and tropical vector addition are defined as:
a v b w : = ( max { a + v 1 , b + w 1 } , , max { a + v e , b + w e } ) .
Definition 3 (Generalized Hilbert Projective Metric). 
For any points v : = ( v 1 , , v d ) , w : = ( w 1 , , w e ) R e / R 1 , the tropical metric, d tr , between v and w, is defined as:
d tr ( v , w ) : = max i { 1 , , e } v i w i min i { 1 , , e } v i w i .
Remark 2. 
The tropical metric d tr is the metric over R e / R 1 .
Definition 4. 
A subset S R e is called tropically convex if it contains the point a x b y for all x , y S and all a , b R . The tropical convex hull or tropical polytope, tconv ( V ) , of a given finite subset V R e is the smallest tropically convex set containing V R e . In addition, tconv ( V ) can be written as the set of all tropical linear combinations
tconv ( V ) = { a 1 v 1 a 2 v 2 a r v r : v 1 , , v r V a n d a 1 , , a r R } .
Any tropically convex subset S of R e is closed under tropical scalar multiplication, R S S , i.e., if x S , then x + c · 1 S for all c R . Thus, the tropically convex set S is identified as its quotient in the tropical projective torus R e / R 1 .
Definition 5 
(Max-tropical Hyperplane [8]). A max-tropical hyperplane H ω max is the set of points x R e / R 1 , such that
max i { 1 , , e } { x i + ω i }
is attained at least twice, where ω : = ( ω 1 , , ω e ) R e / R 1 .
Definition 6 
(Min-tropical Hyperplane [8]). A min-tropical hyperplane H ω min is the set of points x R d / R 1 , such that
min i { 1 , , e } { x i + ω i }
is attained at least twice, where ω : = ( ω 1 , , ω e ) R e / R 1 .
Remark 3. 
A min-tropical hyperplane H ω min and a max-tropical hyperplane H ω max are tropically convex over ( R { } ) e / R 1 .
Definition 7 
(Max-tropical Sectors from Section 5.5 in [8]). For i [ e ] , the i-th open sector of H ω max is defined as
S ω max , i : = { x R e / R 1 | ω i + x i > ω j + x j , j i } .
and the i-th closed sector of H ω max is defined as
S ¯ ω max , i : = { x R e / R 1 | ω i + x i ω j + x j , j i } .
Definition 8 
(Min-tropical Sectors). For i [ d ] , the i-th open sector of H ω min is defined as
S ω min , i : = { x R d / R 1 | ω i + x i < ω j + x j , j i } ,
and the i-th closed sector of H ω min is defined as
S ¯ ω min , i : = { x R d / R 1 | ω i + x i ω j + x j , j i } .

3. Space of Phylogenetic Trees

A phylogenetic tree is a rooted or unrooted tree whose exterior nodes have unique labels, whose interior nodes do not have labels, and whose edges have non-negative weights. In this paper, we focus on an equidistant tree that is a rooted phylogenetic tree, such that a total weight on the path from its root to each leaf on the tree has the same total weight. Let [ m ] : = { 1 , , m } be the set of leaf labels on an equidistant tree T.
Definition 9. 
An equidistant tree T on [ m ] is a rooted phylogenetic tree on [ m ] , such that the total weight from the root to each leaf i [ m ] is equal to a constant h > 0 for all i [ m ] . h is the height of T.
Example 1. 
Figure 1 shows an equidistant tree a height 1 on [ 4 ] : = { 1 , 2 , 3 , 4 } .
Suppose D ( i , j ) is the total weight on the unique path from a leaf i [ m ] and a leaf j [ m ] on a phylogenetic tree T. Then, D = ( D ( 1 , 2 ) , D ( 1 , 3 ) , , D ( m 1 , m ) ) R 0 e , where e : = m 2 , is a metric, that is, D satisfies
D ( i , j ) D ( i , k ) + D ( k , j ) D ( i , j ) = D ( j , i ) D ( i , j ) = 0
for all i , j , k [ m ] . The metric D is the tree metric of a phylogenetic tree T.
If metric D satisfies
max { D ( i , j ) , D ( i , k ) , D ( k , j ) }
and this maximum is achieved at least twice for distinct i , j , k [ m ] , then D is called an ultrametric. Suppose D ( i , j ) is the total weight of the path from i , i [ m ] from an equidistant tree T, then we have the following theorem.
Theorem 1 
(noted in [1]). Suppose we have an equidistant tree T with a leaf label set [ m ] and D as its tree metric. Then, D is an ultrametric if and only if T is an equidistant tree. In addition, we can uniquely reconstruct T from D.
Using Theorem 1, we consider the space of ultrametrics on [ m ] as the space of phylogenetic trees, which is the set of all possible equidistant trees with the leaf set [ m ] . Let U m be the space of ultrametrics on [ m ] .
With tropical geometry, it can be shown that U m is a tropical subspace over the tropical projective space ( R { } ) e / R 1 . Let L m denote the subspace of R e , defined by the linear equations, such that x i j x i k + x j k = 0 for 1 i < j < k m . The tropicalization Trop ( L m ) ( R { } ) e / R 1 is the tropical linear space consisting of points ( u 12 , u 13 , , u m 1 , m ) , such that, for any max ( u i j , u i k , u j k ) , the maximum of i , j , k [ m ] is achieved at least twice.
In addition, it is important to note that the tropical linear space Trop ( L m ) corresponds to the graphic matroid of the complete graph K m .
Theorem 2 
(Theorem 2.18 in [3]). The image of U m in the tropical projective torus R e / R 1 coincides with Trop ( L m ) .

Projection onto Tree Space

In tropical geometry, it is well-known that U m is the support of a pointed simplicial fan of dimension m 2 and it has 2 m m 2 rays, defined as clade metrics [2].
Definition 10. 
Suppose we have an equidistant phylogenetic tree T with leaf set [ m ] . A clade of T with leaves σ [ m ] is the equidistant subtree of T formed by including all common ancestral interior nodes of combinations of leaves in σ, while excluding any common ancestors that involve leaves from X σ in T, along with the edges in T that connect these interior nodes to the leaves in σ.
We note that a clade of an equidistant tree T with leaf set σ [ m ] is a subtree of T with leaves σ . Feichtner showed that each topology of equidistant trees can be encoded by a nested set, that is, a set of clades { σ 1 , , σ C } , where C { 1 , , m 2 } , such that
σ i σ j , or   σ j σ i , or   σ i σ j =
for all 1 i j C and | σ k |     2 for all k = 1 , , C [9].
Definition 11 
(Clade Ultrametrics). We consider an equidistant tree T on the leaf set [ m ] . Let σ [ m ] be a proper subset of [ m ] with at least two elements. Let D σ : = ( D σ ( 1 , 2 ) , , D σ ( m 1 , m ) ) U m , such that
D σ ( i , j ) = 0 i f   i , j σ 1 o t h e r w i s e .
Then, D σ is called a clade ultrametric.
We note that Ardila and Klivans showed that the set of clade ultrametrics forms a set of generators—i.e., rays—of a pointed simplicial fan of dimension m 2 , in terms of classical arithmetic in Euclidean geometry. In this paper, we use an extreme clade ultrametric, which is an analogue of a clade ultrametric defined using the max-plus algebra. This is done by replacing the identity element of classical addition with the identity of tropical addition ⊕ (namely, replacing 0 with ), and replacing the identity element of classical multiplication with that of tropical multiplication ⊙ (namely, replacing 1 with 0).
Definition 12 
(Extreme Clade Ultrametrics). We consider an equidistant tree T on the leaf set [ m ] . Let σ [ m ] be a proper subset with at least two elements. Let D σ : = ( D σ ( 1 , 2 ) , , D σ ( m 1 , m ) ) U m , such that
D σ ( i , j ) = i f   i , j σ 0 o t h e r w i s e .
Then, D σ is called an extreme clade ultrametric.
Remark 4. 
In polyhedral geometry, a polyhedral cone generated by a set of rays V = { v 1 , , v k } R e 1 is defined as
C ( V ) = x R e 1 | x = i = 1 k α i v i , α i 0   f o r   a l l   i = 1 , , k .
We replace classical addition withand classical multiplication withfor V = { v 1 , , v k } R e / R 1 R e 1 ; thus, we have
T r o p ( C ( V ) ) = x R e / R 1 | x = i = 1 k α i v i , α i R   f o r   a l l   i = 1 , , k
which is a tropical polytope defined by V.
Proposition 1 
([10]). The set of all extreme clade ultrametrics, U m , is a generating set of U m in terms of max-plus algebra.
Proposition 1 is a tropical geometric analogue of the simplicial complex result by Ardila and Klivans in [2], obtained by replacing classical addition with ⊕ and classical multiplication with ⊙.
Definition 13 
(Projection Map [10]). The tropical projection map to ultrametric tree space π U m : ( R { } ) e / R 1 U m is given by
π U m ( x ) = v U m λ v v , λ v = min j : v j = 0 { x j }
for x : = ( x 1 , , x e ) R e / R 1 .
Proposition 2 
([10]). For all x R e / R 1 , we have
d tr ( x , x ) d tr ( x , y )
for all y U m , and where x = π U m ( x ) is defined by Definition 13.
The following proposition is key to the projected gradient methods we proposed in Section 4.
Proposition 3 
(Lemma 19, [11]). The projection map π U m ( x ) is non-expansive in terms of d tr , i.e.,
d tr ( π U m ( u ) , π U m ( v ) ) d tr ( u , v )
for all u , v R e / R 1 .
Remark 5. 
The projection map π U m is equivalent to the single linkage hierarchical clustering method [12]. Therefore, in the computational experiment described in Section 5, we use a single linkage hierarchical clustering method to projecting a subgradient.

4. Tropical Principal Component Analysis

Yoshida et al. introduced the notion of tropical principal component analysis (PCA), an analysis based on the best-fit tropical hyperplane or tropical polytope [3]. In particular, they applied tropical PCA using tropical polytopes to samples of ultrametrics within the space of ultrametrics. In this section, we consider U m R e / R 1 , where m is the number of leaves and e = m 2 . Suppose we have a sample S : = { u 1 , u n } U m .
Definition 14 
(Definition 3.1 in [13]). The ( s 1 ) -th order tropical principal polytope P minimizes
i = 1 n d tr ( u i , w i )
where w i is the projection onto a tropical polytope P with s many vertices, that is
d tr ( u i , w i ) d tr ( u i , x )
for all x P for S : { u 1 , u n } , which is called the ( s 1 ) th-order tropical principal component polytope of the sample S . The s vertices of the tropical principal component polytope P are called the ( s 1 ) th order tropical principal components, or equivalently, the best-fit tropical polytope with s vertices.
Remark 6. 
The 0-th tropical principal polytope is a tropical Fermat–Weber point of a sample S with respect to d tr . A tropical Fermat–Weber point of S with respect to d tr is defined as
x * : = arg min x R e / R 1 i = 1 n d tr ( x , u i ) .
A tropical Fermat–Weber point of S with respect to d tr is not necessarily unique, and the set of all tropical Fermat–Weber points forms both a classical polytope and a tropical polytope [14].
In this paper, we focus on the ( s 1 ) -th order principal components over U m R e / R 1 for s > 1 . Our problem can be written as follows:
Problem 1. 
We seek a solution for the following optimization problem:
min D ( 1 ) , , D ( s ) U m i = 1 n d tr ( u i , w i )
where
w i = λ 1 i D ( 1 ) λ s i D ( s ) , where λ k i = min ( u i D ( k ) ) ,
and
d tr ( u i , w i ) = max { | u i ( k ) w i ( k ) u i ( l ) + w i ( l ) | : 1 k < l e }
with
u i = ( u i ( 1 ) , , u i ( e ) ) and w i = ( w i ( 1 ) , , w i ( e ) ) .
Remark 7 
(Proposition 4.2 in [3]). Problem 1 can be formulated as a mixed integer programming problem.
In this section, we consider subgradients of Problem 1. Here, we are interested in computing
d tr ( u i , w i ) D ( k ) .
First, we notice that
d tr ( u i , w i ) D ( k ) = d tr ( u i , w i ) w i w i D ( k )
by the product rule.
Let
δ i j = 1 i f   i = j 0 o t h e r w i s e .
be Kronecker’s Delta. Then, we have the following lemma:
Lemma 1 
(Lemma 10 in [14]). For any two points x , p R e / R 1 , the gradient at x of the tropical distance between x and p is given by
d tr ( p , x ) x ( l ) = δ l t δ l t x S p max , t S p min , t .
provided there are no ties in ( x p ) , which ensures that the min- and max-sectors are uniquely identifiable; that is, the point x is inside of open sectors and not on the boundary of H p .
Also, we notice that
w i ( l ) = max min j ( u i ( j ) D ( 1 ) ( j ) ) 1 + D ( 1 ) ( l ) , , min j ( u i ( j ) D ( s ) ( j ) ) 1 + D ( s ) ( l ) ,
for l = 1 , , e .
Lemma 2. 
w i ( l ) D ( k ) ( l ) = 1 i f argmax k D ( k ) + min j ( u i ( j ) D ( k ) ( j ) ) 1 ( l ) = k , min j ( u i ( j ) D ( k ) ( j ) ) = l ,   a n d   l l , 1 i f argmax k D ( k ) + min j ( u i ( j ) D ( k ) ( j ) ) 1 ( l ) = k , min j ( u i ( j ) D ( k ) ( j ) ) l ,   a n d   l = l , 0 o t h e r w i s e ,
for i = 1 , , n , k = 1 , , s , and for l = 1 , , e .
Proof. 
Direct computation from the equation in (12).    □
Lemma 3. 
Subgradients of Problem 1 over R e / R 1 is
i = 1 n d tr ( u i , w i ) D ( k ) ( l ) = i = 1 n d tr ( u i , w i ) w i ( l ) w i ( l ) D ( k ) ( l )
which can be obtained by Equations (11) and (12).
Theorem 3. 
The subgradient of Problem 1 over U m is
π U m i = 1 n d tr ( u i , w i ) D ( k ) ( l )
where i = 1 n d tr ( u i , w i ) D ( k ) ( l ) is obtained in Lemma 3.
Proof. 
Using Proposition 3, we know that π U m is non-expanding in terms of d tr . Therefore, we have
d 0 , π U m i = 1 n d tr ( u i , w i ) D ( k ) ( l ) ( x ) d tr 0 , i = 1 n d tr ( u i , w i ) D ( k ) ( l ) ( x ) .
Therefore,
d 0 , π U m i = 1 n d tr ( u i , w i ) D ( k ) ( l ) ( x ) = 0
when x is at a critical point.
Suppose x * U m is an optimal solution for the Problem 1. Then, let
x t + 1 : = x t α t i = 1 n d tr ( u i , w i ) D ( k ) ( l ) ( x t ) .
Since
i = 1 n d tr ( u i , w i ) D ( k ) ( l )
is a subgradient in Lemma 3, we have
i = 1 n d tr ( u i , π t c o n v ( D ( 1 ) , , D ( k 1 ) , x t + 1 , D ( k + 1 ) , , D ( s ) ) ( u i ) ) i = 1 n d tr ( u i , π t c o n v ( D ( 1 ) , , D ( k 1 ) , x t , D ( k + 1 ) , , D ( s ) ) ( u i ) ) ,
for k = 1 , , s . Using Proposition 3, we have
i = 1 n d tr π U m ( u i ) , π U m π t c o n v ( D ( 1 ) , , D ( k 1 ) , x t + 1 , D ( k + 1 ) , , D ( s ) ) ( u i ) = i = 1 n d tr u i , π U m π t c o n v ( D ( 1 ) , , D ( k 1 ) , x t + 1 , D ( k + 1 ) , , D ( s ) ) ( u i ) i = 1 n d tr ( u i , π t c o n v ( D ( 1 ) , , D ( k 1 ) , x t + 1 , D ( k + 1 ) , , D ( s ) ) ( u i ) ) i = 1 n d tr ( u i , π t c o n v ( D ( 1 ) , , D ( k 1 ) , x t , D ( k + 1 ) , , D ( s ) ) ( u i ) ) ,
for k = 1 , , s .    □

5. Computational Experiments

5.1. Simulated Dataset

Next, we generate gene trees under the multispecies coalescent model (MCM) using a given species tree via the software Mesquite version 3.81 [15]. We fixed the effective population size at N e = 100 , 000 and varied R = S D N e where S D is the species depth, defined as the number of generations from the most recent common ancestor (the root of the tree) to its leaves.
In this experiment, we simulate 1000 trees for each valuee of R = 0.25, 0.5, 1.0, 2.0, 5.0, 10.0. We run 100 iterations of both the MCMC method and our projected gradient method. To account for variability in performance, we repeat both methods 10 times for each R. For each run, we compute the sum of tropical distances d tr between the observed trees and their projections onto the estimated tropical polytope. This sum, representing the total “magnitude of errors” (SE) in terms of d tr ), corresponds to the estimated optimal value of the linear programming problem in Problem 1. The results are shown in Figure 2. For the learning rate schedule, we start with λ = 0.001 and multiply it by 0.999 at each iteration. Note that this learning rate has not been optimized. Therefore, investigating an optimal learning rates remains a direction for future work. As for the stopping criterion, we terminate the algorithm when the preset maximum number of iterations is reached. Each iteration has time complecity O ( m 2 n ) , where n is the sample size.

5.2. Empirical Dataset

We apply our projected gradient method to estimate the best-fit tropical polytope for an empirical dataset consisting of 268 orthologous sequences from eight protozoa species, as presented in [5]. This dataset contains gene trees reconstructed from the following sequences: Babesia bovis (Bb), Cryptosporidium parvum (Cp), Eimeria tenella (Et) [15], Plasmodium falciparum (Pf) [11], Plasmodium vivax (Pv), Theileria annulata (Ta), and Toxoplasma gondii (Tg). The outgroup is a free-living ciliate, Tetrahymena thermophila (Tt) (Figure 3).
In order to run this experiment, we used a Mac Pro laptop (Apple Inc., Cupertino, CA, USA) with Apple M4 Max and 128 GB memory. We implemented our projected gradient method using R.
We set the maximum number of iterations to 100 for our projected gradient method, and to 1000 for the MCMC method. For the learning rate schedule, we initialize λ = 0.01 and multiply it by 0.999 at each iteration. Note that the learning rate and scheduling have not been optimized. Using the projected gradient descent to estimate the tropical principal polytope on this dataset takes 6.82 s, resulting in an estimated optimal value of 360.8589 for the optimization problem in Problem 1. In comparison, the Markov Chain Monte Carlo (MCMC) method implemented via the TML package [6] yields an estimated optimal value of 397.6459 , with a computational time of 54.70 s over 1000 iterations.

6. Conclusions

In this work, we introduce a novel method to approximate the best-fit tropical polytope that explains a sample of gene trees. We show that our gradient method effectively reduces the objective function when an appropriate learning rate is used. Computational experiments show that this method achieves a lower sum of tropical distances between observations and their projections onto the estimated best-fit tropical polytope, compared to the MCMC approach proposed by Page et al. [13]. Although we implement a decreasing learning rate in our experiments, the optimal learning rate schedule for this problem remains an open question.
We implement our method in R and the source code is available at http://polytopes.net/Tropical_Gradient2.zip (accessed on 15 May 2025).

Funding

This research was funded by NSF Division of Mathematical Sciences: Statistics Program DMS 2409819.

Data Availability Statement

The original contributions presented in this study are included in the article. Further inquiries can be directed to the corresponding author.

Conflicts of Interest

The author declares no conflicts of interest.

Abbreviations

The following abbreviations are used in this manuscript:
PCAPrincipal Component Analysis
MCMCMarkov Chain Monte Carlo

References

  1. Buneman, P. A note on the metric properties of trees. J. Comb. Theory Ser. B 1974, 17, 48–50. [Google Scholar] [CrossRef]
  2. Ardila, F.; Klivans, C.J. The Bergman Complex of a Matroid and Phylogenetic Trees. J. Comb. Theory Ser. B 2006, 96, 38–49. [Google Scholar] [CrossRef]
  3. Yoshida, R.; Zhang, L.; Zhang, X. Tropical Principal Component Analysis and its Application to Phylogenetics. Bull. Math. Biol. 2019, 81, 568–597. [Google Scholar] [CrossRef] [PubMed]
  4. Talbut, R.; Monod, A. Tropical Gradient Descent. arXiv 2024, arXiv:2405.19551. [Google Scholar] [CrossRef]
  5. Kuo, C.; Wares, J.P.; Kissinger, J.C. The Apicomplexan Whole-Genome Phylogeny: An Analysis of Incongruence among Gene Trees. Mol. Biol. Evol. 2008, 25, 2689–2698. [Google Scholar] [CrossRef] [PubMed]
  6. Barnhill, D.; Yoshida, R.; Aliatimis, G.; Miura, K. Tropical geometric tools for machine learning: The TML package. J. Softw. Algebra Geom. 2024, 14, 133–174. [Google Scholar] [CrossRef]
  7. Maclagan, D.; Sturmfels, B. Introduction to Tropical Geometry; Graduate Studies in Mathematics; American Mathematical Society: Providence, RI, USA, 2015; Volume 161. [Google Scholar]
  8. Joswig, M. Essentials of Tropical Combinatorics; Springer: New York, NY, USA, 2021. [Google Scholar]
  9. Feichtner, E.M. Complexes of trees and nested set complexes. Pac. J. Math. 2004, 227, 271–286. [Google Scholar] [CrossRef]
  10. Ardila, F. Subdominant Matroid Ultrametrics. Ann. Comb. 2005, 8, 379–389. [Google Scholar] [CrossRef]
  11. Jaggi, M.; Katz, G.; Wagner, U. New results in tropical discrete geometry. Preprint 2008. Available online: https://api.semanticscholar.org/CorpusID:14825187 (accessed on 14 April 2025).
  12. Gascuel, O.; McKenzie, A. Performance analysis of hierarchical clustering algorithms. J. Classif. 2004, 21, 3–18. [Google Scholar] [CrossRef]
  13. Page, R.; Yoshida, R.; Zhang, L. Tropical principal component analysis on the space of phylogenetic trees. Bioinformatics 2020, 36, 4590–4598. [Google Scholar] [CrossRef] [PubMed]
  14. Barnhill, D.; Sabol, J.; Yoshida, R.; Miura, K. Tropical Fermat-Weber Polytropes. arXiv 2024, arXiv:2402.14287. [Google Scholar] [CrossRef]
  15. Maddison, W.P.; Maddison, D. Mesquite: A Modular System for Evolutionary Analysis. Version 2.72. 2009. Available online: http://mesquiteproject.org (accessed on 11 August 2016).
Figure 1. An equidistant tree with [ 4 ] : = { 1 , 2 , 3 , 4 } from Example 1. The height of the tree is 1.
Figure 1. An equidistant tree with [ 4 ] : = { 1 , 2 , 3 , 4 } from Example 1. The height of the tree is 1.
Mathematics 13 01776 g001
Figure 2. Side-by-side boxplots for the SE for each method and ratio. We repeat computation 10 times for each ratio and method.
Figure 2. Side-by-side boxplots for the SE for each method and ratio. We repeat computation 10 times for each ratio and method.
Mathematics 13 01776 g002
Figure 3. (Left): Estimated second-order tropical principal polytope. (Right): Each color represents a tree topology. The number inside each bracket is the frequency of the tree topology. 1 presents “Pv”, 2 represents “Pf”, 3 represents “Tg”, 4 represents “Et”, 5 represents “Cp”, 6 represents “Ta”, 7 represents “Bb” and 8 represents “Tt”.
Figure 3. (Left): Estimated second-order tropical principal polytope. (Right): Each color represents a tree topology. The number inside each bracket is the frequency of the tree topology. 1 presents “Pv”, 2 represents “Pf”, 3 represents “Tg”, 4 represents “Et”, 5 represents “Cp”, 6 represents “Ta”, 7 represents “Bb” and 8 represents “Tt”.
Mathematics 13 01776 g003
Disclaimer/Publisher’s Note: The statements, opinions and data contained in all publications are solely those of the individual author(s) and contributor(s) and not of MDPI and/or the editor(s). MDPI and/or the editor(s) disclaim responsibility for any injury to people or property resulting from any ideas, methods, instructions or products referred to in the content.

Share and Cite

MDPI and ACS Style

Yoshida, R. Projected Gradient Descent Method for Tropical Principal Component Analysis over Tree Space. Mathematics 2025, 13, 1776. https://doi.org/10.3390/math13111776

AMA Style

Yoshida R. Projected Gradient Descent Method for Tropical Principal Component Analysis over Tree Space. Mathematics. 2025; 13(11):1776. https://doi.org/10.3390/math13111776

Chicago/Turabian Style

Yoshida, Ruriko. 2025. "Projected Gradient Descent Method for Tropical Principal Component Analysis over Tree Space" Mathematics 13, no. 11: 1776. https://doi.org/10.3390/math13111776

APA Style

Yoshida, R. (2025). Projected Gradient Descent Method for Tropical Principal Component Analysis over Tree Space. Mathematics, 13(11), 1776. https://doi.org/10.3390/math13111776

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop