Next Article in Journal
A Decision Tree Regression Algorithm for Real-Time Trust Evaluation of Battlefield IoT Devices
Previous Article in Journal
OIKAN: A Hybrid AI Framework Combining Symbolic Inference and Deep Learning for Interpretable Information Retrieval Models
Previous Article in Special Issue
Enhancing Ferroptosis-Related Protein Prediction Through Multimodal Feature Integration and Pre-Trained Language Model Embeddings
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

TMP-M2Align: A Topology-Aware Multiobjective Approach to the Multiple Sequence Alignment of Transmembrane Proteins

by
Joel Cedeño-Muñoz
1,
Cristian Zambrano-Vega
2 and
Antonio J. Nebro
3,4,*
1
Faculty of Animal and Biology Sciences, State Technical University of Quevedo, Quevedo 120503, Ecuador
2
Faculty of Computer Science and Digital Design, State Technical University of Quevedo, Quevedo 120503, Ecuador
3
ITIS Software, Edificio de Investigación Ada Byron, University of Málaga, 29071 Málaga, Spain
4
Departamento de Lenguajes y Ciencias de la Computación, University of Málaga, 29071 Málaga, Spain
*
Author to whom correspondence should be addressed.
Algorithms 2025, 18(10), 640; https://doi.org/10.3390/a18100640
Submission received: 1 September 2025 / Revised: 30 September 2025 / Accepted: 7 October 2025 / Published: 10 October 2025
(This article belongs to the Special Issue Advanced Research on Machine Learning Algorithms in Bioinformatics)

Abstract

Transmembrane proteins (TMPs) constitute approximately 30% of the mammalian proteome and are critical targets in biomedical research due to their involvement in signaling, transport, and drug interactions. However, their unique structural characteristics pose significant challenges for conventional multiple sequence alignment (MSA) methods, which are typically optimized for soluble proteins. In this paper, we propose TMP-M2Align, a novel topology-aware multiobjective algorithm specifically designed for the multiple alignment of TMPs. The method simultaneously optimizes two complementary objectives: (i) a topology-aware Sum-of-Pairs (SPs) score that integrates region-specific substitution matrices and gap penalties, and (ii) an Aligned Regions (ARs) score that rewards consistent alignment of functional and topological domains. By combining these objectives, TMP-M2Align generates Pareto front approximations of alignment solutions, enabling researchers to select trade-offs that best suit their biological questions. We evaluated TMP-M2Align on BAliBASE Reference Set 7 and on complete datasets of human G protein-coupled receptors (GPCRs) from classes A, B1, and C. Experimental results demonstrate that TMP-M2Align consistently outperforms both traditional alignment tools and specialized TM-specific methods in terms of SPs and Total Column metrics. Moreover, qualitative topological analyses confirm that TMP-M2Align preserves the integrity of transmembrane helices and loop boundaries more effectively than competing approaches. These findings highlight the effectiveness of integrating topology-aware scoring with multiobjective optimization for achieving accurate and biologically meaningful alignments of TMPs.

1. Introduction

Transmembrane proteins (TMPs) are nonsoluble proteins anchored in a cell membrane and containing one or more membrane-spanning segments separated with variable length intra or extracellular domains. Around 30% of the proteins encoded by the mammalian genome are transmembrane proteins [1,2]. Transmembrane proteins (TMPs) have attracted considerable attention playing a fundamental role in cell biology and are among the foremost tended to targets of pharmaceutical and life-science research. They are involved in a wide variety of vital biological processes, including transport of water-soluble molecules, flow of information, and energy production [3], and carry out fundamental capacities in numerous cellular and physiological processes, such as cell–cell recognition, molecular transport, and signal transduction. Given the biomedical importance of TMPs, sequence analysis methods are very significant.
Transmembrane proteins are divided into two main types: transmembrane alpha-helical proteins ( α TMPs) and transmembrane beta-barrel proteins ( β TMPs); this classification is based on the secondary structures that make up these proteins. The  α TMPs are different from the soluble proteins in their conformation characteristics, as they have one or more helices that form helical bundles that cross the biological membrane. These transmembrane helixes (TMHs) are more hydrophobic than the helixes in soluble proteins. Each TMH corresponds to the membrane-spanning region of the protein sequence. The remaining parts of the sequence, referred to as non-TM regions, are classified as either inside (cytoplasmic) or outside (extracellular) segments, depending on their position relative to the lipid bilayer [4]. Figure 1 illustrates the structural differences between the two main types of transmembrane proteins. Figure 1a (left) shows an alpha-helical transmembrane protein ( α TMP), characterized by multiple hydrophobic alpha-helices that span the lipid bilayer. These are common in eukaryotic organisms and are especially prevalent in receptor families such as G protein-coupled receptors (GPCRs). Figure 1b (right) presents a beta-barrel transmembrane protein ( β TMP), typically found in the outer membranes of Gram-negative bacteria and certain organelles. The  β TMPs form cylindrical structures composed of antiparallel beta-strands. Given these structural considerations, we focus in this paper exclusively on alpha-helical transmembrane proteins ( α TMPs) due to their abundance in eukaryotic organisms and their critical biomedical roles.
As with soluble proteins and other biological sequences (DNA, RNA), alignment of two or more TMP sequences to identify regions of similarity, is an essential prerequisite for many modes of analysis in protein families such as homology modeling, secondary structure prediction, phylogenetic reconstruction, or the delineation of conserved and variable sites within a family [5]. This process is known as multiple sequence alignment (MSA), and it is a fundamental task in bioinformatics as the identification of similarity regions may indicate functional, structural, or evolutionary relationships between the sequences. The alignment of homologous sequences is crucial for understanding the evolutionary relationships among proteins and for predicting their functions based on sequence conservation.
Nowadays, many multiple sequence alignment (MSA) methods have been developed and extensively tested for aligning homologous soluble proteins. Notable examples include ClustalW [6], which uses progressive alignment with position-specific gap penalties and sequence weighting; Kalign [7], known for its high speed and accuracy based on Wu–Manber string-matching; MAFFT [8], which employs Fast Fourier Transform for rapid alignment; MUSCLE [9], which balances accuracy and scalability; and T-Coffee [10], which integrates multiple alignment sources through a consistency-based approach. While these tools are widely adopted, they are primarily optimized for globular proteins and often fail to capture the structural and topological constraints inherent to transmembrane proteins (TMPs). Although these methods can be applied to TMPs, they often yield significantly lower alignment accuracy compared to alignments of soluble proteins. This limitation arises because TMPs exhibit unique structural and topological features that are not adequately addressed by conventional MSA tools, necessitating the development of specialized approaches tailored to their characteristics [3]. Despite the importance of TMPs, only a limited number of MSA methods have been specifically developed to address their unique structural characteristics. Notable examples include TM-Coffee [11], PRALINETM [5], and TM-Aligner [2]; however, these tools remain relatively few compared to those available for soluble proteins.

1.1. Related Work on TMP-Specific MSA Methods

Several methods have been specifically developed to align α TMPs, considering their unique structural and topological features. Early contributions include the approach of Cserzö et al. in [12], which used the positions of TMHs in one protein to identify corresponding helices in homologous sequences, providing a foundation for homology modeling of G protein-coupled receptors (GPCRs), such as human rhodopsin and bacteriorhodopsin [13]. The STAM (Simple Transmembrane Alignment Method) [14] introduced substitution matrices and gap penalties tailored to TMPs, becoming the first dedicated software for their alignment. Forrest et al. [15] explored bipartite substitution schemes combining general and TMP-specific matrices, though with limited accuracy gains. Their study introduced HOMEP, a benchmark dataset of homologous membrane protein structures, which remains a valuable resource for assessing TMP alignment strategies [13].
Subsequent efforts incorporated homology information and topology prediction. TM-Coffee [11], an adaptation of T-Coffee, integrates homology extension with consistency-based alignment for α TMPs. PRALINETM [5] extends PRALINE by including topology predictions, the PHAT substitution matrix, and progressive consistency iterations. TM-Aligner [2] is a Web-based tool that uses dynamic programming to align TM and non-TM regions independently before merging them, while the TMSA approach [4] uses segment information extracted from topology predictions and evolutionary data to align TMPs. This sequential, segment-based approach emphasizes the structural and functional relevance of aligned regions.
Although these specialized methods improve alignment quality relative to general-purpose tools, their availability and performance remain limited. In particular, existing approaches often rely on fixed heuristics and lack flexibility to balance multiple alignment quality criteria simultaneously. This motivates the development of new methods that integrate topology-aware information into multiobjective optimization frameworks.

1.2. Contributions

In this study, we have adapted the multiobjective metaheuristic M2-Align [16] to the specific problem of aligning TMPs. Our implementation is based on the software framework introduced in TM-MSAligner [17], a tool specifically designed for multiple sequence alignment of TMPs. The proposed method simultaneously optimizes two widely used objective functions: (i) the Sum-of-Pairs (SOP) score with topology-aware gap penalties, and (ii) the TM-Regions Align (SA) score. Both scores were adapted to the characteristics of TMPs. In particular, the SOP function incorporates a region-aware gap penalty scheme and dynamically applies the PHAT substitution matrix within transmembrane segments. Higher penalties are imposed for opening or extending gaps in TM regions to preserve the structural integrity of conserved helices.
The main contributions of this work are as follows: 1. We present a novel multiobjective approach tailored for the alignment of transmembrane proteins. 2. Our method integrates topology-aware scoring mechanisms to enhance alignment accuracy. 3. We provide a comprehensive evaluation of our approach against existing methods using benchmark datasets. 4. We demonstrate the effectiveness of our method in aligning human G protein-coupled receptors (GPCRs) from classes A, B1, and C, showcasing its practical applicability in real-world scenarios.
The rest of the paper is organized as follows: Section 2 describes the proposed method, including topology prediction, scoring schemes, and the software framework. Section 3 presents the experimental setup, including datasets, evaluation metrics, and baseline methods. Section 4 details the results of our experiments, while Section 5 discusses the main findings, highlighting the advantages and implications of the proposed multiobjective formulation for transmembrane protein alignment. Finally, Section 6 concludes the paper and outlines future work

2. Materials and Methods

2.1. Overview of the Alignment Method

We propose a topology-aware multiobjective formulation for the multiple sequence alignment (MSA) of transmembrane proteins (TMPs). The method builds upon the TM-MSAligner framework [17], an open-source Java tool that implements a multiobjective evolutionary algorithm specifically adapted for TMPs. The alignment problem is modeled as a bi-objective optimization problem, where two quality scores are maximized simultaneously:
  • Sum-of-Pairs (SOPs): This score is adapted to include topology-aware gap penalties and region-specific substitution matrices. It ensures that conserved regions, particularly transmembrane helices, are aligned accurately while penalizing gaps in these regions more heavily to preserve structural integrity.
  • Aligned Regions (ARs): This score rewards topologically consistent alignments by prioritizing the alignment of residues within the same topological regions (e.g., transmembrane, intracellular, or extracellular). It ensures that functionally and structurally relevant domains are aligned cohesively.
By simultaneously optimizing these two objectives, the method generates a Pareto front approximation of alignment solutions. This allows researchers to select alignments that best suit their specific biological questions, balancing trade-offs between structural conservation and broader residue coverage.

2.2. Topology Prediction

Topology prediction is a critical step in adapting scoring strategies to the unique characteristics of TMPs. Accurate topology predictions enable the identification of transmembrane regions, intracellular loops, and extracellular loops, which are essential for designing topology-aware scoring schemes and gap penalties.
Several computational methods have been developed for topology prediction, with Hidden Markov Model (HMM)-based approaches such as TMHMM [18] and HMMTOP [19] achieving notable success. These methods leverage statistical models to predict the likelihood of residues belonging to specific topological regions. Additionally, machine learning-based methods have shown promising results, incorporating features such as sequence profiles and evolutionary information [20,21].
Recent advancements in deep learning have led to the development of more sophisticated models that can capture complex patterns in protein sequences. These models leverage large-scale sequence databases and transfer learning techniques to improve prediction accuracy. For example, DeepTMHMM [22] employs a deep learning architecture to predict transmembrane topology with high accuracy, outperforming traditional HMM-based methods. In this work, we utilize DeepTMHMM for topology prediction, as it has been shown to achieve state-of-the-art performance in predicting transmembrane regions and their orientations. DeepTMHMM uses a convolutional neural network (CNN) architecture to learn hierarchical features from protein sequences, enabling it to capture complex patterns associated with transmembrane topology. The model is trained on a large dataset of experimentally validated TMPs, allowing it to generalize well to novel sequences. DeepTMHMM provides per-residue annotations, including signal peptide (S), inside (I), alpha membrane (M), beta membrane (B), periplasm (P), and outside (O) regions. These annotations are directly integrated into the alignment pipeline and inform both substitution scoring and gap penalty decisions.
The use of DeepTMHMM offers several advantages:
  • High accuracy in predicting transmembrane topology, particularly for complex TMPs.
  • Comprehensive per-residue annotations that inform scoring and gap penalties.
  • Scalability to large datasets, making it suitable for high-throughput applications.
By incorporating topology predictions into our alignment framework, we ensure that the scoring and penalty schemes are tailored to the structural and functional constraints of TMPs. This integration significantly enhances the biological relevance and accuracy of the resulting alignments.
Although our framework depends on the accuracy of topology predictors, it is robust to moderate levels of misclassification. In practice, isolated errors in residue annotation are mitigated because substitution matrix assignment is applied at the column level, where consensus across multiple sequences reduces the weight of individual mistakes. Moreover, the Pareto-based optimization naturally prioritizes alignments that preserve both topological consistency and residue conservation, thereby down-weighting solutions that are negatively impacted by prediction noise. Importantly, DeepTMHMM has been shown to achieve particularly high accuracy in identifying transmembrane helices—the regions most critical for structural preservation—while errors are more likely to occur in loop regions, where alignment flexibility is biologically tolerable.

2.3. Topology-Aware Substitution Scoring

Traditional substitution matrices such as PAM [23] and BLOSUM [24] are widely used for MSA, but they are not ideal for transmembrane regions due to distinct evolutionary constraints [3]. The substitution score S i j between amino acids i and j is computed based on background frequencies and observed substitution frequencies as follows:
S i j = 1 λ ln q i j f i f j
To address the specific needs of TMPs, several specialized substitution matrices have been proposed, including JTT [25], PHAT [26], SLIM [27], and bbTM [28]. These matrices account for the unique physicochemical properties and evolutionary pressures of transmembrane regions. In our method, we dynamically assign substitution matrices based on the predicted topology of each residue:
  • PHAT Matrix: Applied to residues within transmembrane (TM) regions, as it is specifically designed to capture the hydrophobic and structural constraints of TM helices.
  • BLOSUM62 Matrix: Used for residues in non-transmembrane regions, such as intracellular and extracellular loops, to reflect the general evolutionary patterns of soluble proteins.
This dynamic assignment ensures that the scoring scheme is sensitive to the distinct characteristics of each topological region. Following the approach of PRALINETM [29] and TM-Aligner [2], the substitution matrix is selected for each column of the alignment based on the consistency of topology predictions across sequences. Columns with predominantly TM residues use the PHAT matrix, while columns with non-TM residues use BLOSUM62.
By tailoring substitution scoring to the topology of TMPs, our method improves the biological relevance and accuracy of alignments. This approach ensures that conserved transmembrane helices are aligned with high precision, while also accommodating the variability of loop regions.

2.4. Topology-Based Gap Penalty Scheme

A topology-aware gap penalty scheme is integrated into the SOP objective to preserve the structural integrity of conserved transmembrane regions. This scheme dynamically adjusts gap penalties based on the predicted topology of each residue, ensuring that gaps are penalized more heavily in transmembrane (TM) regions compared to non-TM regions.
The gap penalties are defined as follows:
  • o p t m and e p t m : Gap opening and extension penalties within TM regions.
  • o p n o n t m and e p n o n t m : Gap opening and extension penalties in non-TM regions.
The dynamic gap penalty function G a p P ( i ) for residue i is computed as follows:
G a p P ( i ) = o p t m if i = GapOpen and T P ( i ) = TM o p n o n t m if i = GapOpen and T P ( i ) TM e p t m if i = GapExtend and T P ( i ) = TM e p n o n t m if i = GapExtend and T P ( i ) TM
Here, T P ( i ) represents the predicted topology region of residue i, which can be transmembrane (TM), intracellular, or extracellular. This approach ensures that gaps within TM helices are penalized more heavily, discouraging disruptions in these structurally critical regions. Conversely, gaps in non-TM regions, such as loops, are penalized less to allow for greater flexibility in aligning variable regions.
By incorporating topology-aware gap penalties, our method improves the biological relevance of alignments by preserving the continuity of TM helices and minimizing disruptions in conserved regions. This strategy is particularly effective for transmembrane proteins, where structural integrity is closely tied to functional performance.

2.5. Multi-Objective Formulation

The alignment of TMPs is formulated as a bi-optimization problem, where the goal is to find a set of alignments that optimize two complementary objectives: (i) the Sum-of-Pairs (SOPs) score with topology-aware gap penalties and substitution matrices, and (ii) the Aligned Regions (ARs) score, which rewards topologically consistent alignments. Since these objectives are conflicting, improving one generally entails a deterioration of the other. Consequently, the optimum is not a single solution but a set of trade-off, non-dominated solutions, known as the Pareto set, whose image in the objective space is the Pareto front. As the TMP-M2Align method is based on an evolutionary algorithm (see Section 2.6), its purpose is to approximate the Pareto front accurately. Each solution in this front corresponds to a possible alignment, thereby allowing biologists to select the option that best matches their specific requirements and preferences.
Both objectives are designed to be maximized and are specifically adapted to the unique structural and functional characteristics of TMPs. The alignment is represented as a set of k aligned sequences, S = { s 1 , s 2 , , s k } , all of which have the same length L. The two objectives are defined in next sections.

2.5.1. Sum-of-Pairs with Gap Penalty and Topology Prediction

The Sum-of-Pairs (SoP) score is a commonly used metric to evaluate the quality of a MSA. It measures the similarity between pairs of sequences in the MSA by summing the pairwise alignment scores of all possible pairs of sequences. In this study we have adapted the SOP score to consider the substitution matrix and gap penalties described in Section 2.3 and Section 2.4, respectively. The SOP score (Equation (3)) is computed by summing the pairwise scores of all sequences in the alignment, taking into account the predicted topology of each residue:
S O P ( S ) = i = 1 k 1 j = i + 1 k S P ( s i , s j )
where S P ( s i , s j ) represents the Sum-of-Pairs score of the summing of the pairwise comparisons between each residue in each column of the s i and s j sequences as defined in Equation (4):
S P ( s i , s j ) = l = 1 L δ ( s i , l , s j , l ) G P ( s i , l , s j , l )
In Equation (4), δ represents the substitution matrix used: if both s i , l and s j , l residues in the column l are predicted to be member of a TM region, the PHAT matrix is used, otherwise BLOSUM62 is used. This is performed to guarantee that inconsistently predicted positions do not negatively influence the alignment quality.
The gap penalty value G P ( s i , l , s j , l ) is settled for determining the cost of aligning an amino acid with a gap, the gap penalty schema based on topology prediction is defined as follows:
G P ( i , j ) = 0 if i = j = ( g a p ) G a p P ( i ) otherwise
where i and j represent the residues s i , l , s j , l respectively. If both are not gaps, the gap penalty considering TM regions is calculated; this value is represented by G a p P ( i ) and defined in Equation (2). Otherwise, there is no penalty between i and j residues.

2.5.2. Aligned Regions

With the aim of preferentially aligning the regions with the same type, we have considered the second objective function: Aligned Regions, is computed by adding all the scores of the region compatibility between two sequence in each column of the alignment, is defined as follows:
The second objective function, Aligned Regions, is aimed at aligning preferentially regions with the same type. It is computed by adding all the scores of the region compatibility between two sequence in each column of the alignment, as defined in Equation (6):
A R ( S ) = l = 1 L A R l ( l )
where A R l ( l ) is the Aligned Regions score of l column of the alignment, that is defined as follows:
A R l ( l ) = i = 1 k 1 j = i + 1 k M a t c h ( s i , l , s j , l )
In Equation (7), M a t c h ( s i , l , s j , l ) is the match score of two residues considering the type of topology and aminoacid, that is defined as follows:
M a t c h ( i , j ) = 4 if T P ( i ) = T P ( j ) = T M and i = j 2 if T P ( i ) = T P ( j ) = T M and i j 2 if T P ( i ) = T P ( j ) T M and i = j 1 if T P ( i ) = T P ( j ) T M and i j 0 otherwise
where i and j represent the residues s i , l and s j , l , respectively. If both are from different regions, the match value is zero. T P ( i ) represents the topology region to which residue i belongs.

2.6. Implementation Details

The proposed TMP-M2Align method is implemented using TM-MSAligner [17], a flexible software framework developed for the multiple sequence alignment of transmembrane proteins using multiobjective evolutionary algorithms. TM-MSAligner is written in Java and leverages the jMetal framework [30,31], which provides a robust foundation for designing and executing customizable multiobjective metaheuristics.
The core of the optimization procedure is based on the NSGA-II multi-objective evolutionary algorithm [32] and consists of modular components for initialization, selection, crossover, mutation, and evaluation. Some components are customizable to accommodate different optimization strategies. Key components include
  • Initialization: The initial population is generated using a hybrid strategy inspired by the T-Coffee approach [33], where alignments produced by widely used external tools such as ClustalW, Kalign, and MAFFT are merged and recombined to seed the population. This strategy provides a diverse and high-quality starting point for the evolutionary algorithm, helping it converge more efficiently towards accurate alignments.
  • Selection: Supports random and tournament selection. In the tournament case, the tournament size can be tuned to control selection pressure.
  • Crossover: Single Point Crossover (SPX) is used to combine parent alignments, promoting diversity in the offspring population.
  • Mutation: Several biologically inspired mutation operators are available, such as InsertRandomGap (IRG), MergeAdjacentGapGroups (MAGG), ShiftClosedGaps (SCG), and SplitANonGapGroup (SANGG).
  • Evaluation: TM-MSAligner allows running in both sequential and parallel execution modes, which is particularly useful for high-dimensional datasets.
  • Topology-aware evaluation: The objective functions (Sum-of-Pairs and Aligned Regions) are integrated with transmembrane topology prediction. They dynamically apply region-specific substitution matrices and penalize gaps differently in TM and non-TM regions, as described in Section 2.2 and Section 2.3.
Unlike structural homology-based methods such as TM-Aligner [2], TM-MSAligner does not rely on structural templates or 3D models. Instead, it uses only sequence data and predicted topology information, which reduces computational costs and broadens its applicability to large and uncharacterized datasets.

3. Experimental Setup and Benchmark Datasets

This section describes the datasets, evaluation metrics, baseline methods, and algorithmic configuration used to assess the performance of our multiobjective alignment approach.

3.1. Benchmark Datasets

We evaluated our method using Reference Set 7 of the BAliBASE 3.0 benchmark [34], which is a widely recognized standard for assessing the quality of multiple sequence alignment algorithms. This reference set is specifically designed for transmembrane proteins and includes eight families: 7tm, msl, dtd, acr, photo, ion, nat, and ptga, comprising a total of 435 sequences. Each sequence contains between 2 and 14 transmembrane α -helices. The core domains are authors-defined, examining the alignment of structurally equivalent residues only. The main goal of BAliBASE is to assess the capacity of the strategies to recapitulate these core domains, mostly made of α -helices. Furthermore, it contains a program to assess the accuracy of candidate alignments over reference alignments provided by the benchmark, called Baliscore, that includes two metrics: Total Column (TC) and Sum-of-Pairs (SPs) scores.
In addition to BAliBASE, we validated our approach on a real-world dataset composed of all human G protein-coupled receptors (GPCRs), one of the largest and most functionally diverse families of transmembrane proteins. The dataset includes representatives from three major GPCR classes: A (rhodopsin-like), B1 (secretin receptor family), and C (metabotropic glutamate/pheromone receptors). Protein sequences and topology annotations were obtained from the GPCRdb database [35]. This dataset allows us to test the scalability and biological relevance of our method on large, functionally important protein families.

3.2. Evaluation Metrics

We used two widely accepted metrics to evaluate the quality of the alignments:
  • Sum-of-Pairs (SPs) Score: This metric measures the proportion of residue pairs that are correctly aligned in the test alignment with respect to a reference alignment. Higher SPs values indicate improved local homology conservation at the residue level, reflecting the algorithm’s ability to align homologous residues consistently.
  • Total Column (TC) Score: This metric evaluates the number of alignment columns that are perfectly conserved with the reference, meaning that all residues in those columns are correctly aligned. High TC values indicate that the method preserves structurally and functionally coherent blocks across sequences, capturing entire regions rather than isolated pairs of residues.
Both SPs and TC are particularly suitable for transmembrane proteins, as they simultaneously assess (i) the conservation of residues within hydrophobic transmembrane helices—critical for maintaining structural stability in the lipid bilayer—and (ii) the preservation of full topological domains such as helices and intra/extracellular loops, whose continuity is essential for protein function. These metrics were calculated using the baliscore tool provided by the BAliBASE package.

3.3. Compared Methods

To evaluate the performance of our approach, we conducted a comparative analysis against a set of widely used multiple sequence alignment (MSA) tools. These methods were selected because they represent a diverse range of alignment strategies, including traditional progressive aligners, consistency-based methods, and tools specifically adapted for transmembrane protein sequences. This selection allows us to assess both the general alignment performance and the effectiveness of topology-aware optimizations. The methods included in the comparison are summarized in Table 1.
All baseline tools were executed using their default parameters, unless specific options were recommended in their documentation for handling transmembrane protein sequences. TM-Coffee and PRALINETM were included for their explicit consideration of transmembrane topology. TM-Aligner was originally intended as a comparison method, but it has not been included due to the continued inaccessibility of its Web server during the evaluation period.

3.4. TMP-M2Align Configuration

Our TMP-M2Align implementation was configured based on the parameters shown in Table 2, following the executable setup used in our experiments. The algorithm was executed with a limit of 25,000 evaluations and a population size of 100 individuals.
The predicted topologies were obtained using DeepTMHMM and stored in .3line files, which were parsed during runtime to dynamically inform the scoring process. Each benchmark folder contained a minimum of two precomputed alignments (in FASTA format), used to seed the initial population. These alignments were validated prior to execution.
In our configuration, the choice of gap penalty parameters was guided by the structural properties of transmembrane proteins. Transmembrane (TM) helices are highly conserved segments whose continuity is essential for maintaining the stability of the protein within the lipid bilayer. Therefore, we assigned stronger penalties for gap opening (8) and extension (3) in TM regions to discourage insertions or deletions that could disrupt these helices. In contrast, non-TM regions such as cytoplasmic and extracellular loops are more flexible and variable across homologs. For these regions, lower penalties for gap opening (3) and extension (1) were applied, allowing the aligner to introduce gaps where structural variability is expected. This topology-aware scheme balances the need to preserve conserved TM segments while accommodating sequence divergence in loop regions, and is consistent with previous studies that emphasize the differential treatment of TM and non-TM domains in alignment strategies.
All experiments, including those involving baseline alignment tools (ClustalW, Kalign, MAFFT, MUSCLE, T-Coffee, PRALINETM, and TM-Coffee), were conducted on a machine with an Intel Xeon CPU E5-2650 v3 @ 2.30 GHz and 32 GB of RAM, running Ubuntu 20.04 LTS. This uniform setup ensures that performance comparisons across different methods were conducted under equivalent hardware and software conditions.

4. Results

4.1. BAliBASE Results

It is worth noting that, since TMP-M2Align produces a set of non-dominated solutions (i.e., a Pareto front), we selected for each BAliBASE instance the alignment with the highest SPs score and the alignment with the highest TC score, and then reported their respective scores in Table 3. This strategy ensures that the reported results reflect the best-case performance of TMP-M2Align with respect to each metric. The TM-specific methods TM-Coffee and TM-Aligner are included as references, although they were not rerun due to technical limitations (see Section 3.3). Regarding the use of traditional tools such as MAFFT, ClustalW, and Kalign—which are not specifically designed for transmembrane proteins—it is important to clarify that all of them were able to generate syntactically valid alignments. These alignments were evaluated using BAliBASE’s baliscore tool, which assesses structural alignment quality based on reference core domains. However, their lack of topology awareness inherently limits their performance on TMP datasets, as reflected in the lower TC and SPs scores compared to methods designed or adapted for transmembrane sequences.
Our proposed method, achieved the highest average SPs (0.809) and TC (0.404) scores, outperforming all compared tools. Notably, even the best-performing classical tools (T-Coffee and ClustalW) fell short in TC score, highlighting the benefit of using a topology-aware scoring strategy for transmembrane proteins. The improvement over TM-Coffee and TM-Aligner is also evident in both metrics.
Our results suggest that our proposal has more accuracy similar to the tools based on homology-modeling and TM-Aligner, however. These methods require template structures for alignment accuracy. However, our approach does not depend on templates.

4.2. GPCR Dataset Results

The results on the GPCR dataset, summarized in Table 4, further validate the effectiveness of our method. For each GPCR class (A, B1, and C), we compared TMP-M2Align with ClustalW, Kalign, MAFFT, Muscle, and TM-Aligner. Due to the lack of reference alignments for this dataset, we evaluated the alignments using the same SPs and TC metrics employed in the BAliBASE benchmark. As with the previous evaluation, from the set of non-dominated solutions generated by TMP-M2Align, we selected the alignment with the highest SPs score and the one with the highest TC score for each GPCR class. These selected alignments represent the best-performing solutions with respect to each quality criterion, and their scores are reported in the corresponding columns of Table 4.
In GPCR Classes A and C, TMP-M2Align produced alignments that outperformed all traditional aligners in at least one of the evaluated metrics. Notably, in Class B1, it achieved the highest Total Column (TC) score while maintaining a competitive Sum-of-Pairs (SPs) value, indicating improved residue conservation without sacrificing overall alignment quality. In Class C, TMP-M2Align outscored all other methods in both SPs and TC, demonstrating its ability to generate structurally consistent and functionally relevant alignments. These results underscore the advantage of using multiobjective optimization to explore a diverse range of solutions, allowing practitioners to select alignments tailored to specific biological goals.
Due to technical limitations, some transmembrane-specific alignment tools could not be included in the GPCR dataset evaluation. In particular, the Web server for TM-Aligner (http://lms.snu.edu.in) was persistently unreachable, returning a “connection timed out” error. Similarly, attempts to run TM-Coffee and PRALINETM via their respective Web platforms resulted in 403 Forbidden or access-denied responses. Since these tools are only available as Web services and do not provide standalone versions, it was not possible to include them in the GPCR experiments under the same computational conditions. Therefore, while their published results were considered for the BAliBASE benchmark, they were excluded from the GPCR dataset evaluation.

4.3. Visualization of Solution Fronts

TMP-M2Align does not return a single alignment but a set of non-dominated solutions distributed along a Pareto front, thus providing practitioners with the flexibility to select alignments that emphasize either highly conserved columns (Total Column, TC score) or broader homologous residue coverage (Sum-of-Pairs, SPs score). Figure 2 and Figure 3 show typical Pareto front approximations produced by TMP-M2Align for the GPCR Class A and Class B1 datasets, respectively. In these fronts, the extreme points correspond to solutions that maximize one objective at the expense of the other, while the remaining points represent trade-offs with different balances between the two objectives.
These fronts confirm that multiobjective optimization is effective at capturing the inherent trade-offs in MSA quality metrics. In GPCR Class A, the front is broad and well-structured, highlighting the algorithm’s ability to explore diverse alignment solutions. For GPCR Class B1, the front appears tighter but still exhibits a clear gradient of trade-offs, suggesting the presence of structurally variable or functionally divergent regions that benefit from adjustable alignment strategies. This capability is particularly valuable for datasets where balancing structure and homology is critical.
To illustrate the practical meaning of the Pareto fronts, we selected three representative solutions from the GPCR Class C dataset: (i) the solution with the highest Aligned Regions score (BestARscore), (ii) the solution with the highest Sum-of-Pairs score (BestSOPscore), and (iii) an intermediate solution located in the middle of the front (Medium). These alignments are shown in Figure 4.
The BestARscore solution (Figure 4a) maximizes topological consistency: transmembrane helices appear as uninterrupted blocks and loop boundaries are preserved, although this alignment sacrifices some residue-level conservation across sequences. The BestSOPscore solution (Figure 4b) maximizes residue conservation, aligning a greater number of identical and similar residues. However, this comes at the cost of introducing gaps inside helices, fragmenting their continuity and reducing biological interpretability. Finally, the Medium solution (Figure 4c) provides a balanced trade-off, maintaining both a reasonable level of residue conservation and structural coherence across helices and loops.
These examples demonstrate how the Pareto front captures distinct alignment strategies. Practitioners can therefore choose the solution that best fits their objectives: AR-oriented alignments for structural studies, SOP-oriented alignments for evolutionary or motif analyses, and medium trade-offs when both perspectives are relevant.

4.4. Topological Analysis of the Alignments in Class A and Class C GPCRs

Figure 5 and Figure 6 present a visual comparison of the multiple sequence alignments generated for Class A (Rhodopsin-like) and Class C (Glutamate-like) human GPCRs using various alignment tools. Per-residue topological annotations were predicted using DeepTMHMM and visualized in Jalview. Color coding is applied to highlight structural regions: transmembrane helices (TM helix) in red, intracellular regions (inside) in green, and extracellular regions (outside) in blue.
In both classes, the reference alignment, obtained from GPCRdb, exhibits a clearly defined transmembrane architecture with compact and uninterrupted TM segments, flanked appropriately by inside and outside loops. These topologies serve as reliable structural ground truths for assessing the biological validity of each alignment. Our method, TMP-M2Align, achieves high topological consistency in both classes, producing alignments that preserve domain continuity and minimize unwanted gaps within TM segments. The benefits of our approach are particularly evident in Class C, which is more challenging due to higher evolutionary divergence and longer sequence lengths. TMP-M2Align aligns the transmembrane regions as continuous blocks and maintains the separation of topological domains better than the other methods.
By contrast, traditional alignment tools such as ClustalW, Kalign, MAFFT, and MUSCLE exhibit greater fragmentation and inconsistency in both classes. In Class A, some TM helices are reasonably preserved, but gaps and loop misalignments are common, especially with MAFFT and MUSCLE. In Class C, the issues are more severe: transmembrane helices are frequently interrupted by internal gaps, and inside/outside regions are scattered throughout the alignment.
Overall, TMP-M2Align demonstrates superior robustness across both GPCR classes. It consistently preserves the structural integrity of topological segments, making it more suitable for downstream structural and functional analyses involving transmembrane proteins.

4.5. Representative Alignment Snippets

To further illustrate the impact of our topology-aware scoring and penalty scheme, we show in Figure 7 an excerpt of a representative transmembrane segment and its flanking loop regions. This region was selected from the GPCR Class A dataset, as it provides a clear example of the structural constraints typical of transmembrane helices. The reference alignment obtained from GPCRdb is presented in Figure 7a, while the alignment produced by our TMP-M2Align algorithm is shown in Figure 7b. In both cases, residues are colored according to their predicted topology: transmembrane helices in red, intracellular regions in green, and extracellular regions in blue. Figure 7c, Figure 7d and Figure 7e present the results obtained with MAFFT, ClustalW and Kalign, respectively.
As shown in Figure 7a, the reference alignment preserves the general topology of the region but contains a significant number of internal gaps, particularly within transmembrane helices, which fragment these highly conserved domains. By contrast, TMP-M2Align produces a more compact alignment in which gaps are largely confined to loop regions, while the integrity of the helical transmembrane segments is maintained Figure 7b. This behavior is a direct consequence of our topology-aware gap penalty scheme, which imposes stronger penalties for insertions or deletions within transmembrane regions. Additionally, the Aligned Regions objective function contributes to the coherent placement of loop residues, reducing misalignments across cytoplasmic and extracellular domains.
The comparison with other alignment tools highlights the advantages of our approach. MAFFT tends to lose alignment consistency at loop boundaries, fragmenting conserved helices (Figure 7c). ClustalW partially preserves helices but scatters gaps across both loops and transmembrane regions due to its lack of topology awareness (Figure 7d). Kalign maintains the separation of topological domains but does not effectively reduce the number of gaps within helices, leading to unnecessary fragmentation (Figure 7e).
Overall, TMP-M2Align not only improves quantitative metrics such as SPs and TC scores but also yields biologically meaningful alignments where helices remain continuous and loop boundaries are well defined. This reinforces the value of explicitly integrating topology into the alignment process, enabling our method to deliver alignments that are structurally faithful and suitable for downstream applications such as homology modeling and functional annotation.

5. Discussion

The results obtained in this study demonstrate that our approach is an effective strategy for the multiple sequence alignment of transmembrane proteins, especially for highly divergent families such as GPCRs. Its performance surpasses that of classical alignment tools and even specialized TM tools in both BAliBASE and real-world GPCR datasets.

5.1. Implications of a Multiobjective Framework for TMPs

The use of a multiobjective optimization strategy allows simultaneously maximize multiple alignment quality metrics. This is particularly beneficial for TMPs, where trade-offs often exist between structural consistency and alignment completeness. By generating an approximated Pareto front of solutions, our approach empowers users to select the alignment most appropriate for their biological question, whether they prioritize conservation, coverage, or a balance between both.
Consequently, the superior SPs and TC values obtained by TMP-M2Align confirm that the multiobjective approach not only enhances residue-level conservation but also preserves the topological integrity of transmembrane domains, making the alignments more biologically meaningful.

5.2. Advantages of Topology-Aware Gap Penalties

One of the core innovations in our approach is its use of topology-aware scoring and gap penalty schemes. The algorithm increases gap penalties within predicted TM regions, thus discouraging disruptive insertions or deletions that would break the continuity of membrane-spanning helices. This simple yet powerful modification substantially improves alignment quality by preserving biologically meaningful regions.
Additionally, different substitution matrices are dynamically applied depending on the predicted topological region, using PHAT in TM helices and BLOSUM62 elsewhere. This contributes to better biological relevance by reflecting region-specific evolutionary pressures.

5.3. Comparison with Existing Methods

The superiority of our approach can be attributed to three main factors: (i) the integration of topological information into both scoring and gap penalty schemes, (ii) the dynamic use of substitution matrices depending on transmembrane predictions, and (iii) the use of metaheuristics, which explore diverse alignment hypotheses rather than relying on deterministic heuristics.
While tools like TM-Coffee and PRALINETM do incorporate topology information, their methods are fixed and lack flexibility. In contrast, TMP-M2Align dynamically adapts to predicted TM regions and uses evolutionary search to refine alignments based on competing criteria. This flexibility makes it more adaptable to different sequence families and alignment goals.

5.4. Qualitative Topological Consistency of GPCR Alignments

Figure 5 and Figure 6 allow a qualitative evaluation of alignment quality beyond quantitative metrics. For Class A GPCRs, TMP-M2Align produces alignments where transmembrane helices (blue) appear as continuous, uninterrupted segments, with very few artificial gaps introduced inside these regions. This demonstrates that our method preserves the structural integrity of the seven canonical helices while maintaining the clear separation of intracellular (red) and extracellular (green) loops. In contrast, baseline methods such as MAFFT and MUSCLE introduce fragmentation within helices and scatter loop residues across non-homologous positions, reducing biological interpretability.
In Class C GPCRs, which are characterized by greater sequence divergence and longer extracellular domains, the qualitative differences become more evident. TMP-M2Align maintains the block-like organization of transmembrane helices and respects the orientation of topological domains, whereas ClustalW and Kalign frequently disrupt helix continuity with insertions and misplace loop regions relative to the reference alignment. These distortions compromise the accurate delineation of structural domains and could negatively impact downstream structural or evolutionary analyses.
Taken together, the visual inspection of Figure 5 and Figure 6 confirms that TMP-M2Align not only improves numerical scores such as SPs and TC but also yields biologically meaningful alignments that preserve the continuity and organization of topological regions. This qualitative robustness is particularly valuable for GPCRs, where maintaining the integrity of helices and loop boundaries is critical for structure-function studies.

6. Conclusions and Future Work

This work aims to evaluate the effectiveness of a topology-aware, multiobjective approach for the multiple sequence alignment (MSA) of transmembrane proteins (TMPs), using both benchmark data (BAliBASE Reference Set 7) and a real-world dataset consisting of human GPCRs from different classes. To this end, we introduced TMP-M2Align, a software tool which integrates topological information into its scoring scheme and gap penalties.
Our results showed that TMP-M2Align consistently outperforms traditional alignment tools such as ClustalW, Kalign, MAFFT, and MUSCLE, as well as specialized TM tools like TM-Coffee and TM-Aligner (when available). It achieves higher alignment quality, as measured by Sum-of-Pairs (SP) and Total Column (TC) scores, particularly in challenging cases like GPCR Classes B1 and C. The use of a multiobjective optimization strategy enables the generation of Pareto front approximations, offering a spectrum of high-quality alignments that allow users to prioritize either topological consistency or broader residue matching.
One of the key innovations lies in the topology-aware scoring, which includes region-sensitive gap penalties and dynamic substitution matrices. These features contribute to preserving the integrity of transmembrane helices and topological domains, as demonstrated by qualitative assessments using DeepTMHMM annotations and visual inspection in Jalview.
Our approach relies on accurate topology predictions as a prerequisite, which introduces some dependency on external tools such as DeepTMHMM. In future work, the integration of confidence levels from topology predictors or structural validation from tools like AlphaFold2 could enhance robustness. Additionally, incorporating new objective functions based on structural similarity or co-evolutionary information may further expand its applicability.
In conclusion, TMP-M2Align offers a flexible, effective, and biologically relevant solution for aligning transmembrane proteins. Its ability to balance competing alignment goals makes it especially suitable for complex datasets like GPCRs, and its design opens pathways for further integration with structural bioinformatics tools and workflows.

Author Contributions

Conceptualization, J.C.-M. and C.Z.-V.; methodology, A.J.N.; software, C.Z.-V.; validation, J.C.-M. and A.J.N.; formal analysis, J.C.-M.; investigation, J.C.-M.; resources, J.C.-M.; data curation, C.Z.-V.; writing—original draft preparation, J.C.-M. and C.Z.-V.; writing—review and editing, A.J.N.; visualization, C.Z.-V.; supervision, J.C.-M. and A.J.N.; project administration, J.C.-M.; funding acquisition, J.C.-M. All authors have read and agreed to the published version of the manuscript.

Funding

This work has been partially funded by grant PID2024-155363OB-C41 funded by MCIN/AEI/10.13039/501100011033 and by the European Union NextGenerationEU/PRTR, KOSMOS (Boosting Federated Data-Sharing Ecosystems with a Multidimensional Approach) and by grant DGP_PIDI_2024_01174, Junta de Andalucia.

Data Availability Statement

The datasets used in this study are publicly available. The BAliBASE 3.0 Reference Set 7 benchmark can be accessed at https://www.lbgi.fr/balibase/ (accessed on 30 August 2025), and the GPCR sequences and topology annotations were obtained from the GPCRdb database (https://gpcrdb.org/, accessed on 30 August 2025). All alignment outputs and configuration files generated by TMP-M2Align are available upon reasonable request from the corresponding author.

Acknowledgments

The authors would like to express their gratitude to the State Technical University of Quevedo for the support provided throughout this research. Their continuous encouragement and resources have been invaluable in the development of this study.

Conflicts of Interest

The authors declare no conflicts of interest.

References

  1. Wallin, E.; Heijne, G.V. Genome-wide analysis of integral membrane proteins from eubacterial, archaean, and eukaryotic organisms. Protein Sci. 1998, 7, 1029–1038. [Google Scholar] [CrossRef]
  2. Bhat, B.; Ganai, N.A.; Andrabi, S.M.; Shah, R.A.; Singh, A. TM-Aligner: Multiple sequence alignment tool for transmembrane proteins with reduced time and improved accuracy. Sci. Rep. 2017, 7, 12543. [Google Scholar] [CrossRef]
  3. Frishman, D. Structural Bioinformatics of Membrane Proteins; Springer: Berlin/Heidelberg, Germany, 2010; p. 400. [Google Scholar] [CrossRef]
  4. Wang, H.; Wang, J.; Zhang, L.; Sun, P.; Du, N.; Li, Y. A sequential segment based alpha-helical transmembrane protein alignment method. Int. J. Biol. Sci. 2018, 14, 901–906. [Google Scholar] [CrossRef]
  5. Pirovano, W.; Feenstra, K.A.; Heringa, J. PRALINE™: A strategy for improved multiple alignment of transmembrane proteins. Bioinformatics 2008, 24, 492–497. [Google Scholar] [CrossRef]
  6. Thompson, J.; Higgins, D.; Gibson, T. CLUSTAL W: Improving the sensitivity of progressive multiple sequence alignment through sequence weighting, position-specific gap penalties and weight matrix choice. Nucleic Acids Res. 1994, 22, 4673–4680. [Google Scholar] [CrossRef] [PubMed]
  7. Lassmann, T.; Sonnhammer, E. Kalign—An accurate and fast multiple sequence alignment algorithm. BMC Bioinform. 2005, 6, 298. [Google Scholar] [CrossRef] [PubMed]
  8. Katoh, K.; Misawa, K.; Kuma, K.; Miyata, T. MAFFT: A novel method for rapid multiple sequence alignment based on fast Fourier transform. Nucleic Acids Res. 2002, 30, 3059–3066. [Google Scholar] [CrossRef] [PubMed]
  9. Edgar, R. MUSCLE: Multiple sequence alignment with high accuracy and high throughput. Nucleic Acids Res. 2004, 32, 1792–1797. [Google Scholar] [CrossRef]
  10. Notredame, C.; Higgins, D.; Heringa, J. T-Coffee: A novel method for fast and accurate multiple sequence alignment. J. Mol. Biol. 2000, 302, 205–217. [Google Scholar] [CrossRef]
  11. Floden, E.W.; Tommaso, P.D.; Chatzou, M.; Magis, C.; Notredame, C.; Chang, J.M. PSI/TM-Coffee: A web server for fast and accurate multiple sequence alignments of regular and transmembrane proteins using homology extension on reduced databases. Nucleic Acids Res. 2016, 44, W339–W343. [Google Scholar] [CrossRef]
  12. Cserzö, M.; Bernassau, J.M.; Simon, I.; Maigret, B. New Alignment Strategy for Transmembrane Proteins. J. Mol. Biol. 1994, 243, 388–396. [Google Scholar] [CrossRef] [PubMed]
  13. Zambrano-Vega, C.; Oviedo, B.; Villamar-Torres, R.; Botto-Tobar, M.; Barros-Rodríguez, M. An Overview of Multiple Sequence Alignment Methods Applied to Transmembrane Proteins. In Proceedings of the Technology Trends, Babahoyo, Ecuador, 29–31 August 2018; Botto-Tobar, M., Pizarro, G., Zúñiga-Prieto, M., D’Armas, M., Zúñiga Sánchez, M., Eds.; Springer International Publishing: Cham, Switzerland, 2019; pp. 410–419. [Google Scholar]
  14. Shafrir, Y.; Guy, H.R. STAM: Simple Transmembrane Alignment Method. Bioinformatics 2004, 20, 758–769. [Google Scholar] [CrossRef]
  15. Forrest, L.R.; Tang, C.L.; Honig, B. On the accuracy of homology modeling and sequence alignment methods applied to membrane proteins. Biophys. J. 2006, 91, 508–517. [Google Scholar] [CrossRef]
  16. Zambrano-Vega, C.; Nebro, A.J.; García-Nieto, J.; Aldana-Montes, J.F. M2Align: Parallel multiple sequence alignment with a multi-objective metaheuristic. Bioinformatics 2017, 33, 3011–3017. [Google Scholar] [CrossRef]
  17. Cedeño-Muñoz, J.; Zambrano-Vega, C.; Nebro, A.J. TM-MSAligner: A Tool for Multiple Sequence Alignment of Transmembrane Proteins. In Proceedings of the Computational Science—ICCS 2024, Malaga, Spain, 2–4 July 2024; Franco, L., de Mulatier, C., Paszynski, M., Krzhizhanovskaya, V.V., Dongarra, J.J., Sloot, P.M.A., Eds.; Springer International Publishing: Cham, Switzerland, 2024; pp. 113–121. [Google Scholar]
  18. Krogh, A.; Larsson, B.; Von Heijne, G.; Sonnhammer, E.L. Predicting transmembrane protein topology with a hidden markov model: Application to complete genomes1. J. Mol. Biol. 2001, 305, 567–580. [Google Scholar] [CrossRef]
  19. Tusnády, G.E.; Simon, I. The HMMTOP transmembrane topology prediction server. Bioinformatics 2001, 17, 849–850. [Google Scholar] [CrossRef]
  20. Yang, J.; Shen, H.B. MemBrain-contact 2.0: A new two-stage machine learning model for the prediction enhancement of transmembrane protein residue contacts in the full chain. Bioinformatics 2017, 34, 230–238. [Google Scholar] [CrossRef]
  21. Cai, Y.D.; Zhou, G.P.; Chou, K.C. Support Vector Machines for Predicting Membrane Protein Types by Using Functional Domain Composition. Biophys. J. 2003, 84, 3257–3263. [Google Scholar] [CrossRef] [PubMed]
  22. Hallgren, J.; Tsirigos, K.D.; Pedersen, M.D.; Armenteros, J.J.A.; Marcatili, P.; Nielsen, H.; Krogh, A.; Winther, O. DeepTMHMM predicts alpha and beta transmembrane proteins using deep neural networks. bioRxiv 2022. [Google Scholar] [CrossRef]
  23. Dayhoff, M.; Schwartz, R.; Orcutt, B.C. A model of evolutionary change in proteins. In Atlas of Protein Sequences and Structure; National Biomedical Research Foundation: Washington, DC, USA, 1978; Volume 5, pp. 345–352. [Google Scholar]
  24. Henikoff, S.; Henikoff, J. Amino acid substitution matrices from protein blocks. Proc. Natl. Acad. Sci. USA 1992, 89, 10915–10919. [Google Scholar] [CrossRef] [PubMed]
  25. Jones, D.; Taylor, W.; Thornton, J. A mutation data matrix for transmembrane proteins. FEBS Lett. 1994, 339, 269–275. [Google Scholar] [CrossRef]
  26. Ng, P.C.; Henikoff, J.G.; Henikoff, S. PHAT: A transmembrane-specific substitution matrix. Bioinformatics 2000, 16, 760–766. [Google Scholar] [CrossRef] [PubMed]
  27. Müller, T.; Rahmann, S.; Rehmsmeier, M. Non-symmetric score matrices and the detection of homologous transmembrane proteins. Bioinformatics 2001, 17, S182–S189. [Google Scholar] [CrossRef]
  28. Jimenez-Morales, D.; Adamian, L.; Liang, J. Detecting remote homologues using scoring matrices calculated from the estimation of amino acid substitution rates of beta-barrel membrane proteins. In Proceedings of the 2008 30th Annual International Conference of the IEEE Engineering in Medicine and Biology Society, Vancouver, BC, Canada, 20–25 August 2008; pp. 1347–1350. [Google Scholar] [CrossRef]
  29. Pirovano, W.; Abeln, S.; Feenstra, K.A.; Heringa, J. Multiple alignment of transmembrane protein sequences. In Structural Bioinformatics of Membrane Proteins; Springer: Vienna, Austria, 2010; pp. 103–122. [Google Scholar]
  30. Durillo, J.J.; Nebro, A.J. jMetal: A Java framework for multi-objective optimization. Adv. Eng. Softw. 2011, 42, 760–771. [Google Scholar] [CrossRef]
  31. Nebro, A.J.; Durillo, J.J.; Vergne, M. Redesigning the jMetal Multi-Objective Optimization Framework. In Proceedings of the Companion Publication of the 2015 Annual Conference on Genetic and Evolutionary Computation, GECCO Companion’15, Madrid, Spain, 11–15 July 2015; Association for Computing Machinery: New York, NY, USA, 2015; pp. 1093–1100. [Google Scholar] [CrossRef]
  32. Deb, K.; Pratap, A.; Agarwal, S.; Meyarivan, T. A fast and elitist multiobjective genetic algorithm: NSGA-II. IEEE Trans. Evol. Comput. 2002, 6, 182–197. [Google Scholar] [CrossRef]
  33. Madeira, F.; Pearce, M.; Tivey, A.R.N.; Basutkar, P.; Lee, J.; Edbali, O.; Madhusoodanan, N.; Kolesnikov, A.; Lopez, R. Search and sequence analysis tools services from EMBL-EBI in 2022. Nucleic Acids Res. 2022, 50, W276–W279. [Google Scholar] [CrossRef]
  34. Bahr, A.; Thompson, J.D.; Thierry, J.C.; Poch, O. BAliBASE (Benchmark Alignment dataBASE): Enhancements for repeats, transmembrane sequences and circular permutations. Nucleic Acids Res. 2001, 29, 323–326. [Google Scholar] [CrossRef] [PubMed]
  35. Pándy-Szekeres, G.; Munk, C.; Tsonkov, T.M.; Mordalski, S.; Harpsøe, K.; Hauser, A.S.; Papadatos, G.; Siderius, M.; Egebjerg, J.; Jensen, H.H.; et al. GPCRdb in 2023: State-specific structure models using AlphaFold2 and new ligand resources. Nucleic Acids Res. 2023, 51, D368–D376. [Google Scholar] [CrossRef] [PubMed]
Figure 1. Comparison between the two main classes of transmembrane proteins: transmembrane segments in blue, and loop regions in black (a) α TMPs, composed of hydrophobic alpha-helices spanning the lipid bilayer; (b) β TMPs, cylindrical structures formed by antiparallel beta-strands. The lipid bilayer is shown in orange, transmembrane segments in blue, and loop regions in black.
Figure 1. Comparison between the two main classes of transmembrane proteins: transmembrane segments in blue, and loop regions in black (a) α TMPs, composed of hydrophobic alpha-helices spanning the lipid bilayer; (b) β TMPs, cylindrical structures formed by antiparallel beta-strands. The lipid bilayer is shown in orange, transmembrane segments in blue, and loop regions in black.
Algorithms 18 00640 g001
Figure 2. Pareto front approximation obtained by TMP-M2Align on the GPCR Class A dataset. Each point corresponds to a trade-off solution between SPs and TC objectives.
Figure 2. Pareto front approximation obtained by TMP-M2Align on the GPCR Class A dataset. Each point corresponds to a trade-off solution between SPs and TC objectives.
Algorithms 18 00640 g002
Figure 3. Pareto front approximation obtained by TMP-M2Align on the GPCR Class B1 dataset. The distribution reflects multiple high-quality alignments with varying emphasis on residue conservation versus topological consistency.
Figure 3. Pareto front approximation obtained by TMP-M2Align on the GPCR Class B1 dataset. The distribution reflects multiple high-quality alignments with varying emphasis on residue conservation versus topological consistency.
Algorithms 18 00640 g003
Figure 4. Representative solutions selected from the Pareto front of GPCR Class C. Residues are color-coded according to topology: red = transmembrane helices, green = intracellular regions, blue = extracellular regions. (a) BestARscore solution, (b) BestSOPscore solution, (c) Medium solution.
Figure 4. Representative solutions selected from the Pareto front of GPCR Class C. Residues are color-coded according to topology: red = transmembrane helices, green = intracellular regions, blue = extracellular regions. (a) BestARscore solution, (b) BestSOPscore solution, (c) Medium solution.
Algorithms 18 00640 g004
Figure 5. Visual comparison of multiple sequence alignments for Class A (Rhodopsin-like) GPCRs. Topological annotations predicted by DeepTMHMM are visualized in Jalview using the color code: red (TM helix), green (inside), and blue (outside).
Figure 5. Visual comparison of multiple sequence alignments for Class A (Rhodopsin-like) GPCRs. Topological annotations predicted by DeepTMHMM are visualized in Jalview using the color code: red (TM helix), green (inside), and blue (outside).
Algorithms 18 00640 g005
Figure 6. Visual comparison of multiple sequence alignments for Class C (Glutamate-like) GPCRs. Topological annotations predicted by DeepTMHMM are visualized in Jalview using the color code: red (TM helix), green (inside), and blue (outside).
Figure 6. Visual comparison of multiple sequence alignments for Class C (Glutamate-like) GPCRs. Topological annotations predicted by DeepTMHMM are visualized in Jalview using the color code: red (TM helix), green (inside), and blue (outside).
Algorithms 18 00640 g006
Figure 7. Representative alignment snippets from GPCR Class A. Color scheme: transmembrane helices (red), intracellular regions (green), and extracellular regions (blue).
Figure 7. Representative alignment snippets from GPCR Class A. Color scheme: transmembrane helices (red), intracellular regions (green), and extracellular regions (blue).
Algorithms 18 00640 g007
Table 1. Summary of MSA tools used in the comparison. TMP = transmembrane protein.
Table 1. Summary of MSA tools used in the comparison. TMP = transmembrane protein.
ToolTypeTMP Support
ClustalW [6]ProgressiveNo
MAFFT [8]ProgressiveNo
Kalign [7]ProgressiveNo
Muscle [9]ProgressiveNo
T-Coffee [10]Consistency-basedNo
TM-Coffee [11]Consistency-basedYes
PRALINETM [5]Consistency-basedYes
TM-Aligner [2]HeuristicYes
Table 2. Configuration parameters used in TMP-M2Align during the experiments.
Table 2. Configuration parameters used in TMP-M2Align during the experiments.
ParameterValue
Max evaluations25,000
Population size100
Crossover probability0.8
Mutation probability0.2
Mutation operatorShiftClosedGapsMSAMutation
Gap opening (TM regions)8
Gap extension (TM regions)3
Gap opening (non-TM regions)3
Gap extension (non-TM regions)1
Substitution matrix (TM)PHAT
Substitution matrix (non-TM)BLOSUM62
Objective functionsSum-of-Pairs with Topology, Aligned Segments
Topology predictorDeepTMHMM
Initial population sourceClustalW, Kalign, MAFFT alignments
Table 3. SPs and TC scores for each instance in the BAliBASE Reference Set 7. TM-Aligner and TM-Coffee scores were taken from reference results due to server inaccessibility.
Table 3. SPs and TC scores for each instance in the BAliBASE Reference Set 7. TM-Aligner and TM-Coffee scores were taken from reference results due to server inaccessibility.
ToolClustalWKalignMAFFTMusclePralineT-CoffeeTM-CoffeeTM-AlignerTMP-M2Align
SP TC SP TC SP TC SP TC SP TC SP TC SP TC SP SP TC
msl0.8620.6200.8450.7100.8170.5800.8350.5800.8040.5400.8400.6000.8280.6000.8800.8550.720
7tm0.8440.3300.7820.2600.7250.1600.8070.2700.7550.3900.8520.4000.8620.4200.8200.8640.410
ion0.4620.0600.4690.0200.4440.0000.4800.0000.4170.0000.5110.0500.5060.0500.5100.5140.060
photo0.9470.6700.8740.4000.8350.3800.8970.4900.8230.4100.9180.5700.9280.5900.9200.9430.670
ptga0.6540.0600.6880.0800.6290.0500.6510.0500.6410.1900.6870.1500.7050.1600.7000.7180.110
acr0.9100.6500.8800.4700.9010.4900.9420.6700.8760.4700.9290.6800.9300.6600.9200.9440.710
nat0.7220.1800.6970.1600.6720.0600.7230.1600.6060.0000.6950.1100.7000.1000.7500.7550.220
dtd0.8440.2700.8460.3600.8120.1800.8410.3100.7600.2100.8630.2900.8770.3700.8700.8790.330
Average0.7810.3550.7600.3080.7290.2380.7720.3160.7100.2760.7870.3560.7920.3690.7960.8090.404
Table 4. Sum-of-Pairs (SPs) and Total Column (TC) scores for the best alignments obtained for each GPCR class. The results for TMP-M2Align correspond to the best-scoring solutions selected from the generated Pareto fronts. TMP-M2Align consistently outperforms traditional aligners across all three classes.
Table 4. Sum-of-Pairs (SPs) and Total Column (TC) scores for the best alignments obtained for each GPCR class. The results for TMP-M2Align correspond to the best-scoring solutions selected from the generated Pareto fronts. TMP-M2Align consistently outperforms traditional aligners across all three classes.
GPCRClustalWKalignMAFFTMuscleTMP-M2Align
SP TC SP TC SP TC SP TC SP TC
Class A0.6530.0000.5780.0000.5760.0000.6260.0000.6630.020
Class B10.6120.5500.5890.4900.5860.5300.5820.5300.6110.560
Class C0.6520.1900.5190.0000.6770.3600.5060.0000.6920.360
Average0.6390.2470.5620.1630.6130.2970.5710.1770.6550.313
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

Cedeño-Muñoz, J.; Zambrano-Vega, C.; Nebro, A.J. TMP-M2Align: A Topology-Aware Multiobjective Approach to the Multiple Sequence Alignment of Transmembrane Proteins. Algorithms 2025, 18, 640. https://doi.org/10.3390/a18100640

AMA Style

Cedeño-Muñoz J, Zambrano-Vega C, Nebro AJ. TMP-M2Align: A Topology-Aware Multiobjective Approach to the Multiple Sequence Alignment of Transmembrane Proteins. Algorithms. 2025; 18(10):640. https://doi.org/10.3390/a18100640

Chicago/Turabian Style

Cedeño-Muñoz, Joel, Cristian Zambrano-Vega, and Antonio J. Nebro. 2025. "TMP-M2Align: A Topology-Aware Multiobjective Approach to the Multiple Sequence Alignment of Transmembrane Proteins" Algorithms 18, no. 10: 640. https://doi.org/10.3390/a18100640

APA Style

Cedeño-Muñoz, J., Zambrano-Vega, C., & Nebro, A. J. (2025). TMP-M2Align: A Topology-Aware Multiobjective Approach to the Multiple Sequence Alignment of Transmembrane Proteins. Algorithms, 18(10), 640. https://doi.org/10.3390/a18100640

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